diff --git a/dumux/assembly/pq1bubblelocalassembler.hh b/dumux/assembly/pq1bubblelocalassembler.hh index 6283f03f709d8a3fb113ddc32828ad287b37d6f0..ad945d3ccd7b3f73f86680e33a3383e013244da9 100644 --- a/dumux/assembly/pq1bubblelocalassembler.hh +++ b/dumux/assembly/pq1bubblelocalassembler.hh @@ -114,70 +114,49 @@ public: else if (!this->elementIsGhost()) { const auto residual = this->asImp_().assembleJacobianAndResidualImpl(jac, gridVariables, partialReassembler); // forward to the internal implementation - - if (this->element().partitionType() == Dune::InteriorEntity) - { - for (const auto& scv : scvs(this->fvGeometry())) - res[scv.dofIndex()] += residual[scv.localDofIndex()]; - } - else - { - int numVerticesLocal = this->element().subEntities(dim); - - for (int i = 0; i < numVerticesLocal; ++i) - { - auto vertex = this->element().template subEntity(i); - - if (vertex.partitionType() == Dune::InteriorEntity || - vertex.partitionType() == Dune::BorderEntity) - { - // do not change the non-ghost vertices - continue; - } - - // set main diagonal entries for the vertex - int vIdx = gridGeometry.dofMapper().index(vertex); - - typedef typename JacobianMatrix::block_type BlockType; - BlockType &J = jac[vIdx][vIdx]; - for (int j = 0; j < BlockType::rows; ++j) - J[j][j] = 1.0; - - // set residual for the vertex - res[vIdx] = 0; - } - } + for (const auto& scv : scvs(this->fvGeometry())) + res[scv.dofIndex()] += residual[scv.localDofIndex()]; // assemble the coupling blocks for coupled models (does nothing if not coupled) maybeAssembleCouplingBlocks(residual); } else { - //TODO this needs also be done for the interior (element) dofs - int numVerticesLocal = this->element().subEntities(dim); + assert(this->elementIsGhost()); + // handle vertex dofs + const auto numVerticesLocal = this->element().subEntities(dim); for (int i = 0; i < numVerticesLocal; ++i) { + // do not change the non-ghost vertices auto vertex = this->element().template subEntity(i); - - if (vertex.partitionType() == Dune::InteriorEntity || - vertex.partitionType() == Dune::BorderEntity) - { - // do not change the non-ghost vertices + if (vertex.partitionType() == Dune::InteriorEntity || vertex.partitionType() == Dune::BorderEntity) continue; - } // set main diagonal entries for the vertex - int vIdx = gridGeometry.dofMapper().index(vertex); + const auto dofIndex = gridGeometry.dofMapper().index(vertex); + // this might be a vector-valued dof typedef typename JacobianMatrix::block_type BlockType; - BlockType &J = jac[vIdx][vIdx]; + BlockType &J = jac[dofIndex][dofIndex]; for (int j = 0; j < BlockType::rows; ++j) J[j][j] = 1.0; - // set residual for the vertex - res[vIdx] = 0; + // set residual for the ghost vertex dof + res[dofIndex] = 0; } + + // handle element dof + const auto elemDofIndex = gridGeometry.dofMapper().index(this->element()); + + // this might be a vector-valued dof + typedef typename JacobianMatrix::block_type BlockType; + BlockType &J = jac[elemDofIndex][elemDofIndex]; + for (int j = 0; j < BlockType::rows; ++j) + J[j][j] = 1.0; + + // set residual for the ghost element dof + res[elemDofIndex] = 0; } auto applyDirichlet = [&] (const auto& scvI, diff --git a/dumux/discretization/facecentered/CMakeLists.txt b/dumux/discretization/facecentered/CMakeLists.txt index bc798bad22f550b2ac000ae101d7c21738c58369..d8b6c9f2a2f1a095f0ae331f8721502a96eb2fd1 100644 --- a/dumux/discretization/facecentered/CMakeLists.txt +++ b/dumux/discretization/facecentered/CMakeLists.txt @@ -1 +1,2 @@ +add_subdirectory(diamond) add_subdirectory(staggered) diff --git a/dumux/discretization/facecentered/diamond/CMakeLists.txt b/dumux/discretization/facecentered/diamond/CMakeLists.txt new file mode 100644 index 0000000000000000000000000000000000000000..b6ce8d82412d050320d7cc78fd4eeb70df2b5dc6 --- /dev/null +++ b/dumux/discretization/facecentered/diamond/CMakeLists.txt @@ -0,0 +1,3 @@ +file(GLOB DUMUX_DISCRETIZATION_FACECENTERED_DIAMOND_HEADERS *.hh *.inc) +install(FILES ${DUMUX_DISCRETIZATION_FACECENTERED_DIAMOND_HEADERS} + DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/discretization/facecentered/diamond) diff --git a/dumux/freeflow/navierstokes/mass/CMakeLists.txt b/dumux/freeflow/navierstokes/mass/CMakeLists.txt index b4a5a1ccb899eec31d30c4ffb8b3ca1c97afc151..d28d9dcf36849056d898346ee9af2e87f283d545 100644 --- a/dumux/freeflow/navierstokes/mass/CMakeLists.txt +++ b/dumux/freeflow/navierstokes/mass/CMakeLists.txt @@ -1 +1,5 @@ add_subdirectory(1p) + +file(GLOB DUMUX_FREEFLOW_NAVIERSTOKES_MASS_HEADERS *.hh *.inc) +install(FILES ${DUMUX_FREEFLOW_NAVIERSTOKES_MASS_HEADERS} + DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/freeflow/navierstokes/mass) diff --git a/dumux/freeflow/navierstokes/mass/problem.hh b/dumux/freeflow/navierstokes/mass/problem.hh index 3fc1910f45864eac6d27bba8fdafe0bbf7a08a81..175845ee8d9b59218b197d34fdf6d24bc39aa65d 100644 --- a/dumux/freeflow/navierstokes/mass/problem.hh +++ b/dumux/freeflow/navierstokes/mass/problem.hh @@ -106,6 +106,17 @@ public: return asImp_().velocityAtPos(scvf.ipGlobal()); } + /*! + * \brief Returns the velocity at the element center. + */ + VelocityVector elementVelocity(const FVElementGeometry& fvGeometry) const + { + if constexpr (isCoupled_) + return couplingManager_->elementVelocity(fvGeometry); + else + return asImp_().velocityAtPos(fvGeometry.element().geometry().center()); + } + /*! * \brief Returns the velocity at a given position. */ diff --git a/dumux/freeflow/navierstokes/momentum/CMakeLists.txt b/dumux/freeflow/navierstokes/momentum/CMakeLists.txt index dbe53b1e986ebeb435a7a71ba3e5c794cd0fbfbd..436c5d411a846d995b61372189e95906078f651a 100644 --- a/dumux/freeflow/navierstokes/momentum/CMakeLists.txt +++ b/dumux/freeflow/navierstokes/momentum/CMakeLists.txt @@ -1,3 +1,7 @@ +add_subdirectory(cvfe) +add_subdirectory(diamond) +add_subdirectory(pq1bubble) + file(GLOB DUMUX_FREEFLOW_NAVIERSTOKES_MOMENTUM_HEADERS *.hh *.inc) install(FILES ${DUMUX_FREEFLOW_NAVIERSTOKES_MOMENTUM_HEADERS} DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/freeflow/navierstokes/momentum) diff --git a/dumux/freeflow/navierstokes/momentum/cvfe/CMakeLists.txt b/dumux/freeflow/navierstokes/momentum/cvfe/CMakeLists.txt new file mode 100644 index 0000000000000000000000000000000000000000..e69de29bb2d1d6434b8b29ae775ad8c2e48c5391 diff --git a/dumux/freeflow/navierstokes/momentum/diamond/flux.hh b/dumux/freeflow/navierstokes/momentum/cvfe/flux.hh similarity index 95% rename from dumux/freeflow/navierstokes/momentum/diamond/flux.hh rename to dumux/freeflow/navierstokes/momentum/cvfe/flux.hh index 03c3421c9f8fb0e0cc7749d488fb1b46ddf6fe88..07d05ca2f1ae2c67ad298b7946ca4b26da428566 100644 --- a/dumux/freeflow/navierstokes/momentum/diamond/flux.hh +++ b/dumux/freeflow/navierstokes/momentum/cvfe/flux.hh @@ -21,8 +21,8 @@ * \ingroup NavierStokesModel * \copydoc Dumux::NavierStokesFluxVariablesImpl */ -#ifndef DUMUX_NAVIERSTOKES_MOMENTUM_DIAMOND_FLUXVARIABLES_HH -#define DUMUX_NAVIERSTOKES_MOMENTUM_DIAMOND_FLUXVARIABLES_HH +#ifndef DUMUX_NAVIERSTOKES_MOMENTUM_CVFE_FLUXVARIABLES_HH +#define DUMUX_NAVIERSTOKES_MOMENTUM_CVFE_FLUXVARIABLES_HH #include @@ -96,10 +96,10 @@ private: /*! * \ingroup NavierStokesModel - * \brief The flux variables class for the Navier-Stokes model using the diamond grid discretization + * \brief The flux variables class for the Navier-Stokes model using control-volume finite element schemes */ template -class NavierStokesMomentumFluxDiamond +class NavierStokesMomentumFluxCVFE { using GridView = typename GridGeometry::GridView; using Element = typename GridView::template Codim<0>::Entity; @@ -172,14 +172,14 @@ public: // get viscosity from the problem const auto mu = context.problem().effectiveViscosity(element, fvGeometry, scvf); - // TODO enable symmetric gradient static const bool enableUnsymmetrizedVelocityGradient = getParamFromGroup(context.problem().paramGroup(), "FreeFlow.EnableUnsymmetrizedVelocityGradient", false); - if (!enableUnsymmetrizedVelocityGradient) - DUNE_THROW(Dune::NotImplemented, "Symmetric velocity gradient"); // compute -mu*gradV*n*dA - NumEqVector diffusiveFlux = mv(gradV, scvf.unitOuterNormal()); + NumEqVector diffusiveFlux = enableUnsymmetrizedVelocityGradient ? + mv(gradV, scvf.unitOuterNormal()) + : mv(gradV + getTransposed(gradV),scvf.unitOuterNormal()); + diffusiveFlux *= -mu; static const bool enableDilatationTerm = getParamFromGroup(context.problem().paramGroup(), "FreeFlow.EnableDilatationTerm", false); diff --git a/dumux/freeflow/navierstokes/momentum/diamond/CMakeLists.txt b/dumux/freeflow/navierstokes/momentum/diamond/CMakeLists.txt new file mode 100644 index 0000000000000000000000000000000000000000..93a5c3f8f949636e06f920db9ce8dab41a87c67c --- /dev/null +++ b/dumux/freeflow/navierstokes/momentum/diamond/CMakeLists.txt @@ -0,0 +1,3 @@ +file(GLOB DUMUX_FREEFLOW_NAVIERSTOKES_MOMENTUM_DIAMOND_HEADERS *.hh *.inc) +install(FILES ${DUMUX_FREEFLOW_NAVIERSTOKES_MOMENTUM_DIAMOND_HEADERS} + DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/freeflow/navierstokes/momentum/diamond) diff --git a/dumux/freeflow/navierstokes/momentum/diamond/localresidual.hh b/dumux/freeflow/navierstokes/momentum/diamond/localresidual.hh index dd4f0632688a8d0de8ece07c5bfb8972d896abce..78c6014c5928c5e9058e2a790aa307ccaa77b46c 100644 --- a/dumux/freeflow/navierstokes/momentum/diamond/localresidual.hh +++ b/dumux/freeflow/navierstokes/momentum/diamond/localresidual.hh @@ -33,7 +33,7 @@ #include #include -#include "flux.hh" +#include namespace Dumux { @@ -77,7 +77,7 @@ class NavierStokesMomentumDiamondResidual static constexpr auto dim = GridView::dimension; using FluxContext = NavierStokesMomentumFluxContext; - using FluxHelper = NavierStokesMomentumFluxDiamond; + using FluxHelper = NavierStokesMomentumFluxCVFE; public: //! Use the parent type's constructor diff --git a/dumux/freeflow/navierstokes/momentum/pq1bubble/CMakeLists.txt b/dumux/freeflow/navierstokes/momentum/pq1bubble/CMakeLists.txt new file mode 100644 index 0000000000000000000000000000000000000000..38384cf46f77262af8552d02e485c363c1755d3e --- /dev/null +++ b/dumux/freeflow/navierstokes/momentum/pq1bubble/CMakeLists.txt @@ -0,0 +1,3 @@ +file(GLOB DUMUX_FREEFLOW_NAVIERSTOKES_MOMENTUM_PQ1BUBBLE_HEADERS *.hh *.inc) +install(FILES ${DUMUX_FREEFLOW_NAVIERSTOKES_MOMENTUM_PQ1BUBBLE_HEADERS} + DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/freeflow/navierstokes/momentum/pq1bubble) diff --git a/dumux/freeflow/navierstokes/momentum/pq1bubble/indices.hh b/dumux/freeflow/navierstokes/momentum/pq1bubble/indices.hh new file mode 100644 index 0000000000000000000000000000000000000000..ba2d9c4b5213aafdf432a0b1737a11f8b6bb6d3f --- /dev/null +++ b/dumux/freeflow/navierstokes/momentum/pq1bubble/indices.hh @@ -0,0 +1,42 @@ +// -*- 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 3 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 . * + *****************************************************************************/ +/*! + * \file + * \ingroup NavierStokesModel + * \copydoc Dumux::NavierStokesIndices + */ +#ifndef DUMUX_NAVIERSTOKES_MOMENTUM_PQ1BUBBLE_INDICES_HH +#define DUMUX_NAVIERSTOKES_MOMENTUM_PQ1BUBBLE_INDICES_HH + +#include + +namespace Dumux { + +/*! + * \ingroup NavierStokesModel + * \brief The common indices for the isothermal Navier-Stokes model. + * + * \tparam dimension The dimension of the problem + */ +template +using NavierStokesMomentumPQ1BubbleIndices = NavierStokesMomentumDiamondIndices; + +} // end namespace Dumux + +#endif diff --git a/dumux/freeflow/navierstokes/momentum/pq1bubble/localresidual.hh b/dumux/freeflow/navierstokes/momentum/pq1bubble/localresidual.hh new file mode 100644 index 0000000000000000000000000000000000000000..6191bc4c4f00683ea092eb4f8cebcd1621f9cb31 --- /dev/null +++ b/dumux/freeflow/navierstokes/momentum/pq1bubble/localresidual.hh @@ -0,0 +1,179 @@ +// -*- 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 3 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 . * + *****************************************************************************/ +/*! + * \file + * \ingroup NavierStokesModel + * \copydoc Dumux::NavierStokesResidualImpl + */ +#ifndef DUMUX_NAVIERSTOKES_MOMENTUM_PQ1BUBBLE_LOCAL_RESIDUAL_HH +#define DUMUX_NAVIERSTOKES_MOMENTUM_PQ1BUBBLE_LOCAL_RESIDUAL_HH + +#include + +#include +#include + +#include +#include +#include + +#include + +namespace Dumux { + +/*! + * \ingroup NavierStokesModel + * \brief Element-wise calculation of the Navier-Stokes residual for models using the pq1bubble discretization + */ +template +class NavierStokesMomentumPQ1BubbleLocalResidual +: public CVFELocalResidual +{ + using ParentType = CVFELocalResidual; + + using GridVariables = GetPropType; + + using GridVolumeVariables = typename GridVariables::GridVolumeVariables; + using ElementVolumeVariables = typename GridVolumeVariables::LocalView; + using VolumeVariables = typename GridVolumeVariables::VolumeVariables; + + using GridFluxVariablesCache = typename GridVariables::GridFluxVariablesCache; + using ElementFluxVariablesCache = typename GridFluxVariablesCache::LocalView; + + using Scalar = GetPropType; + using Implementation = GetPropType; + using Problem = GetPropType; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename FVElementGeometry::SubControlVolume; + using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; + using GridView = typename GridGeometry::GridView; + using Element = typename GridView::template Codim<0>::Entity; + using ElementBoundaryTypes = GetPropType; + using Indices = typename GetPropType::Indices; + using PrimaryVariables = GetPropType; + using NumEqVector = Dumux::NumEqVector; + + using Extrusion = Extrusion_t; + + using ModelTraits = GetPropType; + + static constexpr auto dim = GridView::dimension; + + using FluxContext = NavierStokesMomentumFluxContext; + using FluxHelper = NavierStokesMomentumFluxCVFE; + +public: + //! Use the parent type's constructor + using ParentType::ParentType; + + /*! + * \brief Calculate the source term of the equation + * + * \param problem The problem to solve + * \param fvGeometry The finite-volume geometry of the element + * \param scv The sub-control volume over which we integrate the storage term + * \param volVars The volume variables associated with the scv + * + */ + NumEqVector computeStorage(const Problem& problem, + const FVElementGeometry& fvGeometry, + const SubControlVolume& scv, + const VolumeVariables& volVars, + const bool isPreviousStorage) const + { + return problem.density(fvGeometry.element(), fvGeometry, scv, isPreviousStorage) * volVars.velocity(); + } + + /*! + * \brief Calculate the source term of the equation + * + * \param problem The problem to solve + * \param element The DUNE Codim<0> entity for which the residual + * ought to be calculated + * \param fvGeometry The finite-volume geometry of the element + * \param elemVolVars The volume variables associated with the element stencil + * \param scv The sub-control volume over which we integrate the source term + * + */ + NumEqVector computeSource(const Problem& problem, + const Element& element, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolume& scv) const + { + NumEqVector source = ParentType::computeSource(problem, element, fvGeometry, elemVolVars, scv); + + // add rho*g (note that gravity might be zero in case it's disabled in the problem) + source += problem.density(element, fvGeometry, scv) * problem.gravity(); + + // Axisymmetric problems in 2D feature an extra source terms arising from the transformation to cylindrical coordinates. + // See Ferziger/Peric: Computational methods for Fluid Dynamics (2020) + // https://doi.org/10.1007/978-3-319-99693-6 + // Chapter 9.9 and Eq. (9.81) and comment on finite volume methods + if constexpr (dim == 2 && isRotationalExtrusion) + { + // the radius with respect to the rotation axis + const auto r = scv.center()[Extrusion::radialAxis] - fvGeometry.gridGeometry().bBoxMin()[Extrusion::radialAxis]; + + // The velocity term is new with respect to Cartesian coordinates and handled below as a source term + // it only enters the balance of the momentum balance in radial direction + source[Extrusion::radialAxis] += -2.0*problem.effectiveViscosity(element, fvGeometry, scv) + * elemVolVars[scv].velocity(Extrusion::radialAxis) / (r*r); + + // Pressure term (needed because we incorporate pressure in terms of a surface integral). + // grad(p) becomes div(pI) + (p/r)*n_r in cylindrical coordinates. The second term + // is new with respect to Cartesian coordinates and handled below as a source term. + source[Extrusion::radialAxis] += problem.pressure(element, fvGeometry, scv)/r; + } + + return source; + } + + /*! + * \brief Evaluates the mass flux over a face of a sub control volume. + * + * \param problem The problem + * \param element The element + * \param fvGeometry The finite volume geometry context + * \param elemVolVars The volume variables for all flux stencil elements + * \param scvf The sub control volume face to compute the flux on + * \param elemFluxVarsCache The cache related to flux computation + */ + NumEqVector computeFlux(const Problem& problem, + const Element& element, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolumeFace& scvf, + const ElementFluxVariablesCache& elemFluxVarsCache) const + { + FluxContext context(problem, fvGeometry, elemVolVars, elemFluxVarsCache, scvf); + FluxHelper fluxHelper; + + NumEqVector flux(0.0); + flux += fluxHelper.advectiveMomentumFlux(context); + flux += fluxHelper.diffusiveMomentumFlux(context); + flux += fluxHelper.pressureContribution(context); + return flux; + } +}; + +} // end namespace Dumux + +#endif diff --git a/dumux/freeflow/navierstokes/momentum/pq1bubble/model.hh b/dumux/freeflow/navierstokes/momentum/pq1bubble/model.hh new file mode 100644 index 0000000000000000000000000000000000000000..056fc8d3c05ea5140805c0cad6d1bce1b76334a0 --- /dev/null +++ b/dumux/freeflow/navierstokes/momentum/pq1bubble/model.hh @@ -0,0 +1,208 @@ +// -*- 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 3 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 . * + *****************************************************************************/ +/*! + * \file + * \ingroup NavierStokesModel + * + * \brief A single-phase, isothermal Navier-Stokes model + * + * This model implements a single-phase, isothermal Navier-Stokes model, solving the momentum balance equation + * \f[ + \frac{\partial (\varrho \textbf{v})}{\partial t} + \nabla \cdot (\varrho \textbf{v} \textbf{v}^{\text{T}}) = \nabla \cdot (\mu (\nabla \textbf{v} + \nabla \textbf{v}^{\text{T}})) + - \nabla p + \varrho \textbf{g} - \textbf{f} + * \f] + * By setting the runtime parameter Problem.EnableInertiaTerms to false the Stokes + * equation can be solved. In this case the term + * \f[ + * \nabla \cdot (\varrho \textbf{v} \textbf{v}^{\text{T}}) + * \f] + * is neglected. + * + * The mass balance equation + * \f[ + \frac{\partial \varrho}{\partial t} + \nabla \cdot (\varrho \textbf{v}) - q = 0 + * \f] + * + * closes the system. + */ + +#ifndef DUMUX_NAVIERSTOKES_MOMENTUM_PQ1BUBBLE_MODEL_HH +#define DUMUX_NAVIERSTOKES_MOMENTUM_PQ1BUBBLE_MODEL_HH + +#include +#include +#include +#include +#include + +#include +#include +#include +#include + +#include "localresidual.hh" +#include "volumevariables.hh" +#include "indices.hh" + +namespace Dumux { + +/*! + * \ingroup NavierStokesModel + * \brief Traits for the Navier-Stokes model + * + * \tparam dimension The dimension of the problem + */ +template +struct NavierStokesMomentumPQ1BubbleModelTraits +{ + //! The dimension of the model + static constexpr int dim() { return dimension; } + + //! There are as many momentum balance equations as dimensions + //! and one mass balance equation. + static constexpr int numEq() { return dim(); } + + //! The number of phases is 1 + static constexpr int numFluidPhases() { return 1; } + + //! The number of components is 1 + static constexpr int numFluidComponents() { return 1; } + + //! Enable advection + static constexpr bool enableAdvection() { return true; } + + //! The one-phase model has no molecular diffusion + static constexpr bool enableMolecularDiffusion() { return false; } + + //! The model is isothermal + static constexpr bool enableEnergyBalance() { return false; } + + //! The model does not include a turbulence model + static constexpr bool usesTurbulenceModel() { return false; } + + //! return the type of turbulence model used + static constexpr auto turbulenceModel() + { return TurbulenceModel::none; } + + //! the indices + using Indices = NavierStokesMomentumPQ1BubbleIndices; +}; + +/*! + * \ingroup NavierStokesModel + * \brief Traits class for the volume variables of the Navier-Stokes model. + * + * \tparam PV The type used for primary variables + * \tparam FSY The fluid system type + * \tparam FST The fluid state type + * \tparam MT The model traits + */ +template +struct NavierStokesMomentumPQ1BubbleVolumeVariablesTraits +{ + using PrimaryVariables = PV; + using FluidSystem = FSY; + using FluidState = FST; + using ModelTraits = MT; +}; + +} // end namespace Dumux + +// \{ +/////////////////////////////////////////////////////////////////////////// +// properties for the single-phase Navier-Stokes model +/////////////////////////////////////////////////////////////////////////// +namespace Dumux::Properties { + +////////////////////////////////////////////////////////////////// +// Type tags +////////////////////////////////////////////////////////////////// + +// Create new type tags +namespace TTag { +//! The type tag for the single-phase, isothermal Navier-Stokes model +struct NavierStokesMomentumPQ1Bubble { using InheritsFrom = std::tuple; }; +} // end namespace TTag + +/////////////////////////////////////////////////////////////////////////// +// default property values for the isothermal single phase model +/////////////////////////////////////////////////////////////////////////// +//!< states some specifics of the Navier-Stokes model +template +struct ModelTraits +{ +private: + using GridView = typename GetPropType::GridView; + static constexpr auto dim = GridView::dimension; +public: + using type = NavierStokesMomentumPQ1BubbleModelTraits; +}; + +/*! + * \brief The fluid state which is used by the volume variables to + * store the thermodynamic state. This should be chosen + * appropriately for the model ((non-)isothermal, equilibrium, ...). + * This can be done in the problem. + */ +template +struct FluidState{ +private: + using Scalar = GetPropType; + using FluidSystem = GetPropType; +public: + using type = ImmiscibleFluidState; +}; + +//! The local residual +template +struct LocalResidual +{ using type = NavierStokesMomentumPQ1BubbleLocalResidual; }; + +//! Set the volume variables property +template +struct VolumeVariables +{ +private: + using PV = GetPropType; + using FSY = GetPropType; + using FST = GetPropType; + using MT = GetPropType; + + static_assert(FSY::numPhases == MT::numFluidPhases(), "Number of phases mismatch between model and fluid system"); + static_assert(FST::numPhases == MT::numFluidPhases(), "Number of phases mismatch between model and fluid state"); + static_assert(!FSY::isMiscible(), "The Navier-Stokes model only works with immiscible fluid systems."); + + using Traits = NavierStokesMomentumPQ1BubbleVolumeVariablesTraits; +public: + using type = NavierStokesMomentumPQ1BubbleVolumeVariables; +}; + +// This is the default (model not coupled with a mass (pressure) discretization) +// i.e. the pressure is supplied via the problem as an analytical solution +// or from a separate computation +template +struct CouplingManager +{ + struct EmptyCouplingManager {}; + using type = EmptyCouplingManager; +}; + +} // end namespace Dumux::Properties + +#endif diff --git a/dumux/freeflow/navierstokes/momentum/pq1bubble/volumevariables.hh b/dumux/freeflow/navierstokes/momentum/pq1bubble/volumevariables.hh new file mode 100644 index 0000000000000000000000000000000000000000..879913c9f408b1db0e980db709e1abc2635144c2 --- /dev/null +++ b/dumux/freeflow/navierstokes/momentum/pq1bubble/volumevariables.hh @@ -0,0 +1,41 @@ +// -*- 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 3 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 . * + *****************************************************************************/ +/*! + * \file + * \ingroup NavierStokesModel + * + * \copydoc Dumux::NavierStokesVolumeVariables + */ +#ifndef DUMUX_NAVIERSTOKES_MOMENTUM_PQ1BUBBLE_VOLUME_VARIABLES_HH +#define DUMUX_NAVIERSTOKES_MOMENTUM_PQ1BUBBLE_VOLUME_VARIABLES_HH + +#include + +namespace Dumux { + +/*! + * \ingroup NavierStokesModel + * \brief Volume variables for the single-phase Navier-Stokes model. + */ +template +using NavierStokesMomentumPQ1BubbleVolumeVariables = NavierStokesMomentumDiamondVolumeVariables; + +} // end namespace Dumux + +#endif diff --git a/dumux/freeflow/navierstokes/momentum/problem.hh b/dumux/freeflow/navierstokes/momentum/problem.hh index 664d67f7bd0cc2eecbadda4591c6eccc019ac0d1..ae6da7dac95bfb2b9466984ae02081a8e42d97c1 100644 --- a/dumux/freeflow/navierstokes/momentum/problem.hh +++ b/dumux/freeflow/navierstokes/momentum/problem.hh @@ -538,8 +538,8 @@ private: /*! * \brief Navier-Stokes default problem implementation for FCDiamond discretizations */ -template -class NavierStokesMomentumProblemImpl +template +class NavierStokesMomentumProblemImpl> : public FVProblemWithSpatialParams { using ParentType = FVProblemWithSpatialParams; @@ -568,6 +568,10 @@ class NavierStokesMomentumProblemImpl using CouplingManager = GetPropType; using ModelTraits = GetPropType; + static constexpr bool isVertexCentered + = GridGeometry::discMethod == DiscretizationMethods::box + || GridGeometry::discMethod == DiscretizationMethods::pq1bubble; + public: //! These types are used in place of the typical NumEqVector type. //! In the numeqvector assembly type, only one equation per DOF (face) is considered @@ -660,6 +664,24 @@ public: return Sources(0.0); } + /*! + * \brief Specifies which kind of boundary condition should be + * used for which equation on a given boundary segment. + * + * \param element The finite element + * \param scv The sub control volume + */ + BoundaryTypes boundaryTypes(const Element& element, + const SubControlVolume& scv) const + { + if (!isVertexCentered) + DUNE_THROW(Dune::InvalidStateException, + "boundaryTypes(..., scv) called for for a non vertex-centered method."); + + // forward it to the method which only takes the global coordinate + return asImp_().boundaryTypesAtPos(scv.dofPosition()); + } + /*! * \brief Specifies which kind of boundary condition should be * used for which equation on a given boundary segment. @@ -667,26 +689,47 @@ public: * \param element The finite element * \param scvf The sub control volume face */ - BoundaryTypes boundaryTypes(const Element &element, - const SubControlVolumeFace &scvf) const + BoundaryTypes boundaryTypes(const Element& element, + const SubControlVolumeFace& scvf) const { - // Forward it to the method which only takes the global coordinate. - // We evaluate the boundary type at the center of the sub control volume face - // in order to avoid ambiguities at domain corners. - return asImp_().boundaryTypesAtPos(scvf.center()); + if (isVertexCentered) + DUNE_THROW(Dune::InvalidStateException, + "boundaryTypes(..., scvf) called for a vertex-centered method."); + + // forward it to the method which only takes the global coordinate + return asImp_().boundaryTypesAtPos(scvf.ipGlobal()); } /*! - * \brief Evaluate the boundary conditions for a dirichlet + * \brief Evaluate the boundary conditions for a Dirichlet + * control volume. + * + * \param element The finite element + * \param scv the sub control volume + */ + DirichletValues dirichlet(const Element& element, const SubControlVolume& scv) const + { + // forward it to the method which only takes the global coordinate + if (!isVertexCentered) + DUNE_THROW(Dune::InvalidStateException, "dirichlet(scv) called for a non vertex-centered method."); + else + return asImp_().dirichletAtPos(scv.dofPosition()); + } + + /*! + * \brief Evaluate the boundary conditions for a Dirichlet * control volume face. * * \param element The finite element * \param scvf the sub control volume face - * \note used for cell-centered discretization schemes */ - DirichletValues dirichlet(const Element &element, const SubControlVolumeFace &scvf) const + DirichletValues dirichlet(const Element& element, const SubControlVolumeFace& scvf) const { - return asImp_().dirichletAtPos(scvf.ipGlobal()); + // forward it to the method which only takes the global coordinate + if (isVertexCentered) + DUNE_THROW(Dune::InvalidStateException, "dirichlet(scvf) called for vertex-centered method."); + else + return asImp_().dirichletAtPos(scvf.ipGlobal()); } /*! @@ -831,7 +874,7 @@ public: template void applyInitialSolution(SolutionVector& sol) const { - static_assert(GridGeometry::discMethod == DiscretizationMethods::fcdiamond); + static_assert(GridGeometry::discMethod == DiscretizationMethods::CVFE{}); sol.resize(this->gridGeometry().numDofs()); std::vector dofHandled(this->gridGeometry().numDofs(), false); auto fvGeometry = localView(this->gridGeometry()); @@ -855,7 +898,7 @@ public: */ InitialValues initial(const SubControlVolume& scv) const { - static_assert(GridGeometry::discMethod == DiscretizationMethods::fcdiamond); + static_assert(GridGeometry::discMethod == DiscretizationMethods::CVFE{}); return asImp_().initialAtPos(scv.dofPosition()); } diff --git a/dumux/freeflow/navierstokes/velocityoutput.hh b/dumux/freeflow/navierstokes/velocityoutput.hh index d00b4dce2802c847f343506459712c02ff67afce..4be42dd84e8584bdad6439c6dc89b28e080d79c2 100644 --- a/dumux/freeflow/navierstokes/velocityoutput.hh +++ b/dumux/freeflow/navierstokes/velocityoutput.hh @@ -83,8 +83,12 @@ public: using MomGG = std::decay_t().problem(CouplingManager::freeFlowMomentumIndex).gridGeometry())>; if constexpr (MomGG::discMethod == DiscretizationMethods::fcstaggered) calculateVelocityForStaggeredGrid_(velocity, element, fvGeometry, elemVolVars); - else if constexpr (MomGG::discMethod == DiscretizationMethods::fcdiamond) - calculateVelocityForDiamondSchemes_(velocity, element, fvGeometry, elemVolVars); + else if constexpr ( + MomGG::discMethod == DiscretizationMethods::fcdiamond + || MomGG::discMethod == DiscretizationMethods::pq1bubble + || MomGG::discMethod == DiscretizationMethods::box + ) + calculateVelocityForCVFESchemes_(velocity, element, fvGeometry, elemVolVars); } private: @@ -102,21 +106,16 @@ private: velocity[eIdx] = StaggeredVelocityReconstruction::cellCenterVelocity(getFaceVelocity, fvGeometry); } - void calculateVelocityForDiamondSchemes_(VelocityVector& velocity, - const Element& element, - const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars) const + void calculateVelocityForCVFESchemes_(VelocityVector& velocity, + const Element& element, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars) const { const auto eIdx = fvGeometry.gridGeometry().elementMapper().index(element); - const auto getFaceVelocity = [&](const FVElementGeometry& fvG, const auto& scvf) - { - return elemVolVars.gridVolVars().problem().faceVelocity(element, fvGeometry, scvf); - }; - - for (const auto& scvf : scvfs(fvGeometry)) - velocity[eIdx] += getFaceVelocity(fvGeometry, scvf) / fvGeometry.numScvf(); + velocity[eIdx] = elemVolVars.gridVolVars().problem().elementVelocity(fvGeometry); } + bool enableOutput_; }; diff --git a/dumux/linear/linearsolvertraits.hh b/dumux/linear/linearsolvertraits.hh index 4f94517cf33c01ee25cb38c6f8d5a8ed53858c5d..34f342368a6234b8b5902765058371aaf802676f 100644 --- a/dumux/linear/linearsolvertraits.hh +++ b/dumux/linear/linearsolvertraits.hh @@ -24,6 +24,8 @@ #ifndef DUMUX_LINEAR_SOLVER_TRAITS_HH #define DUMUX_LINEAR_SOLVER_TRAITS_HH +#include + #include #include #include @@ -124,6 +126,20 @@ struct LinearSolverTraitsImpl { return gridView.overlapSize(0) == 0; } }; +template +struct LinearSolverTraitsImpl +: public LinearSolverTraitsImpl +{ + using Grid = typename GridGeometry::GridView::Traits::Grid; + using DofMapper = typename GridGeometry::DofMapper; + + static constexpr int dofCodim = Grid::dimension; + static constexpr std::bitset dofCodims{ (1UL << Grid::dimension) + 1UL }; + + static const DofMapper& dofMapper(const GridGeometry& gg) + { return { gg.dofMapper() }; } +}; + //! Cell-centered tpfa: use overlapping model template struct LinearSolverTraitsImpl diff --git a/dumux/multidomain/couplingjacobianpattern.hh b/dumux/multidomain/couplingjacobianpattern.hh index 6a8ef21d13aa4726981d563acb62f47d5d748c37..135b46119c877e9dfaf35938cd7a221bf9ba8199 100644 --- a/dumux/multidomain/couplingjacobianpattern.hh +++ b/dumux/multidomain/couplingjacobianpattern.hh @@ -252,6 +252,46 @@ Dune::MatrixIndexSet getCouplingJacobianPattern(const CouplingManager& couplingM return pattern; } +/*! + * \ingroup MultiDomain + * \brief Helper function to generate coupling Jacobian pattern (off-diagonal blocks) + * for the pq1bubble scheme + */ +template = 0> +Dune::MatrixIndexSet getCouplingJacobianPattern(const CouplingManager& couplingManager, + Dune::index_constant domainI, + const GridGeometryI& gridGeometryI, + Dune::index_constant domainJ, + const GridGeometryJ& gridGeometryJ) +{ + Dune::MatrixIndexSet pattern; + + // matrix pattern for implicit Jacobians + if (isImplicit) + { + pattern.resize(gridGeometryI.numDofs(), gridGeometryJ.numDofs()); + auto fvGeometry = localView(gridGeometryI); + for (const auto& elementI : elements(gridGeometryI.gridView())) + { + fvGeometry.bindElement(elementI); + const auto& stencil = couplingManager.couplingStencil(domainI, elementI, domainJ); + for (const auto& scv : scvs(fvGeometry)) + { + for (const auto globalJ : stencil) + pattern.add(scv.dofIndex(), globalJ); + + } + } + } + + // matrix pattern for explicit Jacobians + // -> diagonal matrix, so coupling block is empty + // just return the empty pattern + + return pattern; +} + } // end namespace Dumux #endif diff --git a/dumux/multidomain/freeflow/couplingmanager.hh b/dumux/multidomain/freeflow/couplingmanager.hh index 7e10a96793bdd401c0c647fec078e3004e7647b4..7110e8322074b36e36da6776e97ca4822bb9ad40 100644 --- a/dumux/multidomain/freeflow/couplingmanager.hh +++ b/dumux/multidomain/freeflow/couplingmanager.hh @@ -28,6 +28,7 @@ #include "couplingmanager_staggered.hh" #include "couplingmanager_diamond.hh" +#include "couplingmanager_pq1bubble.hh" #ifndef DOXYGEN namespace Dumux::Detail { @@ -48,6 +49,10 @@ template struct FreeFlowCouplingManagerSelector { using type = FCDiamondFreeFlowCouplingManager; }; +template +struct FreeFlowCouplingManagerSelector +{ using type = PQ1BubbleFreeFlowCouplingManager; }; + } // end namespace Dumux::Detail #endif diff --git a/dumux/multidomain/freeflow/couplingmanager_diamond.hh b/dumux/multidomain/freeflow/couplingmanager_diamond.hh index b3c9351af7813ce713fae4996222100e276dc421..673ab4a92099c5c9d9aa92a9a9495c5bd9814a23 100644 --- a/dumux/multidomain/freeflow/couplingmanager_diamond.hh +++ b/dumux/multidomain/freeflow/couplingmanager_diamond.hh @@ -32,6 +32,7 @@ #include #include #include +#include #include #include @@ -342,6 +343,27 @@ public: return velocity; } + /*! + * \brief Returns the velocity at the element center. + */ + VelocityVector elementVelocity(const FVElementGeometry& fvGeometry) const + { + bindCouplingContext_(Dune::index_constant(), fvGeometry.element()); + + const auto& momentumFvGeometry = this->massAndEnergyCouplingContext_()[0].fvGeometry; + const auto& localBasis = momentumFvGeometry.feLocalBasis(); + + // interpolate velocity at scvf + VelocityVector velocity(0.0); + std::vector shapeValues; + localBasis.evaluateFunction(referenceElement(fvGeometry.element()).position(0,0), shapeValues); + + for (const auto& scv : scvs(momentumFvGeometry)) + velocity.axpy(shapeValues[scv.localDofIndex()][0], this->curSol(freeFlowMomentumIndex)[scv.dofIndex()]); + + return velocity; + } + /*! * \brief The coupling stencil of domain I, i.e. which domain J DOFs * the given domain I element's residual depends on. diff --git a/dumux/multidomain/freeflow/couplingmanager_pq1bubble.hh b/dumux/multidomain/freeflow/couplingmanager_pq1bubble.hh new file mode 100644 index 0000000000000000000000000000000000000000..0591734a81545c25ad6efe0d849333a498caf48e --- /dev/null +++ b/dumux/multidomain/freeflow/couplingmanager_pq1bubble.hh @@ -0,0 +1,704 @@ +// -*- 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 3 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 . * + *****************************************************************************/ +/*! + * \file + * \ingroup MultiDomain + * \brief Freeflow coupling managers (Navier-Stokes mass-momentum coupling) + */ +#ifndef DUMUX_MULTIDOMAIN_FREEFLOW_COUPLING_MANAGER_PQ1BUBBLE_HH +#define DUMUX_MULTIDOMAIN_FREEFLOW_COUPLING_MANAGER_PQ1BUBBLE_HH + +#include +#include +#include +#include + +#include +#include +#include +#include + +#include +#include + +#include +#include +#include + +#include + +#include +#include + +namespace Dumux { + +/*! + * \ingroup MultiDomain + * \brief The interface of the coupling manager for free flow systems + * \note coupling manager for the control-volume finite-element discretization scheme + */ +template +class PQ1BubbleFreeFlowCouplingManager +: public CouplingManager +{ + using ParentType = CouplingManager; +public: + static constexpr auto freeFlowMomentumIndex = typename Traits::template SubDomain<0>::Index(); + static constexpr auto freeFlowMassIndex = typename Traits::template SubDomain<1>::Index(); + + // this can be used if the coupling manager is used inside a meta-coupling manager (e.g. multi-binary) + // to manager the solution vector storage outside this class + using SolutionVectorStorage = typename ParentType::SolutionVectorStorage; +private: + template using SubDomainTypeTag = typename Traits::template SubDomain::TypeTag; + template using PrimaryVariables = GetPropType, Properties::PrimaryVariables>; + template using GridGeometry = GetPropType, Properties::GridGeometry>; + template using GridView = typename GridGeometry::GridView; + template using Element = typename GridView::template Codim<0>::Entity; + template using ElementSeed = typename GridView::Grid::template Codim<0>::EntitySeed; + template using FVElementGeometry = typename GridGeometry::LocalView; + template using SubControlVolume = typename FVElementGeometry::SubControlVolume; + template using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; + template using GridVariables = typename Traits::template SubDomain::GridVariables; + template using ElementVolumeVariables = typename GridVariables::GridVolumeVariables::LocalView; + template using GridFluxVariablesCache = typename GridVariables::GridFluxVariablesCache; + template using Problem = GetPropType, Properties::Problem>; + template using VolumeVariables = GetPropType, Properties::VolumeVariables>; + + using Scalar = typename Traits::Scalar; + using SolutionVector = typename Traits::SolutionVector; + + using CouplingStencilType = std::vector; + + using GridVariablesTuple = typename Traits::template TupleOfSharedPtr; + + using FluidSystem = typename VolumeVariables::FluidSystem; + + using VelocityVector = typename SubControlVolumeFace::GlobalPosition; + using ShapeValue = typename Dune::FieldVector; + + static_assert(std::is_same_v::GlobalPosition>); + + struct MomentumCouplingContext + { + FVElementGeometry fvGeometry; + ElementVolumeVariables curElemVolVars; + ElementVolumeVariables prevElemVolVars; + std::size_t eIdx; + }; + + struct MassAndEnergyCouplingContext + { + MassAndEnergyCouplingContext(FVElementGeometry&& f, const std::size_t i) + : fvGeometry(std::move(f)) + , eIdx(i) + {} + + FVElementGeometry fvGeometry; + std::size_t eIdx; + }; + + using MomentumDiscretizationMethod = typename GridGeometry::DiscretizationMethod; + using MassDiscretizationMethod = typename GridGeometry::DiscretizationMethod; + +public: + + static constexpr auto pressureIdx = VolumeVariables::Indices::pressureIdx; + + /*! + * \brief Methods to be accessed by main + */ + // \{ + + //! use as regular coupling manager + void init(std::shared_ptr> momentumProblem, + std::shared_ptr> massProblem, + GridVariablesTuple&& gridVariables, + const SolutionVector& curSol) + { + this->setSubProblems(std::make_tuple(momentumProblem, massProblem)); + gridVariables_ = gridVariables; + this->updateSolution(curSol); + + computeCouplingStencils_(); + } + + //! use as regular coupling manager in a transient setting + void init(std::shared_ptr> momentumProblem, + std::shared_ptr> massProblem, + GridVariablesTuple&& gridVariables, + const SolutionVector& curSol, + const SolutionVector& prevSol) + { + init(momentumProblem, massProblem, std::forward(gridVariables), curSol); + prevSol_ = &prevSol; + isTransient_ = true; + } + + //! use as binary coupling manager in multi model context + void init(std::shared_ptr> momentumProblem, + std::shared_ptr> massProblem, + GridVariablesTuple&& gridVariables, + typename ParentType::SolutionVectorStorage& curSol) + { + this->setSubProblems(std::make_tuple(momentumProblem, massProblem)); + gridVariables_ = gridVariables; + this->attachSolution(curSol); + + computeCouplingStencils_(); + } + + // \} + + /*! + * \name member functions concerning the coupling stencils + */ + // \{ + + /*! + * \brief Returns the pressure at a given sub control volume face + */ + Scalar pressure(const Element& element, + const FVElementGeometry& fvGeometry, + const SubControlVolumeFace& scvf) const + { + const auto& gg = this->problem(freeFlowMassIndex).gridGeometry(); + const auto elemSol = elementSolution(element, this->curSol(freeFlowMassIndex), gg); + return evalSolution(element, element.geometry(), gg, elemSol, scvf.ipGlobal())[pressureIdx]; + } + + /*! + * \brief Returns the density at a given sub control volume face. + */ + Scalar density(const Element& element, + const FVElementGeometry& fvGeometry, + const SubControlVolumeFace& scvf, + const bool considerPreviousTimeStep = false) const + { + assert(!(considerPreviousTimeStep && !this->isTransient_)); + bindCouplingContext_(Dune::index_constant(), element, fvGeometry.elementIndex()); + + if constexpr (MassDiscretizationMethod{} == DiscretizationMethods::cctpfa) + { + const auto eIdx = fvGeometry.elementIndex(); + const auto& scv = this->momentumCouplingContext_()[0].fvGeometry.scv(eIdx); + + const auto& volVars = considerPreviousTimeStep ? + this->momentumCouplingContext_()[0].prevElemVolVars[scv] + : this->momentumCouplingContext_()[0].curElemVolVars[scv]; + + return volVars.density(); + } + else if constexpr (MassDiscretizationMethod{} == DiscretizationMethods::box + || MassDiscretizationMethod{} == DiscretizationMethods::fcdiamond) + { + // TODO: cache the shape values when Box method is used + using ShapeValue = typename Dune::FieldVector; + const auto& localBasis = this->momentumCouplingContext_()[0].fvGeometry.feLocalBasis(); + std::vector shapeValues; + const auto ipLocal = element.geometry().local(scvf.ipGlobal()); + localBasis.evaluateFunction(ipLocal, shapeValues); + + Scalar rho = 0.0; + for (const auto& scv : scvs(this->momentumCouplingContext_()[0].fvGeometry)) + { + const auto& volVars = considerPreviousTimeStep ? + this->momentumCouplingContext_()[0].prevElemVolVars[scv] + : this->momentumCouplingContext_()[0].curElemVolVars[scv]; + rho += volVars.density()*shapeValues[scv.indexInElement()][0]; + } + + return rho; + } + else + DUNE_THROW(Dune::NotImplemented, + "Density interpolation for discretization scheme " << MassDiscretizationMethod{} + ); + } + + /*! + * \brief Returns the density at a given sub control volume. + */ + Scalar density(const Element& element, + const FVElementGeometry& fvGeometry, + const SubControlVolume& scv, + const bool considerPreviousTimeStep = false) const + { + assert(!(considerPreviousTimeStep && !this->isTransient_)); + bindCouplingContext_(Dune::index_constant(), element, scv.elementIndex()); + + if constexpr (MassDiscretizationMethod{} == DiscretizationMethods::cctpfa) + { + const auto eIdx = scv.elementIndex(); + const auto& scv = this->momentumCouplingContext_()[0].fvGeometry.scv(eIdx); + + const auto& volVars = considerPreviousTimeStep ? + this->momentumCouplingContext_()[0].prevElemVolVars[scv] + : this->momentumCouplingContext_()[0].curElemVolVars[scv]; + + return volVars.density(); + } + else if constexpr (MassDiscretizationMethod{} == DiscretizationMethods::box + || MassDiscretizationMethod{} == DiscretizationMethods::fcdiamond) + { + // TODO: cache the shape values when Box method is used + using ShapeValue = typename Dune::FieldVector; + const auto& localBasis = this->momentumCouplingContext_()[0].fvGeometry.feLocalBasis(); + std::vector shapeValues; + const auto ipLocal = element.geometry().local(scv.dofPosition()); + localBasis.evaluateFunction(ipLocal, shapeValues); + + Scalar rho = 0.0; + for (const auto& scvI : scvs(this->momentumCouplingContext_()[0].fvGeometry)) + { + const auto& volVars = considerPreviousTimeStep ? + this->momentumCouplingContext_()[0].prevElemVolVars[scvI] + : this->momentumCouplingContext_()[0].curElemVolVars[scvI]; + rho += volVars.density()*shapeValues[scvI.indexInElement()][0]; + } + return rho; + } + else + DUNE_THROW(Dune::NotImplemented, + "Density interpolation for discretization scheme " << MassDiscretizationMethod{} + ); + } + + /*! + * \brief Returns the pressure at a given sub control volume face. + */ + Scalar effectiveViscosity(const Element& element, + const FVElementGeometry& fvGeometry, + const SubControlVolumeFace& scvf) const + { + bindCouplingContext_(Dune::index_constant(), element, fvGeometry.elementIndex()); + + if constexpr (MassDiscretizationMethod{} == DiscretizationMethods::cctpfa) + { + const auto eIdx = fvGeometry.elementIndex(); + const auto& scv = this->momentumCouplingContext_()[0].fvGeometry.scv(eIdx); + const auto& volVars = this->momentumCouplingContext_()[0].curElemVolVars[scv]; + return volVars.viscosity(); + } + else if constexpr (MassDiscretizationMethod{} == DiscretizationMethods::box + || MassDiscretizationMethod{} == DiscretizationMethods::fcdiamond) + { + // TODO: cache the shape values when Box method is used + using ShapeValue = typename Dune::FieldVector; + const auto& localBasis = this->momentumCouplingContext_()[0].fvGeometry.feLocalBasis(); + std::vector shapeValues; + const auto ipLocal = element.geometry().local(scvf.ipGlobal()); + localBasis.evaluateFunction(ipLocal, shapeValues); + + Scalar mu = 0.0; + for (const auto& scv : scvs(this->momentumCouplingContext_()[0].fvGeometry)) + { + const auto& volVars = this->momentumCouplingContext_()[0].curElemVolVars[scv]; + mu += volVars.viscosity()*shapeValues[scv.indexInElement()][0]; + } + + return mu; + } + else + DUNE_THROW(Dune::NotImplemented, + "Viscosity interpolation for discretization scheme " << MassDiscretizationMethod{} + ); + + } + + /*! + * \brief Returns the velocity at a given sub control volume face. + */ + VelocityVector faceVelocity(const Element& element, + const SubControlVolumeFace& scvf) const + { + // TODO: optimize this function for tpfa where the scvf ip coincides with the dof location + + bindCouplingContext_(Dune::index_constant(), element); + + const auto& fvGeometry = this->massAndEnergyCouplingContext_()[0].fvGeometry; + const auto& localBasis = fvGeometry.feLocalBasis(); + + // interpolate velocity at scvf + VelocityVector velocity(0.0); + std::vector shapeValues; + const auto ipLocal = element.geometry().local(scvf.ipGlobal()); + localBasis.evaluateFunction(ipLocal, shapeValues); + + for (const auto& scv : scvs(fvGeometry)) + velocity.axpy(shapeValues[scv.localDofIndex()][0], this->curSol(freeFlowMomentumIndex)[scv.dofIndex()]); + + return velocity; + } + + /*! + * \brief Returns the velocity at the element center. + */ + VelocityVector elementVelocity(const FVElementGeometry& fvGeometry) const + { + bindCouplingContext_(Dune::index_constant(), fvGeometry.element()); + + const auto& momentumFvGeometry = this->massAndEnergyCouplingContext_()[0].fvGeometry; + const auto& localBasis = momentumFvGeometry.feLocalBasis(); + + // interpolate velocity at scvf + VelocityVector velocity(0.0); + std::vector shapeValues; + localBasis.evaluateFunction(referenceElement(fvGeometry.element()).position(0,0), shapeValues); + + for (const auto& scv : scvs(momentumFvGeometry)) + velocity.axpy(shapeValues[scv.localDofIndex()][0], this->curSol(freeFlowMomentumIndex)[scv.dofIndex()]); + + return velocity; + } + + /*! + * \brief The coupling stencil of domain I, i.e. which domain J DOFs + * the given domain I element's residual depends on. + */ + template + const CouplingStencilType& couplingStencil(Dune::index_constant domainI, + const Element& elementI, + const SubControlVolume& scvI, + Dune::index_constant domainJ) const + { return emptyStencil_; } + + /*! + * \brief returns an iterable container of all indices of degrees of freedom of domain j + * that couple with / influence the element residual of the given element of domain i + * + * \param domainI the domain index of domain i + * \param elementI the coupled element of domain í + * \param domainJ the domain index of domain j + * + * \note The element residual definition depends on the discretization scheme of domain i + * box: a container of the residuals of all sub control volumes + * cc : the residual of the (sub) control volume + * fem: the residual of the element + * \note This function has to be implemented by all coupling managers for all combinations of i and j + */ + const CouplingStencilType& couplingStencil(Dune::index_constant domainI, + const Element& elementI, + Dune::index_constant domainJ) const + { + const auto eIdx = this->problem(freeFlowMassIndex).gridGeometry().elementMapper().index(elementI); + return massAndEnergyToMomentumStencils_[eIdx]; + } + + /*! + * \brief returns an iterable container of all indices of degrees of freedom of domain j + * that couple with / influence the element residual of the given element of domain i + * + * \param domainI the domain index of domain i + * \param elementI the coupled element of domain í + * \param domainJ the domain index of domain j + */ + const CouplingStencilType& couplingStencil(Dune::index_constant domainI, + const Element& elementI, + Dune::index_constant domainJ) const + { + const auto eIdx = this->problem(freeFlowMomentumIndex).gridGeometry().elementMapper().index(elementI); + return momentumToMassAndEnergyStencils_[eIdx]; + } + + // \} + + /*! + * \name member functions concerning variable caching for element residual evaluations + */ + // \{ + + /*! + * \ingroup MultiDomain + * \brief updates all data and variables that are necessary to evaluate the residual of the element of domain i + * this is called whenever one of the primary variables that the element residual depends on changes in domain j + * + * \param domainI the domain index of domain i + * \param localAssemblerI the local assembler assembling the element residual of an element of domain i + * \param domainJ the domain index of domain j + * \param dofIdxGlobalJ the index of the degree of freedom of domain j whose solution changed + * \param priVarsJ the new solution at the degree of freedom of domain j with index dofIdxGlobalJ + * \param pvIdxJ the index of the primary variable of domain j which has been updated + * + * \note this concerns all data that is used in the evaluation of the element residual and depends on + * the primary variables at the degree of freedom location with index dofIdxGlobalJ + * \note the element whose residual is to be evaluated can be retrieved from the local assembler + * as localAssemblerI.element() + * \note per default, we update the solution vector, if the element residual of domain i depends on more than + * the primary variables of domain j update the other dependent data here by overloading this function + */ + template + void updateCouplingContext(Dune::index_constant domainI, + const LocalAssemblerI& localAssemblerI, + Dune::index_constant domainJ, + std::size_t dofIdxGlobalJ, + const PrimaryVariables& priVarsJ, + int pvIdxJ) + { + this->curSol(domainJ)[dofIdxGlobalJ][pvIdxJ] = priVarsJ[pvIdxJ]; + + if constexpr (MassDiscretizationMethod{} == DiscretizationMethods::cctpfa) + { + if constexpr (domainI == freeFlowMomentumIndex && domainJ == freeFlowMassIndex) + { + bindCouplingContext_(domainI, localAssemblerI.element()); + + const auto& problem = this->problem(domainJ); + const auto& deflectedElement = problem.gridGeometry().element(dofIdxGlobalJ); + const auto elemSol = elementSolution(deflectedElement, this->curSol(domainJ), problem.gridGeometry()); + const auto& fvGeometry = momentumCouplingContext_()[0].fvGeometry; + const auto& scv = fvGeometry.scv(dofIdxGlobalJ); + + if constexpr (ElementVolumeVariables::GridVolumeVariables::cachingEnabled) + gridVars_(freeFlowMassIndex).curGridVolVars().volVars(scv).update(std::move(elemSol), problem, deflectedElement, scv); + else + momentumCouplingContext_()[0].curElemVolVars[scv].update(std::move(elemSol), problem, deflectedElement, scv); + } + } + else if constexpr (MassDiscretizationMethod{} == DiscretizationMethods::box + || MassDiscretizationMethod{} == DiscretizationMethods::fcdiamond) + { + if constexpr (domainI == freeFlowMomentumIndex && domainJ == freeFlowMassIndex) + { + bindCouplingContext_(domainI, localAssemblerI.element()); + + const auto& problem = this->problem(domainJ); + const auto& deflectedElement = problem.gridGeometry().element(this->momentumCouplingContext_()[0].eIdx); + const auto elemSol = elementSolution(deflectedElement, this->curSol(domainJ), problem.gridGeometry()); + const auto& fvGeometry = this->momentumCouplingContext_()[0].fvGeometry; + + for (const auto& scv : scvs(fvGeometry)) + { + if(scv.dofIndex() == dofIdxGlobalJ) + { + if constexpr (ElementVolumeVariables::GridVolumeVariables::cachingEnabled) + this->gridVars_(freeFlowMassIndex).curGridVolVars().volVars(scv).update(std::move(elemSol), problem, deflectedElement, scv); + else + this->momentumCouplingContext_()[0].curElemVolVars[scv].update(std::move(elemSol), problem, deflectedElement, scv); + } + } + } + } + else + DUNE_THROW(Dune::NotImplemented, + "Context update for discretization scheme " << MassDiscretizationMethod{} + ); + } + + // \} + + /*! + * \brief Compute colors for multithreaded assembly + */ + void computeColorsForAssembly() + { + // use coloring of the momentum discretization for both domains + elementSets_ = computeColoring(this->problem(freeFlowMomentumIndex).gridGeometry()).sets; + } + + /*! + * \brief Execute assembly kernel in parallel + * + * \param domainI the domain index of domain i + * \param assembleElement kernel function to execute for one element + */ + template + void assembleMultithreaded(Dune::index_constant domainId, AssembleElementFunc&& assembleElement) const + { + if (elementSets_.empty()) + DUNE_THROW(Dune::InvalidStateException, "Call computeColorsForAssembly before assembling in parallel!"); + + // make this element loop run in parallel + // for this we have to color the elements so that we don't get + // race conditions when writing into the global matrix + // each color can be assembled using multiple threads + const auto& grid = this->problem(domainId).gridGeometry().gridView().grid(); + for (const auto& elements : elementSets_) + { + Dumux::parallelFor(elements.size(), [&](const std::size_t n) + { + const auto element = grid.entity(elements[n]); + assembleElement(element); + }); + } + } + +private: + void bindCouplingContext_(Dune::index_constant domainI, + const Element& elementI) const + { + // The call to this->problem() is expensive because of std::weak_ptr (see base class). Here we try to avoid it if possible. + if (momentumCouplingContext_().empty()) + bindCouplingContext_(domainI, elementI, this->problem(freeFlowMomentumIndex).gridGeometry().elementMapper().index(elementI)); + else + bindCouplingContext_(domainI, elementI, momentumCouplingContext_()[0].fvGeometry.gridGeometry().elementMapper().index(elementI)); + } + + void bindCouplingContext_(Dune::index_constant domainI, + const Element& elementI, + const std::size_t eIdx) const + { + if (momentumCouplingContext_().empty()) + { + auto fvGeometry = localView(this->problem(freeFlowMassIndex).gridGeometry()); + fvGeometry.bind(elementI); + + auto curElemVolVars = localView(gridVars_(freeFlowMassIndex).curGridVolVars()); + curElemVolVars.bind(elementI, fvGeometry, this->curSol(freeFlowMassIndex)); + + auto prevElemVolVars = isTransient_ ? localView(gridVars_(freeFlowMassIndex).prevGridVolVars()) + : localView(gridVars_(freeFlowMassIndex).curGridVolVars()); + + if (isTransient_) + prevElemVolVars.bindElement(elementI, fvGeometry, (*prevSol_)[freeFlowMassIndex]); + + momentumCouplingContext_().emplace_back(MomentumCouplingContext{std::move(fvGeometry), std::move(curElemVolVars), std::move(prevElemVolVars), eIdx}); + } + else if (eIdx != momentumCouplingContext_()[0].eIdx) + { + momentumCouplingContext_()[0].eIdx = eIdx; + momentumCouplingContext_()[0].fvGeometry.bind(elementI); + momentumCouplingContext_()[0].curElemVolVars.bind(elementI, momentumCouplingContext_()[0].fvGeometry, this->curSol(freeFlowMassIndex)); + + if (isTransient_) + momentumCouplingContext_()[0].prevElemVolVars.bindElement(elementI, momentumCouplingContext_()[0].fvGeometry, (*prevSol_)[freeFlowMassIndex]); + } + } + + void bindCouplingContext_(Dune::index_constant domainI, + const Element& elementI) const + { + // The call to this->problem() is expensive because of std::weak_ptr (see base class). Here we try to avoid it if possible. + if (massAndEnergyCouplingContext_().empty()) + bindCouplingContext_(domainI, elementI, this->problem(freeFlowMassIndex).gridGeometry().elementMapper().index(elementI)); + else + bindCouplingContext_(domainI, elementI, massAndEnergyCouplingContext_()[0].fvGeometry.gridGeometry().elementMapper().index(elementI)); + } + + void bindCouplingContext_(Dune::index_constant domainI, + const Element& elementI, + const std::size_t eIdx) const + { + if (massAndEnergyCouplingContext_().empty()) + { + const auto& gridGeometry = this->problem(freeFlowMomentumIndex).gridGeometry(); + auto fvGeometry = localView(gridGeometry); + fvGeometry.bindElement(elementI); + massAndEnergyCouplingContext_().emplace_back(std::move(fvGeometry), eIdx); + } + else if (eIdx != massAndEnergyCouplingContext_()[0].eIdx) + { + massAndEnergyCouplingContext_()[0].eIdx = eIdx; + massAndEnergyCouplingContext_()[0].fvGeometry.bindElement(elementI); + } + } + + /*! + * \brief Return a reference to the grid variables of a sub problem + * \param domainIdx The domain index + */ + template + const GridVariables& gridVars_(Dune::index_constant domainIdx) const + { + if (std::get(gridVariables_)) + return *std::get(gridVariables_); + else + DUNE_THROW(Dune::InvalidStateException, "The gridVariables pointer was not set. Use setGridVariables() before calling this function"); + } + + /*! + * \brief Return a reference to the grid variables of a sub problem + * \param domainIdx The domain index + */ + template + GridVariables& gridVars_(Dune::index_constant domainIdx) + { + if (std::get(gridVariables_)) + return *std::get(gridVariables_); + else + DUNE_THROW(Dune::InvalidStateException, "The gridVariables pointer was not set. Use setGridVariables() before calling this function"); + } + + + void computeCouplingStencils_() + { + const auto& momentumGridGeometry = this->problem(freeFlowMomentumIndex).gridGeometry(); + const auto& massGridGeometry = this->problem(freeFlowMassIndex).gridGeometry(); + auto momentumFvGeometry = localView(momentumGridGeometry); + auto massFvGeometry = localView(massGridGeometry); + + massAndEnergyToMomentumStencils_.clear(); + massAndEnergyToMomentumStencils_.resize(massGridGeometry.gridView().size(0)); + + momentumToMassAndEnergyStencils_.clear(); + momentumToMassAndEnergyStencils_.resize(momentumGridGeometry.gridView().size(0)); + + assert(massAndEnergyToMomentumStencils_.size() == momentumToMassAndEnergyStencils_.size()); + + for (const auto& element : elements(momentumGridGeometry.gridView())) + { + momentumFvGeometry.bindElement(element); + massFvGeometry.bindElement(element); + const auto eIdx = momentumFvGeometry.elementIndex(); + + for (const auto& scv : scvs(momentumFvGeometry)) + massAndEnergyToMomentumStencils_[eIdx].push_back(scv.dofIndex()); + + for (const auto& scv : scvs(massFvGeometry)) + momentumToMassAndEnergyStencils_[eIdx].push_back(scv.dofIndex()); + } + } + + CouplingStencilType emptyStencil_; + std::vector momentumToMassAndEnergyStencils_; + std::vector massAndEnergyToMomentumStencils_; + + // the coupling context exists for each thread + // TODO this is a bad pattern, just like mutable caches + // we should really construct and pass the context and not store it globally + std::vector& momentumCouplingContext_() const + { + thread_local static std::vector c; + return c; + } + + // the coupling context exists for each thread + std::vector& massAndEnergyCouplingContext_() const + { + thread_local static std::vector c; + return c; + } + + //! A tuple of std::shared_ptrs to the grid variables of the sub problems + GridVariablesTuple gridVariables_; + + const SolutionVector* prevSol_; + bool isTransient_; + + std::deque>> elementSets_; +}; + +//! we support multithreaded assembly +template +struct CouplingManagerSupportsMultithreadedAssembly> +: public std::true_type {}; + +} // end namespace Dumux + +#endif diff --git a/dumux/multidomain/fvassembler.hh b/dumux/multidomain/fvassembler.hh index 2673368433ef44531b58ba52fbfc4f55b1ee30e6..875c3b69f993f195d79b6f63d1b88b4362915241 100644 --- a/dumux/multidomain/fvassembler.hh +++ b/dumux/multidomain/fvassembler.hh @@ -49,6 +49,7 @@ #include "subdomainstaggeredlocalassembler.hh" #include "subdomainfclocalassembler.hh" #include "subdomainfcdiamondlocalassembler.hh" +#include "subdomainpq1bubblelocalassembler.hh" #include @@ -176,6 +177,12 @@ private: using type = SubDomainFaceCenteredDiamondLocalAssembler, ThisType, diffMethod, isImplicit()>; }; + template + struct SubDomainAssemblerType + { + using type = SubDomainPQ1BubbleLocalAssembler, ThisType, diffMethod, isImplicit()>; + }; + template using SubDomainAssembler = typename SubDomainAssemblerType::DiscretizationMethod, id>::type; diff --git a/dumux/multidomain/subdomainpq1bubblelocalassembler.hh b/dumux/multidomain/subdomainpq1bubblelocalassembler.hh new file mode 100644 index 0000000000000000000000000000000000000000..9c551bba8c64051fafea18dc2c5dabfa04edfae8 --- /dev/null +++ b/dumux/multidomain/subdomainpq1bubblelocalassembler.hh @@ -0,0 +1,419 @@ +// -*- 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 3 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 . * + *****************************************************************************/ +/*! + * \file + * \ingroup Assembly + * \ingroup PQ1BubbleDiscretization + * \ingroup MultiDomain + * \brief An assembler for Jacobian and residual contribution per element for multidomain problems + */ +#ifndef DUMUX_MULTIDOMAIN_PQ1BUBBLE_SUBDOMAIN_LOCAL_ASSEMBLER_HH +#define DUMUX_MULTIDOMAIN_PQ1BUBBLE_SUBDOMAIN_LOCAL_ASSEMBLER_HH + +#include +#include +#include // for GhostEntity + +#include +#include +#include +#include +#include +#include + +namespace Dumux { + +/*! + * \ingroup Assembly + * \ingroup PQ1BubbleDiscretization + * \ingroup MultiDomain + * \brief A base class for PQ1Bubble local assemblers + * \tparam id the id of the sub domain + * \tparam TypeTag the TypeTag + * \tparam Assembler the assembler type + * \tparam Implementation the actual implementation type + * \tparam implicit Specifies whether the time discretization is implicit or not not (i.e. explicit) + */ +template +class SubDomainPQ1BubbleLocalAssemblerBase : public PQ1BubbleLocalAssembler +{ + using ParentType = PQ1BubbleLocalAssembler; + + using Problem = GetPropType; + using SolutionVector = typename Assembler::SolutionVector; + using SubSolutionVector = GetPropType; + + using GridVariables = GetPropType; + using GridVolumeVariables = typename GridVariables::GridVolumeVariables; + using ElementVolumeVariables = typename GridVolumeVariables::LocalView; + using ElementFluxVariablesCache = typename GridVariables::GridFluxVariablesCache::LocalView; + using Scalar = typename GridVariables::Scalar; + + using GridGeometry = typename GridVariables::GridGeometry; + using FVElementGeometry = typename GridGeometry::LocalView; + using SubControlVolume = typename GridGeometry::SubControlVolume; + using GridView = typename GridGeometry::GridView; + using Element = typename GridView::template Codim<0>::Entity; + + using CouplingManager = typename Assembler::CouplingManager; + + static constexpr auto numEq = GetPropType::numEq(); + +public: + //! export the domain id of this sub-domain + static constexpr auto domainId = typename Dune::index_constant(); + //! pull up constructor of parent class + using ParentType::ParentType; + //! export element residual vector type + using ElementResidualVector = typename ParentType::LocalResidual::ElementResidualVector; + + // the constructor + explicit SubDomainPQ1BubbleLocalAssemblerBase( + const Assembler& assembler, + const Element& element, + const SolutionVector& curSol, + CouplingManager& couplingManager + ) + : ParentType(assembler, + element, + curSol, + localView(assembler.gridGeometry(domainId)), + localView(assembler.gridVariables(domainId).curGridVolVars()), + localView(assembler.gridVariables(domainId).prevGridVolVars()), + localView(assembler.gridVariables(domainId).gridFluxVarsCache()), + assembler.localResidual(domainId), + (element.partitionType() == Dune::GhostEntity)) + , couplingManager_(couplingManager) + {} + + /*! + * \brief Computes the derivatives with respect to the given element and adds them + * to the global matrix. The element residual is written into the right hand side. + */ + template + void assembleJacobianAndResidual(JacobianMatrixRow& jacRow, SubSolutionVector& res, GridVariablesTuple& gridVariables) + { + auto assembleCouplingBlocks = [&](const auto& residual) + { + // assemble the coupling blocks + using namespace Dune::Hybrid; + forEach(integralRange(Dune::Hybrid::size(jacRow)), [&](auto&& i) + { + if (i != id) + this->assembleJacobianCoupling(i, jacRow, residual, gridVariables); + }); + }; + + // the coupled model does not support partial reassembly yet + const DefaultPartialReassembler* noReassembler = nullptr; + ParentType::assembleJacobianAndResidual(jacRow[domainId], res, *std::get(gridVariables), noReassembler, assembleCouplingBlocks); + } + + /*! + * \brief Assemble the entries in a coupling block of the jacobian. + * There is no coupling block between a domain and itself. + */ + template = 0> + void assembleJacobianCoupling(Dune::index_constant domainJ, JacRow& jacRow, + const ElementResidualVector& res, GridVariables& gridVariables) + {} + + /*! + * \brief Assemble the entries in a coupling block of the jacobian. + */ + template = 0> + void assembleJacobianCoupling(Dune::index_constant domainJ, JacRow& jacRow, + const ElementResidualVector& res, GridVariables& gridVariables) + { + this->asImp_().assembleJacobianCoupling(domainJ, jacRow[domainJ], res, *std::get(gridVariables)); + } + + /*! + * \brief Evaluates the local source term for an element and given element volume variables + */ + ElementResidualVector evalLocalSourceResidual(const Element& element, const ElementVolumeVariables& elemVolVars) const + { + // initialize the residual vector for all scvs in this element + ElementResidualVector residual(this->fvGeometry().numScv()); + + // evaluate the volume terms (storage + source terms) + // forward to the local residual specialized for the discretization methods + for (auto&& scv : scvs(this->fvGeometry())) + { + const auto& curVolVars = elemVolVars[scv]; + auto source = this->localResidual().computeSource(problem(), element, this->fvGeometry(), elemVolVars, scv); + source *= -scv.volume()*curVolVars.extrusionFactor(); + residual[scv.localDofIndex()] = std::move(source); + } + + return residual; + } + + /*! + * \brief Evaluates the local source term depending on time discretization scheme + */ + ElementResidualVector evalLocalSourceResidual(const Element& neighbor) const + { return this->evalLocalSourceResidual(neighbor, implicit ? this->curElemVolVars() : this->prevElemVolVars()); } + + /*! + * \brief Prepares all local views necessary for local assembly. + */ + void bindLocalViews() + { + // get some references for convenience + const auto& element = this->element(); + const auto& curSol = this->curSol(domainId); + auto&& fvGeometry = this->fvGeometry(); + auto&& curElemVolVars = this->curElemVolVars(); + auto&& elemFluxVarsCache = this->elemFluxVarsCache(); + + // bind the caches + couplingManager_.bindCouplingContext(domainId, element, this->assembler()); + fvGeometry.bind(element); + + if (implicit) + { + curElemVolVars.bind(element, fvGeometry, curSol); + elemFluxVarsCache.bind(element, fvGeometry, curElemVolVars); + if (!this->assembler().isStationaryProblem()) + this->prevElemVolVars().bindElement(element, fvGeometry, this->assembler().prevSol()[domainId]); + } + else + { + auto& prevElemVolVars = this->prevElemVolVars(); + const auto& prevSol = this->assembler().prevSol()[domainId]; + + curElemVolVars.bindElement(element, fvGeometry, curSol); + prevElemVolVars.bind(element, fvGeometry, prevSol); + elemFluxVarsCache.bind(element, fvGeometry, prevElemVolVars); + } + + this->elemBcTypes().update(problem(), this->element(), this->fvGeometry()); + } + + //! return reference to the underlying problem + template + const Problem& problem(Dune::index_constant dId = domainId) const + { return this->assembler().problem(domainId); } + + //! return reference to the underlying problem + template + const auto& curSol(Dune::index_constant dId = domainId) const + { return ParentType::curSol()[dId]; } + + //! return reference to the coupling manager + CouplingManager& couplingManager() + { return couplingManager_; } + +private: + CouplingManager& couplingManager_; //!< the coupling manager +}; + +/*! + * \ingroup Assembly + * \ingroup PQ1BubbleDiscretization + * \ingroup MultiDomain + * \brief The PQ1Bubble scheme multidomain local assembler + * \tparam id the id of the sub domain + * \tparam TypeTag the TypeTag + * \tparam Assembler the assembler type + * \tparam DM the numeric differentiation method + * \tparam implicit whether the assembler is explicit or implicit in time + */ +template +class SubDomainPQ1BubbleLocalAssembler; + +/*! + * \ingroup Assembly + * \ingroup PQ1BubbleDiscretization + * \ingroup MultiDomain + * \brief Control-volume fe staggered scheme multi domain local assembler using numeric differentiation and implicit time discretization + */ +template +class SubDomainPQ1BubbleLocalAssembler +: public SubDomainPQ1BubbleLocalAssemblerBase, DiffMethod::numeric, /*implicit=*/true> +{ + using ThisType = SubDomainPQ1BubbleLocalAssembler; + using ParentType = SubDomainPQ1BubbleLocalAssemblerBase; + using Scalar = GetPropType; + using VolumeVariables = GetPropType; + + using Problem = GetPropType; + using GridGeometry = GetPropType; + using FVElementGeometry = typename GridGeometry::LocalView; + using GridView = typename GridGeometry::GridView; + using Element = typename GridView::template Codim<0>::Entity; + using SubControlVolume = typename FVElementGeometry::SubControlVolume; + + enum { numEq = GetPropType::numEq() }; + enum { dim = GridView::dimension }; + + static constexpr bool enableGridFluxVarsCache = GetPropType::GridFluxVariablesCache::cachingEnabled; + static constexpr bool enableGridVolVarsCache = GetPropType::GridVolumeVariables::cachingEnabled; + static constexpr auto domainI = Dune::index_constant(); + +public: + using ParentType::ParentType; + //! export element residual vector type + using ElementResidualVector = typename ParentType::LocalResidual::ElementResidualVector; + + /*! + * \brief Update the coupling context for coupled models. + */ + template + void maybeUpdateCouplingContext(const SubControlVolume& scv, ElemSol& elemSol, const int pvIdx) + { + this->couplingManager().updateCouplingContext(domainI, *this, domainI, scv.dofIndex(), elemSol[scv.localDofIndex()], pvIdx); + } + + /*! + * \brief Update the additional domain derivatives for coupled models. + */ + template + void maybeEvalAdditionalDomainDerivatives(const ElementResidualVector& origResiduals, const JacobianMatrixDiagBlock& A, GridVariables& gridVariables) + { + this->couplingManager().evalAdditionalDomainDerivatives(domainI, *this, origResiduals, A, gridVariables); + } + + /*! + * \brief Computes the derivatives with respect to the given element and adds them + * to the global matrix. + * + * \return The element residual at the current solution. + */ + template + void assembleJacobianCoupling(Dune::index_constant domainJ, JacobianBlock& A, + const ElementResidualVector& res, GridVariables& gridVariables) + { + //////////////////////////////////////////////////////////////////////////////////////////////////////// + // Calculate derivatives of all dofs in the element with respect to all dofs in the coupling stencil. // + //////////////////////////////////////////////////////////////////////////////////////////////////////// + + // get some aliases for convenience + const auto& element = this->element(); + const auto& fvGeometry = this->fvGeometry(); + auto&& curElemVolVars = this->curElemVolVars(); + auto&& elemFluxVarsCache = this->elemFluxVarsCache(); + + // convenience lambda for call to update self + auto updateCoupledVariables = [&] () + { + // Update ourself after the context has been modified. Depending on the + // type of caching, other objects might have to be updated. All ifs can be optimized away. + if constexpr (enableGridFluxVarsCache) + { + if constexpr (enableGridVolVarsCache) + this->couplingManager().updateCoupledVariables(domainI, *this, gridVariables.curGridVolVars(), gridVariables.gridFluxVarsCache()); + else + this->couplingManager().updateCoupledVariables(domainI, *this, curElemVolVars, gridVariables.gridFluxVarsCache()); + } + else + { + if constexpr (enableGridVolVarsCache) + this->couplingManager().updateCoupledVariables(domainI, *this, gridVariables.curGridVolVars(), elemFluxVarsCache); + else + this->couplingManager().updateCoupledVariables(domainI, *this, curElemVolVars, elemFluxVarsCache); + } + }; + + const auto& stencil = this->couplingManager().couplingStencil(domainI, element, domainJ); + const auto& curSolJ = this->curSol(domainJ); + for (const auto globalJ : stencil) + { + // undeflected privars and privars to be deflected + const auto origPriVarsJ = curSolJ[globalJ]; + auto priVarsJ = origPriVarsJ; + + // the undeflected coupling residual + const auto origResidual = this->couplingManager().evalCouplingResidual(domainI, *this, domainJ, globalJ); + + for (int pvIdx = 0; pvIdx < JacobianBlock::block_type::cols; ++pvIdx) + { + auto evalCouplingResidual = [&](Scalar priVar) + { + priVarsJ[pvIdx] = priVar; + this->couplingManager().updateCouplingContext(domainI, *this, domainJ, globalJ, priVarsJ, pvIdx); + updateCoupledVariables(); + return this->couplingManager().evalCouplingResidual(domainI, *this, domainJ, globalJ); + }; + + // derive the residuals numerically + ElementResidualVector partialDerivs(fvGeometry.numScv()); + + const auto& paramGroup = this->assembler().problem(domainJ).paramGroup(); + static const int numDiffMethod = getParamFromGroup(paramGroup, "Assembly.NumericDifferenceMethod"); + static const auto epsCoupl = this->couplingManager().numericEpsilon(domainJ, paramGroup); + + NumericDifferentiation::partialDerivative(evalCouplingResidual, origPriVarsJ[pvIdx], partialDerivs, origResidual, + epsCoupl(origPriVarsJ[pvIdx], pvIdx), numDiffMethod); + + // update the global stiffness matrix with the current partial derivatives + for (const auto& scv : scvs(fvGeometry)) + { + for (int eqIdx = 0; eqIdx < numEq; eqIdx++) + { + // A[i][col][eqIdx][pvIdx] is the rate of change of + // the residual of equation 'eqIdx' at dof 'i' + // depending on the primary variable 'pvIdx' at dof + // 'col'. + A[scv.dofIndex()][globalJ][eqIdx][pvIdx] += partialDerivs[scv.localDofIndex()][eqIdx]; + + // If the dof is coupled by a Dirichlet condition, + // set the derived value only once (i.e. overwrite existing values). + if (this->elemBcTypes().hasDirichlet()) + { + const auto bcTypes = this->elemBcTypes().get(fvGeometry, scv); + if (bcTypes.isCouplingDirichlet(eqIdx)) + A[scv.dofIndex()][globalJ][eqIdx][pvIdx] = partialDerivs[scv.localDofIndex()][eqIdx]; + else if (bcTypes.isDirichlet(eqIdx)) + A[scv.dofIndex()][globalJ][eqIdx][pvIdx] = 0.0; + } + + // enforce internal Dirichlet constraints + if constexpr (Problem::enableInternalDirichletConstraints()) + { + const auto internalDirichletConstraints = this->problem().hasInternalDirichletConstraint(this->element(), scv); + if (internalDirichletConstraints[eqIdx]) + A[scv.dofIndex()][globalJ][eqIdx][pvIdx] = 0.0; + } + } + } + + // restore the current element solution + priVarsJ[pvIdx] = origPriVarsJ[pvIdx]; + + // restore the undeflected state of the coupling context + this->couplingManager().updateCouplingContext(domainI, *this, domainJ, globalJ, priVarsJ, pvIdx); + } + + // Restore original state of the flux vars cache and/or vol vars. + // This has to be done in case they depend on variables of domainJ before + // we continue with the numeric derivative w.r.t the next globalJ. Otherwise, + // the next "origResidual" will be incorrect. + updateCoupledVariables(); + } + } +}; + +} // end namespace Dumux + +#endif diff --git a/test/freeflow/navierstokes/analyticalsolutionvectors.hh b/test/freeflow/navierstokes/analyticalsolutionvectors.hh index e53873985e95cd1e0f8e9f56ad37c4aceeebc89e..15a7c766da83fe0aa0b7e630fc8f29018a157354 100644 --- a/test/freeflow/navierstokes/analyticalsolutionvectors.hh +++ b/test/freeflow/navierstokes/analyticalsolutionvectors.hh @@ -51,7 +51,7 @@ public: { analyticalPressure_.resize(problem_->gridGeometry().numCellCenterDofs()); analyticalVelocity_.resize(problem_->gridGeometry().numCellCenterDofs()); - analyticalVelocityOnFace_.resize(problem_->gridGeometry().numFaceDofs()); + analyticalVelocityAtDofs_.resize(problem_->gridGeometry().numFaceDofs()); auto fvGeometry = localView(problem_->gridGeometry()); @@ -63,7 +63,7 @@ public: // velocities on faces for (const auto& scvf : scvfs(fvGeometry)) { - analyticalVelocityOnFace_[scvf.dofIndex()][scvf.directionIndex()] = problem_->analyticalSolution(scvf.center(), time)[Indices::velocity(scvf.directionIndex())]; + analyticalVelocityAtDofs_[scvf.dofIndex()][scvf.directionIndex()] = problem_->analyticalSolution(scvf.center(), time)[Indices::velocity(scvf.directionIndex())]; } analyticalPressure_[scv.dofIndex()] = problem_->analyticalSolution(scv.dofPosition(), time)[Indices::pressureIdx]; @@ -93,9 +93,9 @@ public: /*! * \brief Returns the analytical solution for the velocity at the faces */ - const std::vector& getAnalyticalVelocitySolutionOnFace() const + const std::vector& getAnalyticalVelocitySolutionAtDofs() const { - return analyticalVelocityOnFace_; + return analyticalVelocityAtDofs_; } private: @@ -103,7 +103,7 @@ private: std::vector analyticalPressure_; std::vector analyticalVelocity_; - std::vector analyticalVelocityOnFace_; + std::vector analyticalVelocityAtDofs_; }; template @@ -147,7 +147,7 @@ public: { analyticalPressure_.resize(massProblem_->gridGeometry().numDofs()); analyticalVelocity_.resize(massProblem_->gridGeometry().gridView().size(0)); - analyticalVelocityOnFace_.resize(momentumProblem_->gridGeometry().numDofs()); + analyticalVelocityAtDofs_.resize(momentumProblem_->gridGeometry().numDofs()); // cell-centers (pressure + velocity) { @@ -170,7 +170,7 @@ public: } } - // face-centers (velocity) + // dof positions (velocity) { auto fvGeometry = localView(momentumProblem_->gridGeometry()); const auto gridView = momentumProblem_->gridGeometry().gridView(); @@ -180,13 +180,14 @@ public: if constexpr (MomentumGridGeometry::discMethod == DiscretizationMethods::fcstaggered) for (const auto& scv : scvs(fvGeometry)) - analyticalVelocityOnFace_[scv.dofIndex()][scv.dofAxis()] + analyticalVelocityAtDofs_[scv.dofIndex()][scv.dofAxis()] = momentumProblem_->analyticalSolution(scv.center(), time)[MomIndices::velocity(scv.dofAxis())]; - else if constexpr (MomentumGridGeometry::discMethod == DiscretizationMethods::fcdiamond) + else if constexpr (MomentumGridGeometry::discMethod == DiscretizationMethods::fcdiamond + || MomentumGridGeometry::discMethod == DiscretizationMethods::pq1bubble) for (const auto& scv : scvs(fvGeometry)) for (int dirIdx = 0; dirIdx < dimWorld; ++dirIdx) - analyticalVelocityOnFace_[scv.dofIndex()][dirIdx] + analyticalVelocityAtDofs_[scv.dofIndex()][dirIdx] = momentumProblem_->analyticalSolution(scv.dofPosition(), time)[MomIndices::velocity(dirIdx)]; else @@ -214,9 +215,9 @@ public: /*! * \brief Returns the analytical solution for the velocity at the faces */ - const std::vector& analyticalVelocitySolutionOnFace() const + const std::vector& analyticalVelocitySolutionAtDofs() const { - return analyticalVelocityOnFace_; + return analyticalVelocityAtDofs_; } private: @@ -225,7 +226,7 @@ private: std::vector analyticalPressure_; std::vector analyticalVelocity_; - std::vector analyticalVelocityOnFace_; + std::vector analyticalVelocityAtDofs_; }; template diff --git a/test/freeflow/navierstokes/channel/3d_nonuniform/CMakeLists.txt b/test/freeflow/navierstokes/channel/3d_nonuniform/CMakeLists.txt index 9ae8d20eebd5dc084b9bef2bfcc10402331f1879..abdd485b983224d546e41830c461f7fadc25c5ce 100644 --- a/test/freeflow/navierstokes/channel/3d_nonuniform/CMakeLists.txt +++ b/test/freeflow/navierstokes/channel/3d_nonuniform/CMakeLists.txt @@ -1,23 +1,39 @@ dune_symlink_to_source_files(FILES "params.input" "channel.msh" "channel_quad.msh") -dumux_add_test(NAME test_ff_stokes_channel_3d_nonuniform +dumux_add_test(NAME test_ff_stokes_channel_3d_nonuniform_diamond SOURCES main.cc + COMPILE_DEFINITIONS TYPETAG_MOMENTUM=ThreeDChannelTestMomentumDiamond + COMPILE_DEFINITIONS TYPETAG_MASS=ThreeDChannelTestMassTpfa LABELS freeflow navierstokes CMAKE_GUARD "( HAVE_UMFPACK AND dune-uggrid_FOUND )" COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py CMD_ARGS --script fuzzy - --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_stokes_channel_3d_nonuniform-reference.vtu - ${CMAKE_CURRENT_BINARY_DIR}/test_ff_stokes_channel_3d_nonuniform-00001.vtu - --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_stokes_channel_3d_nonuniform params.input - -Problem.Name test_ff_stokes_channel_3d_nonuniform") + --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_stokes_channel_3d_nonuniform_diamond-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_ff_stokes_channel_3d_nonuniform_diamond-00001.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_stokes_channel_3d_nonuniform_diamond params.input + -Problem.Name test_ff_stokes_channel_3d_nonuniform_diamond") -dumux_add_test(NAME test_ff_stokes_channel_3d_nonuniform_simplex - TARGET test_ff_stokes_channel_3d_nonuniform +dumux_add_test(NAME test_ff_stokes_channel_3d_nonuniform_diamond_simplex + TARGET test_ff_stokes_channel_3d_nonuniform_diamond LABELS freeflow navierstokes CMAKE_GUARD "( HAVE_UMFPACK AND dune-uggrid_FOUND )" COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py CMD_ARGS --script fuzzy - --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_stokes_channel_3d_nonuniform_simplex-reference.vtu - ${CMAKE_CURRENT_BINARY_DIR}/test_ff_stokes_channel_3d_nonuniform_simplex-00001.vtu - --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_stokes_channel_3d_nonuniform params.input - -Problem.Name test_ff_stokes_channel_3d_nonuniform_simplex + --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_stokes_channel_3d_nonuniform_diamond_simplex-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_ff_stokes_channel_3d_nonuniform_diamond_simplex-00001.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_stokes_channel_3d_nonuniform_diamond params.input + -Problem.Name test_ff_stokes_channel_3d_nonuniform_diamond_simplex -Grid.File channel.msh") + +dumux_add_test(NAME test_ff_stokes_channel_3d_nonuniform_pq1bubble_simplex + SOURCES main.cc + COMPILE_DEFINITIONS TYPETAG_MOMENTUM=ThreeDChannelTestMomentumPQ1Bubble + COMPILE_DEFINITIONS TYPETAG_MASS=ThreeDChannelTestMassBox + LABELS freeflow navierstokes + CMAKE_GUARD "( HAVE_UMFPACK AND dune-uggrid_FOUND )" + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_stokes_channel_3d_nonuniform_pq1bubble_simplex-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_ff_stokes_channel_3d_nonuniform_pq1bubble_simplex-00001.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_stokes_channel_3d_nonuniform_pq1bubble_simplex params.input + -Problem.Name test_ff_stokes_channel_3d_nonuniform_pq1bubble_simplex + -Grid.File channel.msh") diff --git a/test/freeflow/navierstokes/channel/3d_nonuniform/main.cc b/test/freeflow/navierstokes/channel/3d_nonuniform/main.cc index f5e6919581a66cf235a3fc72d23369838c1d2563..b0874dd3a6c5bee2c4a758e0da06f15e25725aaa 100644 --- a/test/freeflow/navierstokes/channel/3d_nonuniform/main.cc +++ b/test/freeflow/navierstokes/channel/3d_nonuniform/main.cc @@ -54,8 +54,8 @@ int main(int argc, char** argv) using namespace Dumux; // define the type tag for this problem - using MomentumTypeTag = Properties::TTag::ThreeDChannelTestMomentum; - using MassTypeTag = Properties::TTag::ThreeDChannelTestMass; + using MomentumTypeTag = Properties::TTag::TYPETAG_MOMENTUM; + using MassTypeTag = Properties::TTag::TYPETAG_MASS; // initialize MPI+X initialize(argc, argv); diff --git a/test/freeflow/navierstokes/channel/3d_nonuniform/problem.hh b/test/freeflow/navierstokes/channel/3d_nonuniform/problem.hh index 0e9cb34b81faa51dd2b81740366a73204a2be14e..77a5678bb9e0dbcc1ee95eadd8d9f55c7438036b 100644 --- a/test/freeflow/navierstokes/channel/3d_nonuniform/problem.hh +++ b/test/freeflow/navierstokes/channel/3d_nonuniform/problem.hh @@ -104,6 +104,42 @@ public: return values; } + /*! + * \brief Specifies which kind of boundary condition should be + * used for which equation on a given boundary segment. + * + * \param element The finite element + * \param scv The sub control volume + */ + BoundaryTypes boundaryTypes(const Element& element, + const SubControlVolume& scv) const + { + BoundaryTypes values; + + if constexpr (ParentType::isMomentumProblem()) + { + auto fvGeometry = localView(this->gridGeometry()); + fvGeometry.bindElement(element); + + for (const auto& scvf : scvfs(fvGeometry)) + { + if (fvGeometry.scv(scvf.insideScvIdx()).dofIndex() == scv.dofIndex() && scvf.boundary()) + { + if (isOutlet_(scvf) || isInlet_(scvf)) + values.setAllNeumann(); + else + values.setAllDirichlet(); + + break; + } + } + } + else + values.setNeumann(Indices::conti0EqIdx); + + return values; + } + /*! * \brief Evaluates the boundary conditions for a Dirichlet control volume. * @@ -213,7 +249,8 @@ public: using Grid = Dune::FoamGrid; Dune::GridFactory factory; { - std::vector>> elms(gg.numBoundaryScvf()); + std::vector>> elems; + elems.reserve(gg.numBoundaryScvf()); std::vector insertedVertex(gv.size(dim), false); std::vector vertexIndexMap(gv.size(dim), -1); std::vector> points; @@ -229,9 +266,10 @@ public: const auto refElement = referenceElement(element); const auto numVertices = refElement.size(insideIdx, 1, dim); if (numVertices == 3) - elms[boundaryElementIndex].resize(1); + elems.push_back({std::vector{}}); else if (numVertices == 4) - elms[boundaryElementIndex].resize(2); // add two triangles + elems.push_back({std::vector{}, + std::vector{}}); // add two triangles else DUNE_THROW(Dune::NotImplemented, "Wall shear stress for boundary type with " << numVertices << " corners" @@ -252,20 +290,20 @@ public: if (numVertices == 3) - elms[boundaryElementIndex][0].push_back(vertexIndexMap[vIdx]); + elems[boundaryElementIndex][0].push_back(vertexIndexMap[vIdx]); else if (numVertices == 4) { // add two triangles if (i == 0) - elms[boundaryElementIndex][0].push_back(vertexIndexMap[vIdx]); + elems[boundaryElementIndex][0].push_back(vertexIndexMap[vIdx]); else if (i == 1 || i == 2) { - elms[boundaryElementIndex][0].push_back(vertexIndexMap[vIdx]); - elms[boundaryElementIndex][1].push_back(vertexIndexMap[vIdx]); + elems[boundaryElementIndex][0].push_back(vertexIndexMap[vIdx]); + elems[boundaryElementIndex][1].push_back(vertexIndexMap[vIdx]); } else - elms[boundaryElementIndex][1].push_back(vertexIndexMap[vIdx]); + elems[boundaryElementIndex][1].push_back(vertexIndexMap[vIdx]); } else DUNE_THROW(Dune::NotImplemented, @@ -278,12 +316,9 @@ public: } } - if (boundaryElementIndex != gg.numBoundaryScvf()) - DUNE_THROW(Dune::InvalidStateException, "Wrong number of boundary segments"); - for (const auto& p : points) factory.insertVertex(p); - for (const auto& e : elms) + for (const auto& e : elems) for (const auto& ee : e) factory.insertElement(Dune::GeometryTypes::simplex(dim-1), ee); } diff --git a/test/freeflow/navierstokes/channel/3d_nonuniform/properties.hh b/test/freeflow/navierstokes/channel/3d_nonuniform/properties.hh index 208b8d99f253347e1d1013c8e739f18bb57c9c2c..69662b6cbe5be4d33ca3129133b78bd0f4dd38a8 100644 --- a/test/freeflow/navierstokes/channel/3d_nonuniform/properties.hh +++ b/test/freeflow/navierstokes/channel/3d_nonuniform/properties.hh @@ -24,17 +24,32 @@ #ifndef DUMUX_TEST_FREEFLOW_NAVIERSTOKES_3D_CHANNEL_PROPERTIES_HH #define DUMUX_TEST_FREEFLOW_NAVIERSTOKES_3D_CHANNEL_PROPERTIES_HH +#ifndef TYPETAG_MOMENTUM +#define TYPETAG_MOMENTUM ThreeDChannelTestMomentumDiamond +#endif + +#ifndef TYPETAG_MASS +#define TYPETAG_MASS ThreeDChannelTestMassTpfa +#endif + #include #include #include #include #include +#include +#include +#include #include #include #include +#include +#include +#include #include +#include #include #include #include @@ -50,8 +65,10 @@ namespace Dumux::Properties { // Create new type tags namespace TTag { struct ThreeDChannelTest {}; -struct ThreeDChannelTestMomentum { using InheritsFrom = std::tuple; }; -struct ThreeDChannelTestMass { using InheritsFrom = std::tuple; }; +struct ThreeDChannelTestMomentumDiamond { using InheritsFrom = std::tuple; }; +struct ThreeDChannelTestMomentumPQ1Bubble { using InheritsFrom = std::tuple; }; +struct ThreeDChannelTestMassTpfa { using InheritsFrom = std::tuple; }; +struct ThreeDChannelTestMassBox { using InheritsFrom = std::tuple; }; } // end namespace TTag // the fluid system @@ -71,7 +88,7 @@ struct Grid // Set the grid type template -struct GridGeometry +struct GridGeometry { using GridView = typename GetPropType::LeafGridView; static constexpr bool enableCache = getPropValue(); @@ -86,8 +103,27 @@ struct GridGeometry using type = FaceCenteredDiamondFVGridGeometry; }; +// Set the grid type +template +struct GridGeometry +{ + using Scalar = GetPropType; + using GridView = typename GetPropType::LeafGridView; + static constexpr bool enableCache = getPropValue(); + + // use boundary segment index (works with gmsh files and not with dgf when using ALUGrid) + struct MyScvfTraits : public PQ1BubbleDefaultScvfGeometryTraits + { using BoundaryFlag = BoundarySegmentIndexFlag; }; + + struct MyGGTraits : public PQ1BubbleDefaultGridGeometryTraits + { using SubControlVolumeFace = PQ1BubbleSubControlVolumeFace; }; + + using type = PQ1BubbleFVGridGeometry; +}; + + template -struct GridGeometry +struct GridGeometry { using GridView = typename GetPropType::LeafGridView; static constexpr bool enableCache = getPropValue(); @@ -102,18 +138,31 @@ struct GridGeometry using type = CCTpfaFVGridGeometry; }; -// Set the problem property template -struct Problem +struct GridGeometry { - using type = ThreeDChannelTestProblem> ; + using Scalar = GetPropType; + using GridView = typename GetPropType::LeafGridView; + static constexpr bool enableCache = getPropValue(); + + // use boundary segment index (works with gmsh files and not with dgf when using ALUGrid) + struct MyScvfTraits : public BoxDefaultScvfGeometryTraits + { using BoundaryFlag = BoundarySegmentIndexFlag; }; + + struct MyGGTraits : public BoxDefaultGridGeometryTraits + { using SubControlVolumeFace = BoxSubControlVolumeFace; }; + + using type = BoxFVGridGeometry; }; +// Set the problem property +template +struct Problem +{ using type = ThreeDChannelTestProblem>; }; + template -struct Problem -{ - using type = ThreeDChannelTestProblem> ; -}; +struct Problem +{ using type = ThreeDChannelTestProblem>; }; template struct EnableGridGeometryCache { static constexpr bool value = true; }; @@ -125,7 +174,7 @@ struct EnableGridVolumeVariablesCache { static template struct CouplingManager { - using Traits = MultiDomainTraits; + using Traits = MultiDomainTraits; using type = FreeFlowCouplingManager; }; diff --git a/test/freeflow/navierstokes/channel/pipe/momentum/CMakeLists.txt b/test/freeflow/navierstokes/channel/pipe/momentum/CMakeLists.txt index c2579311899c646b3650237173cf903c77dfa213..fe285a78abd0872d32bca361ea70d67bd2286618 100644 --- a/test/freeflow/navierstokes/channel/pipe/momentum/CMakeLists.txt +++ b/test/freeflow/navierstokes/channel/pipe/momentum/CMakeLists.txt @@ -1,8 +1,18 @@ dune_symlink_to_source_files(FILES params.input convergencetest.py) -dumux_add_test(NAME test_ff_stokes_channel_pipe_momenum_diamond +dumux_add_test(NAME test_ff_stokes_channel_pipe_momentum_diamond LABELS freeflow navierstokes SOURCES main.cc + COMPILE_DEFINITIONS TYPETAG=PipeFlowDiamond LABELS freeflow CMAKE_GUARD HAVE_UMFPACK COMMAND ./convergencetest.py - CMD_ARGS test_ff_stokes_channel_pipe_momenum_diamond) + CMD_ARGS test_ff_stokes_channel_pipe_momentum_diamond) + +dumux_add_test(NAME test_ff_stokes_channel_pipe_momentum_pq1bubble + LABELS freeflow navierstokes + SOURCES main.cc + COMPILE_DEFINITIONS TYPETAG=PipeFlowPQ1Bubble + LABELS freeflow + CMAKE_GUARD HAVE_UMFPACK + COMMAND ./convergencetest.py + CMD_ARGS test_ff_stokes_channel_pipe_momentum_pq1bubble) diff --git a/test/freeflow/navierstokes/channel/pipe/momentum/convergencetest.py b/test/freeflow/navierstokes/channel/pipe/momentum/convergencetest.py index 7f8cc84c2a9932ad8158d795c4a3897524639c0c..6fc967c7fe9d1cf5013479d5124f3cd784b23155 100755 --- a/test/freeflow/navierstokes/channel/pipe/momentum/convergencetest.py +++ b/test/freeflow/navierstokes/channel/pipe/momentum/convergencetest.py @@ -67,7 +67,7 @@ def mean(numbers): return float(sum(numbers)) / len(numbers) -if mean(resultsVx) < 2.05 and mean(resultsVx) < 1.9: +if mean(resultsVx) < 2.05 and mean(resultsVx) < 1.9 and max(errorVx) > 1e-15: sys.stderr.write( "*" * 70 + "\n" @@ -77,7 +77,7 @@ if mean(resultsVx) < 2.05 and mean(resultsVx) < 1.9: ) sys.exit(1) -if mean(resultsVy) < 2.05 and mean(resultsVy) < 1.9: +if mean(resultsVy) < 2.05 and mean(resultsVy) < 1.9 and max(errorVy) > 1e-15: sys.stderr.write( "*" * 70 + "\n" diff --git a/test/freeflow/navierstokes/channel/pipe/momentum/main.cc b/test/freeflow/navierstokes/channel/pipe/momentum/main.cc index e039ec767c81766b1b216de51f46e310175ee70f..0d0957de5a9c673b8c0f4e0e5cc884771b3048da 100644 --- a/test/freeflow/navierstokes/channel/pipe/momentum/main.cc +++ b/test/freeflow/navierstokes/channel/pipe/momentum/main.cc @@ -46,7 +46,7 @@ int main(int argc, char** argv) { using namespace Dumux; - using TypeTag = Properties::TTag::PipeFlow; + using TypeTag = Properties::TTag::TYPETAG;; // maybe initialize MPI and/or multithreading backend initialize(argc, argv); @@ -74,8 +74,16 @@ int main(int argc, char** argv) auto gridVariables = std::make_shared(problem, gridGeometry); gridVariables->init(x); + const auto vtkOutputType = [&]{ + if constexpr (GridGeometry::discMethod == Dumux::DiscretizationMethods::fcdiamond) + return Dune::VTK::nonconforming; + else + return Dune::VTK::conforming; + }(); + using VTKOut = VtkOutputModule; - VTKOut vtkWriter(*gridVariables, x, problem->name(), "", Dune::VTK::nonconforming); + VTKOut vtkWriter(*gridVariables, x, problem->name(), "", vtkOutputType); + vtkWriter.addVolumeVariable([](const auto& v){ return v.velocity(); }, "velocity"); std::vector pressure(gridGeometry->gridView().size(0)); for (const auto& e : elements(gridGeometry->gridView())) diff --git a/test/freeflow/navierstokes/channel/pipe/momentum/problem.hh b/test/freeflow/navierstokes/channel/pipe/momentum/problem.hh index 3533a0616cc58088be6f3a0994ad8c666a65aac2..9626f329502e5de902bcde283637bd2d6d3bfc63 100644 --- a/test/freeflow/navierstokes/channel/pipe/momentum/problem.hh +++ b/test/freeflow/navierstokes/channel/pipe/momentum/problem.hh @@ -23,18 +23,16 @@ #include #include -#include - namespace Dumux { /*! * \ingroup NavierStokesTests * \brief Freeflow problem for pipe flow * Simulation of a radially-symmetric pipe flow with circular cross-section */ -template -class FreeFlowPipeProblem : public NavierStokesMomentumProblem +template +class FreeFlowPipeProblem : public BaseProblem { - using ParentType = NavierStokesMomentumProblem; + using ParentType = BaseProblem; using GridGeometry = GetPropType; using FVElementGeometry = typename GridGeometry::LocalView; using SubControlVolume = typename FVElementGeometry::SubControlVolume; diff --git a/test/freeflow/navierstokes/channel/pipe/momentum/properties.hh b/test/freeflow/navierstokes/channel/pipe/momentum/properties.hh index 666ec3f4b5e74d1b8f730d2aea1f22765f849553..821063fb04177c96e982137264a176efbfd42b59 100644 --- a/test/freeflow/navierstokes/channel/pipe/momentum/properties.hh +++ b/test/freeflow/navierstokes/channel/pipe/momentum/properties.hh @@ -28,10 +28,11 @@ #include #include -#include +#include +#include #include -#include +#include #include #include @@ -42,7 +43,9 @@ namespace Dumux::Properties { // Create new type tags namespace TTag { -struct PipeFlow { using InheritsFrom = std::tuple; }; +struct PipeFlow { }; +struct PipeFlowDiamond { using InheritsFrom = std::tuple; }; +struct PipeFlowPQ1Bubble { using InheritsFrom = std::tuple; }; } // end namespace TTag // the fluid system @@ -50,7 +53,7 @@ template struct FluidSystem { using Scalar = GetPropType; - using type = FluidSystems::OnePLiquid > ; + using type = FluidSystems::OnePLiquid >; }; // Set the grid type @@ -61,7 +64,7 @@ struct Grid // Set the problem property template struct Problem -{ using type = FreeFlowPipeProblem ; }; +{ using type = FreeFlowPipeProblem>; }; template struct EnableGridGeometryCache { static constexpr bool value = true; }; @@ -72,7 +75,7 @@ struct EnableGridVolumeVariablesCache { static constexp // rotation-symmetric grid geometry forming a cylinder channel template -struct GridGeometry +struct GridGeometry { static constexpr bool enableCache = getPropValue(); using GridView = typename GetPropType::LeafGridView; @@ -83,6 +86,20 @@ struct GridGeometry using type = FaceCenteredDiamondFVGridGeometry; }; +// rotation-symmetric grid geometry forming a cylinder channel +template +struct GridGeometry +{ + static constexpr bool enableCache = getPropValue(); + using GridView = typename GetPropType::LeafGridView; + using Scalar = GetPropType; + + struct GGTraits : public PQ1BubbleDefaultGridGeometryTraits + { using Extrusion = RotationalExtrusion<0>; }; + + using type = PQ1BubbleFVGridGeometry; +}; + } // end namespace Dumux::Properties #endif diff --git a/test/freeflow/navierstokes/donea/CMakeLists.txt b/test/freeflow/navierstokes/donea/CMakeLists.txt index 26387a29aa7f17bff5d985991e6233a253656be1..4a52e84ef37501b1610b9302489e69631e6012eb 100644 --- a/test/freeflow/navierstokes/donea/CMakeLists.txt +++ b/test/freeflow/navierstokes/donea/CMakeLists.txt @@ -125,7 +125,7 @@ dumux_add_test(NAME test_ff_stokes_donea_momentum_diamond_simplex SOURCES main_momentum.cc LABELS freeflow navierstokes donea CMAKE_GUARD "( HAVE_UMFPACK AND dune-alugrid_FOUND )" - COMPILE_DEFINITIONS GRIDTYPE=Dune::ALUGrid<2,2,Dune::simplex,Dune::conforming> + COMPILE_DEFINITIONS GRIDTYPE=Dune::ALUGrid<2,2,Dune::simplex,Dune::nonconforming> COMPILE_DEFINITIONS DISCRETIZATION_MODEL=FaceCenteredDiamondModel COMPILE_DEFINITIONS NAVIER_STOKES_MODEL=NavierStokesMomentumDiamond COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py @@ -145,3 +145,31 @@ dumux_add_test(NAME test_ff_stokes_donea_momentum_diamond_simplex_parallel ${CMAKE_CURRENT_BINARY_DIR}/s0004-donea_momentum_simplex_fcdiamond_1.pvtu --command "${MPIEXEC} -np 4 ${CMAKE_CURRENT_BINARY_DIR}/test_ff_stokes_donea_momentum_diamond_simplex params.input -Problem.Name donea_momentum_simplex -Problem.UseNeumann true -FreeFlow.EnableUnsymmetrizedVelocityGradient true") + +dumux_add_test(NAME test_ff_stokes_donea_momentum_pq1bubble_quad + SOURCES main_momentum.cc + LABELS freeflow navierstokes donea + CMAKE_GUARD "( HAVE_UMFPACK AND dune-alugrid_FOUND )" + COMPILE_DEFINITIONS GRIDTYPE=Dune::ALUGrid<2,2,Dune::cube,Dune::nonconforming> + COMPILE_DEFINITIONS DISCRETIZATION_MODEL=PQ1BubbleModel + COMPILE_DEFINITIONS NAVIER_STOKES_MODEL=NavierStokesMomentumPQ1Bubble + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_stokes_donea_momentum_pq1bubble_quad-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/donea_momentum_quad_pq1bubble_1.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_stokes_donea_momentum_pq1bubble_quad params.input + -Problem.Name donea_momentum_quad -Problem.UseNeumann true -FreeFlow.EnableUnsymmetrizedVelocityGradient false") + +dumux_add_test(NAME test_ff_stokes_donea_momentum_pq1bubble_simplex + SOURCES main_momentum.cc + LABELS freeflow navierstokes donea + CMAKE_GUARD "( HAVE_UMFPACK AND dune-alugrid_FOUND )" + COMPILE_DEFINITIONS GRIDTYPE=Dune::ALUGrid<2,2,Dune::simplex,Dune::nonconforming> + COMPILE_DEFINITIONS DISCRETIZATION_MODEL=PQ1BubbleModel + COMPILE_DEFINITIONS NAVIER_STOKES_MODEL=NavierStokesMomentumPQ1Bubble + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_stokes_donea_momentum_pq1bubble_simplex-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/donea_momentum_simplex_pq1bubble_1.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_stokes_donea_momentum_pq1bubble_simplex params.input + -Problem.Name donea_momentum_simplex -Problem.UseNeumann false -FreeFlow.EnableUnsymmetrizedVelocityGradient false") diff --git a/test/freeflow/navierstokes/donea/main_momentum.cc b/test/freeflow/navierstokes/donea/main_momentum.cc index fdac04e16128ac0c947282ed321bb2fb476a6376..2ac92e2431a237d4949d8cad40e5b7f02f4e7bf7 100644 --- a/test/freeflow/navierstokes/donea/main_momentum.cc +++ b/test/freeflow/navierstokes/donea/main_momentum.cc @@ -80,13 +80,14 @@ void printErrors(std::shared_ptr problem, std::ofstream logFile(problem->name() + ".csv", std::ios::app); auto totalVolume = errors.totalVolume(); + auto numDofs = errors.numDofs(); // For the staggered scheme, the control volumes are overlapping if constexpr (GridGeometry::discMethod == Dumux::DiscretizationMethods::fcstaggered) totalVolume /= dim; logFile << Fmt::format("{:.5e}", errors.time()) << ", "; - logFile << problem->gridGeometry().numDofs() << ", "; - logFile << std::pow(totalVolume / problem->gridGeometry().numDofs(), 1.0/dim); + logFile << numDofs << ", "; + logFile << std::pow(totalVolume / numDofs, 1.0/dim); const auto& componentErrors = errors.l2Absolute(); // Calculate L2-error for velocity field Dune::FieldVector velError(0.0); @@ -107,10 +108,6 @@ void updateVelocities( ){ auto fvGeometry = localView(gridGeometry); auto elemVolVars = localView(gridVariables.curGridVolVars()); - - using ShapeValue = typename Dune::FieldVector; - std::vector shapeValues; - for (const auto& element : elements(gridGeometry.gridView())) { fvGeometry.bind(element); @@ -134,6 +131,12 @@ void updateVelocities( for (const auto& scv : scvs(fvGeometry)) faceVelocity[scv.dofIndex()] = elemVolVars[scv].velocity(); } + else if constexpr (GridGeometry::discMethod == Dumux::DiscretizationMethods::pq1bubble) + { + const auto elemGeo = element.geometry(); + const auto elemSol = elementSolution(element, x, gridGeometry); + velocity[eIdx] = evalSolution(element, elemGeo, gridGeometry, elemSol, elemGeo.center()); + } else DUNE_THROW(Dune::Exception, "Unknown discretization type: " << GridGeometry::discMethod); } @@ -215,13 +218,17 @@ int main(int argc, char** argv) writer.write(baseName + discSuffix + "_0"); ConformingIntersectionWriter faceVtk(gridGeometry->gridView()); - faceVtk.addField(dofIdx, "dofIdx"); - faceVtk.addField(faceVelocity, "velocityVector"); - faceVtk.addField([&](const auto& is, const auto idx) { - const auto& facet = is.inside().template subEntity <1> (is.indexInInside()); - return facet.partitionType(); - }, "partitionType"); - faceVtk.write(baseName + "_face" + discSuffix + rankSuffix + "_0", Dune::VTK::ascii); + // face quantities have no special significance for the PQ1Bubble scheme + if constexpr (GridGeometry::discMethod != DiscretizationMethods::pq1bubble) + { + faceVtk.addField(dofIdx, "dofIdx"); + faceVtk.addField(faceVelocity, "velocityVector"); + faceVtk.addField([&](const auto& is, const auto idx) { + const auto& facet = is.inside().template subEntity <1> (is.indexInInside()); + return facet.partitionType(); + }, "partitionType"); + faceVtk.write(baseName + "_face" + discSuffix + rankSuffix + "_0", Dune::VTK::ascii); + } using Assembler = FVAssembler; auto assembler = std::make_shared(problem, gridGeometry, gridVariables); @@ -239,7 +246,9 @@ int main(int argc, char** argv) //////////////////////////////////////////////////////////// Dumux::updateVelocities(velocity, faceVelocity, *gridGeometry, *gridVariables, x); writer.write(baseName + discSuffix + "_1"); - faceVtk.write(baseName + "_face" + discSuffix + rankSuffix + "_1", Dune::VTK::ascii); + + if constexpr (GridGeometry::discMethod != DiscretizationMethods::pq1bubble) + faceVtk.write(baseName + "_face" + discSuffix + rankSuffix + "_1", Dune::VTK::ascii); Dumux::printErrors(problem, *gridVariables, x); diff --git a/test/freeflow/navierstokes/donea/params.input b/test/freeflow/navierstokes/donea/params.input index 20acc796b968ed3fbe3d5e33e068b0c0e8d05ff8..2ac7412c79e4a877608ed3c31a30bdb0817fb424 100644 --- a/test/freeflow/navierstokes/donea/params.input +++ b/test/freeflow/navierstokes/donea/params.input @@ -11,6 +11,7 @@ Name = test_donea EnableGravity = false EnableInertiaTerms = false UseNeumann = true +PrintErrors = true [Component] LiquidDensity = 1.0 @@ -21,15 +22,15 @@ MaxSteps = 10 MaxRelativeShift = 1e-8 [LinearSolver] -Type = cgsolver -ResidualReduction = 1e-13 +Type = bicgstabsolver +ResidualReduction = 1e-15 [LinearSolver.Preconditioner] -Type = amg +Type = ilu AmgAccumulationMode = atOnce [Assembly] -NumericDifference.BaseEpsilon = 1e-8 +NumericDifference.BaseEpsilon = 1e-1 [SpatialParams] Temperature = 298.0 diff --git a/test/freeflow/navierstokes/donea/properties_momentum.hh b/test/freeflow/navierstokes/donea/properties_momentum.hh index 8636e91f2dc60c4c0a80d4fe087c158972d6f7bb..17455be6048b474b14e08cf1852d07431660c3c2 100644 --- a/test/freeflow/navierstokes/donea/properties_momentum.hh +++ b/test/freeflow/navierstokes/donea/properties_momentum.hh @@ -54,6 +54,9 @@ #include #include +#include +#include + #include "problem.hh" namespace Dumux::Properties { diff --git a/test/freeflow/navierstokes/errors.hh b/test/freeflow/navierstokes/errors.hh index f8a0295838a9a024ca567802b23a5771016e3ea3..90c15ef13e496172e707fc3a329fc09a499a799e 100644 --- a/test/freeflow/navierstokes/errors.hh +++ b/test/freeflow/navierstokes/errors.hh @@ -349,6 +349,9 @@ public: //! Volume of domain Scalar totalVolume() const { return totalVolume_; } + //! Number of scvs that have been considered in error calculation + Scalar numDofs() const { return numDofs_; } + private: template void calculateErrors_(const SolutionVector& curSol, Scalar time) @@ -359,6 +362,12 @@ private: // calculate helping variables totalVolume_ = 0.0; hMax_ = 0.0; + numDofs_ = problem_->gridGeometry().numDofs(); + + using GridGeometry = std::decay_t().gridGeometry())>; + // We do not consider the overlapping Dofs, i.e. elements, in the errors + if constexpr (GridGeometry::discMethod == DiscretizationMethods::pq1bubble) + numDofs_ -= problem_->gridGeometry().gridView().size(0); ErrorVector sumReference(0.0); ErrorVector sumError(0.0); @@ -374,15 +383,14 @@ private: fvGeometry.bindElement(element); for (const auto& scv : scvs(fvGeometry)) { - using GridGeometry = std::decay_t().gridGeometry())>; using Extrusion = Extrusion_t; - totalVolume_ += Extrusion::volume(fvGeometry, scv); // velocity errors if constexpr (isMomentumProblem) { if constexpr (GridGeometry::discMethod == DiscretizationMethods::fcstaggered) { + totalVolume_ += Extrusion::volume(fvGeometry, scv); // compute the velocity errors using Indices = typename Problem::Indices; const auto velIdx = Indices::velocity(scv.dofAxis()); @@ -399,8 +407,9 @@ private: sumError[velIdx] += vError * vError * Extrusion::volume(fvGeometry, scv); sumReference[velIdx] += vReference * vReference * Extrusion::volume(fvGeometry, scv); } - else if (GridGeometry::discMethod == DiscretizationMethods::fcdiamond) + else if constexpr (GridGeometry::discMethod == DiscretizationMethods::fcdiamond) { + totalVolume_ += Extrusion::volume(fvGeometry, scv); for (int dirIdx = 0; dirIdx < dim; ++dirIdx) { const auto analyticalSolution @@ -417,10 +426,36 @@ private: sumReference[dirIdx] += vReference * vReference * Extrusion::volume(fvGeometry, scv); } } + else if constexpr (GridGeometry::discMethod == DiscretizationMethods::pq1bubble) + { + if(!scv.isOverlapping()) + { + totalVolume_ += Extrusion::volume(fvGeometry, scv); + for (int dirIdx = 0; dirIdx < dim; ++dirIdx) + { + const auto analyticalSolution + = problem_->analyticalSolution(scv.dofPosition(), time)[dirIdx]; + const auto numericalSolution + = curSol[scv.dofIndex()][dirIdx]; + + const Scalar vError = absDiff_(analyticalSolution, numericalSolution); + const Scalar vReference = absDiff_(analyticalSolution, 0.0); + + maxError[dirIdx] = std::max(maxError[dirIdx], vError); + maxReference[dirIdx] = std::max(maxReference[dirIdx], vReference); + sumError[dirIdx] += vError * vError * Extrusion::volume(fvGeometry, scv); + sumReference[dirIdx] += vReference * vReference * Extrusion::volume(fvGeometry, scv); + } + } + } + else + DUNE_THROW(Dune::InvalidStateException, + "Unknown momentum discretization scheme in Navier-Stokes error calculation"); } // pressure errors else { + totalVolume_ += Extrusion::volume(fvGeometry, scv); // compute the pressure errors using Indices = typename Problem::Indices; const auto analyticalSolution @@ -462,6 +497,7 @@ private: Scalar time_; Scalar hMax_; Scalar totalVolume_; + std::size_t numDofs_; }; /*! @@ -474,6 +510,7 @@ class Errors = std::decay_t().gridGeometry())>::GridView::dimension; using ErrorVector = Dune::FieldVector; + using NumSubProblemVector = Dune::FieldVector; public: template @@ -519,8 +556,12 @@ public: std::copy( lInfAbsoluteMomentum.begin(), lInfAbsoluteMomentum.end(), lInfAbsolute_.begin() + 1 ); std::copy( lInfRelativeMomentum.begin(), lInfRelativeMomentum.end(), lInfRelative_.begin() + 1 ); - hMax_ = massErrors_.hMax(); - totalVolume_ = massErrors_.totalVolume(); + hMax_[0] = massErrors_.hMax(); + totalVolume_[0] = massErrors_.totalVolume(); + numDofs_[0] = massErrors_.numDofs(); + hMax_[1] = momentumErrors_.hMax(); + totalVolume_[1] = momentumErrors_.totalVolume(); + numDofs_[1] = momentumErrors_.numDofs(); } //! The (absolute) discrete l2 error @@ -532,14 +573,15 @@ public: //! The relative discrete l-infinity error (relative to the discrete loo norm of the reference solution) const ErrorVector& lInfRelative() const { return lInfRelative_; } - //! Time corresponding to the error (returns 0 per default) - Scalar time() const { return time_; } - + //! Volume of scvs considered in error calculation + const NumSubProblemVector& totalVolume() const { return totalVolume_; } + //! Number of scvs considered in error calculation + const NumSubProblemVector& numDofs() const { return numDofs_; } //! Maximum diameter of primal grid elements - Scalar hMax() const { return hMax_; } + const NumSubProblemVector& hMax() const { return hMax_; } - //! Volume of domain - Scalar totalVolume() const { return totalVolume_; } + //! Time corresponding to the error (returns 0 per default) + Scalar time() const { return time_; } private: ErrorsSubProblem momentumErrors_; @@ -550,9 +592,11 @@ private: ErrorVector lInfAbsolute_; ErrorVector lInfRelative_; + NumSubProblemVector hMax_; + NumSubProblemVector totalVolume_; + NumSubProblemVector numDofs_; + Scalar time_; - Scalar hMax_; - Scalar totalVolume_; }; template diff --git a/test/freeflow/navierstokes/kovasznay/main.cc b/test/freeflow/navierstokes/kovasznay/main.cc index ae9095502a79bd203d4722b8bc989b3cb1c9addc..3aee4a5e28949f9963294a956514d8741c7819a3 100644 --- a/test/freeflow/navierstokes/kovasznay/main.cc +++ b/test/freeflow/navierstokes/kovasznay/main.cc @@ -134,7 +134,7 @@ int main(int argc, char** argv) NavierStokesAnalyticalSolutionVectors analyticalSolVectors(problem); vtkWriter.addField(analyticalSolVectors.getAnalyticalPressureSolution(), "pressureExact"); vtkWriter.addField(analyticalSolVectors.getAnalyticalVelocitySolution(), "velocityExact"); - vtkWriter.addFaceField(analyticalSolVectors.getAnalyticalVelocitySolutionOnFace(), "faceVelocityExact"); + vtkWriter.addFaceField(analyticalSolVectors.getAnalyticalVelocitySolutionAtDofs(), "faceVelocityExact"); vtkWriter.write(0.0); diff --git a/test/freeflow/navierstokes/unstructured/CMakeLists.txt b/test/freeflow/navierstokes/unstructured/CMakeLists.txt index 9950e7cb34f5448189a561b347b5a76a60ac04e7..70b56252e0326d197a5b358bd986d24091331f83 100644 --- a/test/freeflow/navierstokes/unstructured/CMakeLists.txt +++ b/test/freeflow/navierstokes/unstructured/CMakeLists.txt @@ -1,25 +1,81 @@ dune_symlink_to_source_files(FILES params.input cylinder_channel.msh cylinder_channel_quad.msh) # Navier-Stokes version of the test (Re=20) -dumux_add_test(NAME test_ff_navierstokes_dfg_benchmark_stationary +dumux_add_test(NAME test_ff_navierstokes_dfg_benchmark_stationary_diamond SOURCES main.cc + COMPILE_DEFINITIONS TYPETAG_MOMENTUM=DFGChannelTestMomentumDiamond + COMPILE_DEFINITIONS TYPETAG_MASS=DFGChannelTestMassTpfa LABELS freeflow navierstokes CMAKE_GUARD "( HAVE_UMFPACK AND dune-uggrid_FOUND )" COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py CMD_ARGS --script fuzzy - --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_navierstokes_dfg_benchmark_stationary.vtu - ${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_dfg_benchmark_stationary-00001.vtu - --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_dfg_benchmark_stationary params.input - -Problem.Name test_ff_navierstokes_dfg_benchmark_stationary -Problem.EnableInertiaTerms true") + --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_navierstokes_dfg_benchmark_stationary_diamond.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_dfg_benchmark_stationary_diamond-00001.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_dfg_benchmark_stationary_diamond params.input + -Problem.Name test_ff_navierstokes_dfg_benchmark_stationary_diamond -Problem.EnableInertiaTerms true") # Stokes version of the test (no inertia) -dumux_add_test(NAME test_ff_stokes_dfg_benchmark_stationary - TARGET test_ff_navierstokes_dfg_benchmark_stationary +dumux_add_test(NAME test_ff_stokes_dfg_benchmark_stationary_diamond + TARGET test_ff_navierstokes_dfg_benchmark_stationary_diamond LABELS freeflow navierstokes CMAKE_GUARD "( HAVE_UMFPACK AND dune-uggrid_FOUND )" COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py CMD_ARGS --script fuzzy - --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_stokes_dfg_benchmark_stationary.vtu - ${CMAKE_CURRENT_BINARY_DIR}/test_ff_stokes_dfg_benchmark_stationary-00001.vtu - --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_dfg_benchmark_stationary params.input - -Problem.Name test_ff_stokes_dfg_benchmark_stationary -Problem.EnableInertiaTerms false") + --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_stokes_dfg_benchmark_stationary_diamond.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_ff_stokes_dfg_benchmark_stationary_diamond-00001.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_dfg_benchmark_stationary_diamond params.input + -Problem.Name test_ff_stokes_dfg_benchmark_stationary_diamond -Problem.EnableInertiaTerms false") + +# Navier-Stokes version of the test (Re=20) +dumux_add_test(NAME test_ff_navierstokes_dfg_benchmark_stationary_pq1bubble_box + SOURCES main.cc + COMPILE_DEFINITIONS TYPETAG_MOMENTUM=DFGChannelTestMomentumPQ1Bubble + COMPILE_DEFINITIONS TYPETAG_MASS=DFGChannelTestMassBox + LABELS freeflow navierstokes + CMAKE_GUARD "( HAVE_UMFPACK AND dune-uggrid_FOUND )" + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_navierstokes_dfg_benchmark_stationary_pq1bubble_box.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_dfg_benchmark_stationary_pq1bubble_box-00001.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_dfg_benchmark_stationary_pq1bubble_box params.input + -Problem.Name test_ff_navierstokes_dfg_benchmark_stationary_pq1bubble_box -Problem.EnableInertiaTerms true") + +# Stokes version of the test (no inertia) +dumux_add_test(NAME test_ff_stokes_dfg_benchmark_stationary_pq1bubble_box + TARGET test_ff_navierstokes_dfg_benchmark_stationary_pq1bubble_box + LABELS freeflow navierstokes + CMAKE_GUARD "( HAVE_UMFPACK AND dune-uggrid_FOUND )" + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_stokes_dfg_benchmark_stationary_pq1bubble_box.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_ff_stokes_dfg_benchmark_stationary_pq1bubble_box-00001.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_dfg_benchmark_stationary_pq1bubble_box params.input + -Problem.Name test_ff_stokes_dfg_benchmark_stationary_pq1bubble_box -Problem.EnableInertiaTerms false") + +# Navier-Stokes version of the test (Re=20) +dumux_add_test(NAME test_ff_navierstokes_dfg_benchmark_stationary_pq1bubble_diamond + SOURCES main.cc + COMPILE_DEFINITIONS TYPETAG_MOMENTUM=DFGChannelTestMomentumPQ1Bubble + COMPILE_DEFINITIONS TYPETAG_MASS=DFGChannelTestMassDiamond + LABELS freeflow navierstokes + CMAKE_GUARD "( HAVE_UMFPACK AND dune-uggrid_FOUND )" + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_navierstokes_dfg_benchmark_stationary_pq1bubble_diamond.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_dfg_benchmark_stationary_pq1bubble_diamond-00001.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_dfg_benchmark_stationary_pq1bubble_diamond params.input + -Problem.Name test_ff_navierstokes_dfg_benchmark_stationary_pq1bubble_diamond -Problem.EnableInertiaTerms true + -Grid.File cylinder_channel_quad.msh") + +# Stokes version of the test (no inertia) +dumux_add_test(NAME test_ff_stokes_dfg_benchmark_stationary_pq1bubble_diamond + TARGET test_ff_navierstokes_dfg_benchmark_stationary_pq1bubble_diamond + LABELS freeflow navierstokes + CMAKE_GUARD "( HAVE_UMFPACK AND dune-uggrid_FOUND )" + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_stokes_dfg_benchmark_stationary_pq1bubble_diamond.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_ff_stokes_dfg_benchmark_stationary_pq1bubble_diamond-00001.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_dfg_benchmark_stationary_pq1bubble_diamond params.input + -Problem.Name test_ff_stokes_dfg_benchmark_stationary_pq1bubble_diamond -Problem.EnableInertiaTerms false + -Grid.File cylinder_channel_quad.msh") diff --git a/test/freeflow/navierstokes/unstructured/main.cc b/test/freeflow/navierstokes/unstructured/main.cc index 521b79b4da857beece5367cfc036565a0a3c3fd1..495baf0fddff5bca8c63df5c25afe0534374427f 100644 --- a/test/freeflow/navierstokes/unstructured/main.cc +++ b/test/freeflow/navierstokes/unstructured/main.cc @@ -48,8 +48,8 @@ int main(int argc, char** argv) using namespace Dumux; // define the type tag for this problem - using MomentumTypeTag = Properties::TTag::DFGChannelTestMomentum; - using MassTypeTag = Properties::TTag::DFGChannelTestMass; + using MomentumTypeTag = Properties::TTag::TYPETAG_MOMENTUM; + using MassTypeTag = Properties::TTag::TYPETAG_MASS; // initialize MPI, finalize is done automatically on exit initialize(argc, argv); @@ -124,8 +124,10 @@ int main(int argc, char** argv) couplingManager); // initialize the vtk output module + constexpr bool isDiamond = MassGridGeometry::discMethod == DiscretizationMethods::fcdiamond; + const auto mode = isDiamond ? Dune::VTK::nonconforming : Dune::VTK::conforming; using IOFields = GetPropType; - VtkOutputModule vtkWriter(*massGridVariables, x[massIdx], massProblem->name()); + VtkOutputModule vtkWriter(*massGridVariables, x[massIdx], massProblem->name(), "", mode); IOFields::initOutputModule(vtkWriter); // Add model specific output fields vtkWriter.addVelocityOutput(std::make_shared>()); vtkWriter.write(0.0); @@ -149,7 +151,7 @@ int main(int argc, char** argv) static constexpr double cDrafReference = 5.57953523384; static constexpr double cLiftReference = 0.010618948146; static constexpr double pDiffReference = 0.11752016697; - const auto [cDrag, cLift] = momentumProblem->evalDragAndLiftCoefficient(*momentumGridVariables, x[momentumIdx]); + const auto [cDrag, cLift] = momentumProblem->evalDragAndLiftCoefficientWithIntegration(*momentumGridVariables, x[momentumIdx]); std::cout << "cDrag: " << cDrag << " (reference: " << cDrafReference << ")" << "\n" @@ -157,12 +159,13 @@ int main(int argc, char** argv) << " (reference: " << cLiftReference << ")" << std::endl; - const auto pDiff = massProblem->evalPressureDifference(x[massIdx]); + const auto pDiff = massProblem->evalPressureDifference(*massGridVariables, x[massIdx]); std::cout << "pDiff: " << pDiff << " (reference: " << pDiffReference << ")" << std::endl; - if (getParam("Problem.CheckIndicators", true)) + // To be close to the reference values the grid needs to be refined + if (getParam("Problem.CheckIndicators", false)) { using std::abs; if (abs(cDrag - cDrafReference) > 0.002) diff --git a/test/freeflow/navierstokes/unstructured/problem.hh b/test/freeflow/navierstokes/unstructured/problem.hh index 0cf46864f02a8e7a9e7beba97d047b273772ecbf..f056e31fe7986903567aec13086760aca9e9006a 100644 --- a/test/freeflow/navierstokes/unstructured/problem.hh +++ b/test/freeflow/navierstokes/unstructured/problem.hh @@ -30,6 +30,8 @@ #include #include #include +#include +#include namespace Dumux { @@ -81,19 +83,17 @@ public: /*! * \brief Specifies which kind of boundary condition should be - * used for which equation on a given boundary segment. + * used for which equation on a given boundary control volume. * - * \param element The finite element - * \param scvf The sub control volume face + * \param globalPos The position of the center of the finite volume */ - BoundaryTypes boundaryTypes(const Element& element, - const SubControlVolumeFace& scvf) const + BoundaryTypes boundaryTypesAtPos(const GlobalPosition& globalPos) const { BoundaryTypes values; if constexpr (ParentType::isMomentumProblem()) { - if (isOutlet_(scvf)) + if (isOutlet_(globalPos)) values.setAllNeumann(); else values.setAllDirichlet(); @@ -136,10 +136,11 @@ public: { if (this->enableInertiaTerms()) { - if (isOutlet_(scvf)) + if (isOutlet_(scvf.ipGlobal())) { // advective term: vv*n - const auto v = elemVolVars[scvf.insideScvIdx()].velocity(); + const auto elemSol = elementSolution(element, elemVolVars, fvGeometry); + const auto v = evalSolution(element, element.geometry(), fvGeometry.gridGeometry(), elemSol, scvf.ipGlobal()); values.axpy(density_*(v*scvf.unitOuterNormal()), v); } } @@ -173,29 +174,32 @@ public: //! Computes pressure difference benchmark indicator //! (only works for correct domain size 2.2 x 0.41 and boundary conditions, Re=20) - template = 0> - Scalar evalPressureDifference(const SolutionVector& p) const + template = 0> + Scalar evalPressureDifference(const GridVariables& gridVariables, const SolutionVector& p) const { - const auto& tree = this->gridGeometry().boundingBoxTree(); + const auto& gg = gridVariables.gridGeometry(); + const auto& tree = gg.boundingBoxTree(); GlobalPosition evalPoint1({0.15, 0.2}); GlobalPosition evalPoint2({0.25, 0.2}); const Scalar stepSize = 0.001; - auto entities1 = intersectingEntities(evalPoint1, tree); - while (entities1.empty()) - { - evalPoint1[0] -= stepSize; - entities1 = intersectingEntities(evalPoint1, tree); - } - auto entities2 = intersectingEntities(evalPoint2, tree); - while (entities2.empty()) + + const auto evalPressure = [&](auto pos, bool backwards) { - evalPoint2[0] += stepSize; - entities2 = intersectingEntities(evalPoint2, tree); - } + auto entities = intersectingEntities(pos, tree); + while (entities.empty()) + { + pos[0] += backwards ? -stepSize : stepSize; + entities = intersectingEntities(pos, tree); + } - const auto p1 = p[entities1[0]][0]; - const auto p2 = p[entities2[0]][0]; - return p1 - p2; + const auto element = gg.element(entities[0]); + const auto fvGeometry = localView(gg).bindElement(element); + const auto elemVolVars = localView(gridVariables.curGridVolVars()).bindElement(element, fvGeometry, p); + const auto elemSol = elementSolution(element, elemVolVars, fvGeometry); + return evalSolution(element, element.geometry(), fvGeometry.gridGeometry(), elemSol, pos); + }; + + return evalPressure(evalPoint1, true) - evalPressure(evalPoint2, false); } //! Computes drag and lift coefficient benchmark indicator @@ -230,6 +234,93 @@ public: stress[dir].axpy(velocity[dir], fluxVarCache.gradN(scv.indexInElement())); } + stress *= viscosity_; + + for (int dir = 0; dir < dim; ++dir) + stress[dir][dir] -= this->pressure(element, fvGeometry, scvf); + + BoundaryFluxes normalStress = mv(stress, scvf.unitOuterNormal()); + forces.axpy(scvf.area(), normalStress); + + cylinderSurface += scvf.area(); + } + } + } + } + + const Scalar dragForce = -forces[0]; + const Scalar liftForce = -forces[1]; + + const Scalar uMean = 0.2; + const Scalar lChar = 0.1; + const Scalar coefficientFactor = 2.0/(uMean*uMean*lChar); + + // sanity check + std::cout << "Reynolds number: " << uMean*lChar/viscosity_ << std::endl; + std::cout << "Cylinder surface: " << cylinderSurface + << " (reference: 0.31415926535)" + << std::endl; + + return std::make_pair( coefficientFactor*dragForce, coefficientFactor*liftForce ); + } + + //! Computes drag and lift coefficient benchmark indicator + //! (only works for correct domain size 2.2 x 0.41 and boundary conditions, Re=20) + template = 0> + auto evalDragAndLiftCoefficientWithoutBubble(const GridVariables& gridVariables, const SolutionVector& v) const + { + auto fvGeometry = localView(this->gridGeometry()); + auto elemVolVars = localView(gridVariables.curGridVolVars()); + auto elemFluxVarsCache = localView(gridVariables.gridFluxVarsCache()); + + BoundaryFluxes forces(0.0); + Scalar cylinderSurface = 0.0; + for (const auto& element : elements(this->gridGeometry().gridView())) + { + fvGeometry.bind(element); + if (fvGeometry.hasBoundaryScvf()) + { + for (const auto& scvf : scvfs(fvGeometry)) + { + if (scvf.boundary() && onCylinderBoundary_(scvf.ipGlobal())) + { + using CoordScalar = typename Element::Geometry::GlobalCoordinate::value_type; + using P1FiniteElement = Dune::LagrangeCubeLocalFiniteElement; + P1FiniteElement p1FiniteElement; + + elemVolVars.bind(element, fvGeometry, v); + const auto& localBasis = p1FiniteElement.localBasis(); + + const auto geometry = element.geometry(); + Dune::FieldMatrix stress(0.0); + using FeLocalBasis = typename GridGeometry::FeCache::FiniteElementType::Traits::LocalBasisType; + using ShapeJacobian = typename FeLocalBasis::Traits::JacobianType; + using ShapeValue = typename Dune::FieldVector; + using JacobianInverseTransposed = typename Element::Geometry::JacobianInverseTransposed; + std::vector gradN; + std::vector shapeJacobian; + std::vector shapeValues; + const auto ipGlobal = scvf.ipGlobal(); + const auto ipLocal = geometry.local(ipGlobal); + JacobianInverseTransposed jacInvT = geometry.jacobianInverseTransposed(ipLocal); + localBasis.evaluateJacobian(ipLocal, shapeJacobian); + localBasis.evaluateFunction(ipLocal, shapeValues); + + shapeJacobian.push_back(ShapeJacobian(0.0)); + shapeValues.push_back(ShapeValue(0.0)); + + // compute the gradN at for every scv/dof + gradN.resize(fvGeometry.numScv()); + for (const auto& scv: scvs(fvGeometry)) + jacInvT.mv(shapeJacobian[scv.localDofIndex()][0], gradN[scv.indexInElement()]); + + for (const auto& scv : scvs(fvGeometry)) + { + const auto velocity = elemVolVars[scv].velocity(); + for (int dir = 0; dir < dim; ++dir) + stress[dir].axpy(velocity[dir], gradN[scv.indexInElement()]); + } + stress += getTransposed(stress); stress *= viscosity_; @@ -261,12 +352,104 @@ public: return std::make_pair( coefficientFactor*dragForce, coefficientFactor*liftForce ); } + //! Computes drag and lift coefficient benchmark indicator + //! (only works for correct domain size 2.2 x 0.41 and boundary conditions, Re=20) + template = 0> + auto evalDragAndLiftCoefficientWithIntegration(const GridVariables& gridVariables, const SolutionVector& v) const + { + auto fvGeometry = localView(this->gridGeometry()); + auto elemVolVars = localView(gridVariables.curGridVolVars()); + + BoundaryFluxes forces(0.0); + Scalar cylinderSurface = 0.0; + for (const auto& element : elements(this->gridGeometry().gridView())) + { + fvGeometry.bind(element); + if (fvGeometry.hasBoundaryScvf()) + { + for (const auto& scvf : scvfs(fvGeometry)) + { + if (scvf.boundary() && onCylinderBoundary_(scvf.ipGlobal())) + { + elemVolVars.bind(element, fvGeometry, v); + Dune::FieldMatrix stress(0.0); + const auto& localBasis = fvGeometry.feLocalBasis(); + Scalar area = 0.0; + + const auto geometry = element.geometry(); + const auto isgeometry = fvGeometry.geometry(scvf); + const auto& quad = Dune::QuadratureRules::mydimension>::rule(isgeometry.type(), 5); + for (auto&& qp : quad) + { + Dune::FieldMatrix stressLocal(0.0); + using FeLocalBasis = typename GridGeometry::FeCache::FiniteElementType::Traits::LocalBasisType; + using ShapeJacobian = typename FeLocalBasis::Traits::JacobianType; + using ShapeValue = typename Dune::FieldVector; + using JacobianInverseTransposed = typename Element::Geometry::JacobianInverseTransposed; + std::vector gradN; + std::vector shapeJacobian; + std::vector shapeValues; + const auto ipGlobal = isgeometry.global(qp.position()); + const auto ipLocal = geometry.local(ipGlobal); + JacobianInverseTransposed jacInvT = geometry.jacobianInverseTransposed(ipLocal); + localBasis.evaluateJacobian(ipLocal, shapeJacobian); + localBasis.evaluateFunction(ipLocal, shapeValues); + + // compute the gradN at for every scv/dof + gradN.resize(fvGeometry.numScv()); + for (const auto& scv: scvs(fvGeometry)) + jacInvT.mv(shapeJacobian[scv.localDofIndex()][0], gradN[scv.indexInElement()]); + + for (const auto& scv : scvs(fvGeometry)) + { + const auto velocity = elemVolVars[scv].velocity(); + for (int dir = 0; dir < dim; ++dir) + stressLocal[dir].axpy(velocity[dir], gradN[scv.indexInElement()]); + } + area += qp.weight()*isgeometry.integrationElement(qp.position()); + stressLocal += getTransposed(stressLocal); + stressLocal *= qp.weight()*isgeometry.integrationElement(qp.position()); + + stress += stressLocal; + } + stress *= viscosity_; + stress /= scvf.area(); + + // Add pressure contribuition + for (int dir = 0; dir < dim; ++dir) + stress[dir][dir] -= this->pressure(element, fvGeometry, scvf); + + BoundaryFluxes normalStress = mv(stress, scvf.unitOuterNormal()); + forces.axpy(scvf.area(), normalStress); + + cylinderSurface += scvf.area(); + } + } + } + } + + const Scalar dragForce = -forces[0]; + const Scalar liftForce = -forces[1]; + + const Scalar uMean = 0.2; + const Scalar lChar = 0.1; + const Scalar coefficientFactor = 2.0/(uMean*uMean*lChar); + + // sanity check + std::cout << "Reynolds number: " << uMean*lChar/viscosity_ << std::endl; + std::cout << "Cylinder surface: " << cylinderSurface + << " (reference: 0.31415926535)" + << std::endl; + + return std::make_pair( coefficientFactor*dragForce, coefficientFactor*liftForce ); + } + private: - bool isInlet_(const SubControlVolumeFace& scvf) const - { return scvf.ipGlobal()[0] < this->gridGeometry().bBoxMin()[0] + eps_; } + bool isInlet_(const GlobalPosition& globalPos) const + { return globalPos[0] < this->gridGeometry().bBoxMin()[0] + eps_; } - bool isOutlet_(const SubControlVolumeFace& scvf) const - { return scvf.ipGlobal()[0] > this->gridGeometry().bBoxMax()[0] - eps_; } + bool isOutlet_(const GlobalPosition& globalPos) const + { return globalPos[0] > this->gridGeometry().bBoxMax()[0] - eps_; } bool onCylinderBoundary_(const GlobalPosition& globalPos) const { return std::hypot(globalPos[0] - 0.2, globalPos[1] - 0.2) < 0.06; } diff --git a/test/freeflow/navierstokes/unstructured/properties.hh b/test/freeflow/navierstokes/unstructured/properties.hh index 1039c6e28fd4dc52a65747046da97bff005575a1..76e5ecf5c921d3455c9ecc5992d2a1c1f0eb0f51 100644 --- a/test/freeflow/navierstokes/unstructured/properties.hh +++ b/test/freeflow/navierstokes/unstructured/properties.hh @@ -27,9 +27,12 @@ #include #include +#include #include +#include #include +#include #include #include #include @@ -45,8 +48,11 @@ namespace Dumux::Properties { // Create new type tags namespace TTag { struct DFGChannelTest {}; -struct DFGChannelTestMomentum { using InheritsFrom = std::tuple; }; -struct DFGChannelTestMass { using InheritsFrom = std::tuple; }; +struct DFGChannelTestMomentumDiamond { using InheritsFrom = std::tuple; }; +struct DFGChannelTestMomentumPQ1Bubble { using InheritsFrom = std::tuple; }; +struct DFGChannelTestMassTpfa { using InheritsFrom = std::tuple; }; +struct DFGChannelTestMassBox { using InheritsFrom = std::tuple; }; +struct DFGChannelTestMassDiamond { using InheritsFrom = std::tuple; }; } // end namespace TTag // the fluid system @@ -66,11 +72,11 @@ struct Grid // Set the problem property template -struct Problem +struct Problem { using type = DFGChannelTestProblem> ; }; template -struct Problem +struct Problem { using type = DFGChannelTestProblem> ; }; template @@ -83,7 +89,7 @@ struct EnableGridVolumeVariablesCache { static co template struct CouplingManager { - using Traits = MultiDomainTraits; + using Traits = MultiDomainTraits; using type = FreeFlowCouplingManager; }; diff --git a/test/multidomain/boundary/stokesdarcy/1p_1p/convergencetest/main.cc b/test/multidomain/boundary/stokesdarcy/1p_1p/convergencetest/main.cc index 5bac0bcc901dc7034af604db57c7486ebf32363c..c5ebe048fba4ee1d1bd3d62f0362b9aacdfcc916 100644 --- a/test/multidomain/boundary/stokesdarcy/1p_1p/convergencetest/main.cc +++ b/test/multidomain/boundary/stokesdarcy/1p_1p/convergencetest/main.cc @@ -251,7 +251,7 @@ int main(int argc, char** argv) NavierStokesAnalyticalSolutionVectors freeFlowAnalyticalSolVectors(freeFlowProblem); freeFlowVtkWriter.addField(freeFlowAnalyticalSolVectors.getAnalyticalPressureSolution(), "pressureExact"); freeFlowVtkWriter.addField(freeFlowAnalyticalSolVectors.getAnalyticalVelocitySolution(), "velocityExact"); - freeFlowVtkWriter.addFaceField(freeFlowAnalyticalSolVectors.getAnalyticalVelocitySolutionOnFace(), "faceVelocityExact"); + freeFlowVtkWriter.addFaceField(freeFlowAnalyticalSolVectors.getAnalyticalVelocitySolutionAtDofs(), "faceVelocityExact"); freeFlowVtkWriter.write(0.0); diff --git a/test/references/test_ff_navierstokes_dfg_benchmark_stationary.vtu b/test/references/test_ff_navierstokes_dfg_benchmark_stationary_diamond.vtu similarity index 100% rename from test/references/test_ff_navierstokes_dfg_benchmark_stationary.vtu rename to test/references/test_ff_navierstokes_dfg_benchmark_stationary_diamond.vtu diff --git a/test/references/test_ff_navierstokes_dfg_benchmark_stationary_pq1bubble_box.vtu b/test/references/test_ff_navierstokes_dfg_benchmark_stationary_pq1bubble_box.vtu new file mode 100644 index 0000000000000000000000000000000000000000..0f6ec08b28c716577c6b6e52593c250dfd8d76c6 --- /dev/null +++ b/test/references/test_ff_navierstokes_dfg_benchmark_stationary_pq1bubble_box.vtu @@ -0,0 +1,27918 @@ + + + + + + + 0.000107379 0.000242023 9.79375e-05 0.0139009 0.0138208 0.0138926 0.021137 0.0199008 0.0211392 0.020056 0.0204876 0.0196142 + 0.0154526 0.0153205 0.0155261 0.115143 0.111814 0.115788 0.026546 0.0262127 0.0263861 0.0254862 0.0255822 0.0253372 + 0.124396 0.125023 0.123145 0.0146779 0.0150197 0.0147565 0.0813407 0.0838862 0.0873091 0.0138724 0.0135887 0.0138473 + 0.0264074 0.0121653 0.0126047 0.0124583 0.0174628 0.0174784 0.0176661 0.0248515 0.0291379 0.028332 0.0162308 0.0161033 + 0.0163307 0.0252865 0.0790379 0.0784757 0.0790919 0.0303201 0.0304048 0.0304498 0.0263668 0.0275376 0.0218876 0.0297239 + 0.0299562 0.0298818 0.00675974 0.00690423 0.00691468 0.0194939 0.0194092 0.0196183 0.0247481 0.0248536 0.0246357 0.0967241 + 0.099246 0.0957682 0.0595455 0.0590481 0.0589726 0.0140985 0.0142062 0.0143288 0.00674531 0.0142387 0.00593886 0.00607074 + 0.0060643 0.05888 0.0566745 0.0561453 0.00369552 0.00386285 0.00374124 0.0611307 0.061962 0.0620035 0.00017151 0.000115938 + -1.78838e-05 0.00384099 7.27994e-05 0.0302758 0.0139748 0.0651175 0.0638555 0.0629712 0.0140808 0.0135152 0.0692477 0.0737004 + 0.0685123 0.0619538 0.0618885 0.0618352 0.0105683 0.0105465 0.0104261 0.0280463 0.0282453 0.027947 0.0162009 0.00653098 + 0.00653184 0.00636493 0.00138431 0.00127718 0.00120439 0.000219504 7.37923e-05 0.000142005 0.0292055 0.029044 0.0289156 0.00639263 + 0.00896653 0.00847566 0.00817386 0.0252588 0.0252396 0.0245982 0.0250305 0.0255457 0.0254094 0.0270052 0.0271212 0.0272663 + -0.00362886 -0.00275895 -0.00432575 0.0249011 0.025118 0.0249938 0.0541963 0.00561208 0.00517641 0.00631248 0.0154046 0.0151721 + 0.0125378 0.0125438 0.0127115 0.00170533 0.00319803 0.00383808 0.0939923 0.0293768 0.0296511 0.0294603 0.0269375 0.0265508 + 0.0270263 0.0118107 0.0117741 0.0116506 0.0491602 0.0473851 0.0516904 0.0656578 0.0650973 0.0646391 0.0260635 0.0247615 + 0.0260988 0.00749931 0.0075182 0.00767066 -0.00765896 -0.00839335 -0.00633488 0.0251723 0.0223009 0.0275932 0.0273758 0.0274917 + 0.0303488 0.0657348 0.075185 0.0768412 0.0756244 0.0612312 0.0594344 0.0122302 0.116206 0.119249 0.118995 0.00551437 + 0.00566774 0.0056509 0.0262383 0.0261037 0.0261783 0.0278466 0.0281125 0.00183608 0.00197219 0.00194148 -0.00936979 -0.00915765 + -0.010546 0.0303377 0.0301923 0.0303575 0.105019 0.101335 0.10265 0.0379842 0.0372357 0.0386709 0.0295154 0.0291802 + 0.0293462 0.00390006 0.00402518 0.00388149 0.0265273 0.0264886 0.0265694 0.017769 0.0233471 0.0196788 0.0118302 0.0117943 + 0.012695 0.0132079 0.0128361 0.0278565 0.0642506 0.0261695 0.0261154 0.0262173 -0.00746901 -0.00846127 -0.00685019 0.0262606 + 0.0260855 0.0636361 0.0617659 0.0609728 0.0152704 0.0138876 0.0138437 0.0119738 0.00284442 0.00300864 0.00299799 0.125912 + 0.0281279 0.0286333 0.0282584 0.00469738 0.00451685 0.00460278 0.0299012 0.0296701 0.0297003 0.0151095 0.0095564 0.00941124 + 0.0095518 0.021478 0.0215761 0.0216746 0.00102463 0.00088267 0.00102639 0.00400581 0.016291 0.0184467 0.0158555 0.0129995 + 0.0129305 0.0128233 0.0128852 -0.0107169 0.00619672 0.00633393 0.00617905 0.0506335 0.0510822 0.0519518 0.000237965 0.00916322 + 0.00124759 3.71056e-05 -0.00226509 0.00628677 0.0424095 0.0425398 0.0409801 0.0127204 0.0114469 0.0118231 0.0138733 0.0137581 + 0.0139826 0.0150815 0.0148889 0.0149974 -0.0015332 -0.00106853 -0.00252185 0.111469 0.114813 0.1158 0.0795682 0.00571192 + 0.0301953 0.0929891 0.0940877 0.0965808 0.049883 0.0138548 0.0128726 0.012991 0.0130473 0.00335135 0.00348365 0.0033378 + 0.0256379 0.024339 0.0242386 0.0148953 0.0135303 0.0134242 0.0133046 0.0959908 0.0615493 0.061679 0.0248832 0.0133778 + 0.0224224 0.0223265 0.0221775 0.0287564 0.000405142 0.000369742 0.000241664 0.00346102 0.00233327 0.00286295 0.00177014 0.0176954 + 0.0175636 0.0177532 0.0368422 0.0416495 0.042118 -0.00210524 0.0224612 0.0226422 0.0226078 0.00511931 0.00526036 0.00524299 + 0.0123085 0.0122018 0.01238 0.0771017 0.00963 0.0096269 0.00980092 0.00123042 0.00122562 0.00113092 0.00888693 0.00919792 + 0.00777616 0.100945 0.103926 0.104948 0.0130603 0.0182534 0.0182365 0.0180821 0.023964 0.0241578 0.0240001 0.0173231 + 0.0402455 0.0388795 0.0426929 0.0154414 0.0152618 0.0154423 0.0113378 0.0113745 0.0112254 0.0114601 0.0297024 0.0295399 + 0.0293591 0.010722 0.0106176 0.0113065 0.0168375 0.017055 0.0176752 0.0601109 0.0602643 -0.00496977 -0.00364897 -0.00342486 + 0.00551836 0.00538787 0.0053505 0.073601 0.0747351 0.0720276 0.0152952 0.000283264 0.000255784 0.000139072 0.0158734 0.0156533 + 0.0154372 0.0217885 0.0222768 0.0214298 0.0294107 0.0252331 0.00554382 0.0254573 0.0258248 0.0252292 0.0200248 0.0200167 + 0.0202097 0.0268361 0.0267208 0.0267449 0.00579753 0.00591879 0.0953999 0.10043 0.0961313 0.120086 0.115748 0.117582 + 0.0283172 0.00350211 -0.000140407 0.00223627 0.121639 0.00577772 0.0279631 0.027743 0.0280637 0.0116151 0.0974311 0.093643 + 0.0964268 0.0732698 0.0749853 0.0737796 -0.00158984 -0.000359629 -0.000572244 0.0947892 0.113372 0.0129722 0.0222641 0.0187558 + 0.0188475 0.018648 0.0221572 0.0220319 0.0222203 0.0287218 -0.00447652 -0.00258799 -0.00444435 0.0437074 0.0413632 0.0427759 + 0.00738821 0.0270712 0.0284013 0.0311507 0.101311 0.0979193 0.000343801 0.000330486 0.00021417 0.0210062 0.014583 0.0147515 + 0.0147444 0.0106944 0.0102176 0.0109179 0.0119622 0.0117776 0.00184182 0.00181279 0.0016994 0.024636 0.0247564 0.0247533 + 0.0275032 0.0272633 0.0273118 0.013881 0.0297312 0.0139947 0.0208521 0.109654 0.0303217 0.0331246 0.0306169 0.0990521 + 0.019766 0.0202852 0.0194925 0.0406507 0.0145263 0.0144938 0.0143664 0.00308521 0.0722262 0.0708145 0.0719744 0.0160304 + 0.0160937 0.0162498 0.0178279 0.0177292 0.0176245 0.0131092 0.0135612 0.0132774 0.076672 0.0170667 0.0171423 0.0169415 + 0.013665 0.0136074 0.0134947 0.0154737 0.0158626 0.0159638 0.00901146 0.0089002 0.00889762 0.00875056 0.0234137 0.0239639 + 0.0226509 0.0786624 0.0273756 0.0272593 0.0271561 0.0656044 0.0699272 0.0723263 0.0260561 0.0127829 0.0107832 0.0123487 + 0.0730346 0.0696749 0.0672452 0.0252762 0.0267246 0.025618 0.00550425 0.00538043 0.0223878 0.00819749 0.00808713 0.00823862 + 0.0122661 0.0103482 0.0104686 0.0103494 0.0102053 0.0278017 0.0281295 0.0280028 0.00981485 0.0646412 0.0651265 0.0645307 + 0.0184707 0.0179202 0.0121012 0.0119272 0.0119664 0.0239987 0.0244136 0.0246404 0.0645342 0.0634465 0.0666255 0.0655057 + 0.121461 0.121287 0.030198 0.018007 0.0213144 0.0168554 0.0237875 0.0235995 0.0236975 0.0108991 0.0109323 0.0107813 + 0.070948 0.0707446 0.0727202 0.0282359 0.0284461 0.00880835 0.00797964 0.0173986 0.018374 0.0168523 0.026724 0.0266209 + 0.0266804 0.0815139 0.0788892 0.0803542 0.00319539 0.00330312 0.00335017 0.00090367 0.0110029 0.0284369 0.0286005 0.0286913 + 0.0947084 0.0953596 0.0972446 0.0163424 0.01625 0.0119483 0.012622 0.01281 0.0274332 0.00536001 0.00945947 0.00682844 + 0.0394455 0.0824962 0.0036726 0.00352284 0.00358693 0.0173144 0.01793 0.0173576 0.02334 0.0239466 0.023068 0.00919254 + 0.00912424 0.00929242 0.020952 0.0212626 0.0276772 0.00429547 0.00444705 0.00442118 -0.0108329 0.0334896 0.0352876 0.0354863 + 0.0160984 0.0129251 0.0130075 0.012824 0.0075296 0.00737456 0.00754403 0.00425566 0.00400662 0.0230145 0.0226282 0.0231472 + 0.022781 0.0731424 0.0748619 0.0728454 0.0106492 0.0113208 0.0202355 0.0300731 0.0775775 0.0784773 0.0787146 0.0179659 + 0.0159862 0.0165444 0.0160132 -0.00468697 0.0121715 0.0120542 0.0122121 0.0309062 0.0305405 0.0302123 0.00545043 0.00534175 + 0.00548524 0.0359755 0.0586766 0.0594359 0.0601207 0.00328574 0.00939858 0.0119947 0.0113825 0.0114652 0.0115511 0.0176625 + 0.0520779 0.0503738 0.0514591 0.0204372 0.0241263 0.0217485 0.0139902 0.0144776 0.0141781 -0.0100778 -0.0110574 -0.0114578 + 0.0597041 0.0403237 0.041837 0.0433761 0.0207262 0.0204932 0.020684 0.0295517 0.0778082 0.0205581 0.0557964 0.0566308 + 0.0569017 0.00523772 0.00503163 0.0274242 0.0276247 0.0277372 0.0278209 0.00182406 0.0186647 0.0187562 0.0185905 0.0292656 + 0.0278228 0.00495286 0.00510278 0.0148162 0.0148263 0.0149844 0.027311 0.0270387 0.0271338 0.0233858 0.0235135 0.0724196 + 0.0233169 0.0147013 0.0109171 0.00766272 0.0077302 0.00756068 0.0259386 0.0260067 0.0254401 0.0184709 0.00496346 0.116499 + 0.0250475 0.0274454 0.0746697 0.0596235 0.00612526 0.00665337 0.00462738 0.0241953 0.0246573 0.017268 0.0142776 0.0144407 + 0.0144401 0.0711719 0.0690285 0.070338 -0.00342307 -0.00402945 -0.00218414 0.0635768 0.0636052 0.0629567 0.0637711 0.0636374 + 0.0202162 0.0219989 0.0011072 0.000959877 0.000945208 0.00437625 0.0269551 0.0270003 0.0268158 0.0123339 0.00528635 0.0576162 + 0.0197177 0.0121386 0.0298598 0.0296652 0.0809504 0.084151 0.0787856 0.0221326 0.0203076 0.0212112 0.0123421 0.0124097 + 0.0122271 0.00136426 0.0352697 0.0352882 0.0363952 0.0503327 0.0444863 0.0481835 0.0278596 0.0276687 0.027664 0.0295406 + 0.0123446 0.0126806 0.0122362 0.0128226 0.013071 0.0127124 0.0332543 0.0325643 0.031957 0.107242 0.104485 0.106782 + -0.00527691 -0.00592738 7.91704e-05 0.000207528 8.49995e-05 0.0156969 0.0122201 0.0171987 0.0242744 0.0251076 0.0621047 0.0679631 + 0.0188629 0.0243358 0.0241326 0.0242158 0.0224392 0.0232185 0.0231686 0.0104874 0.0763475 0.0105267 0.00986392 0.0100766 + 0.0313644 0.0995396 0.0976671 0.100598 0.0204269 0.0200049 0.0196884 0.0104667 0.0107757 0.00983299 0.00704821 0.00527865 + 0.0189183 0.0217511 0.00635531 0.0233872 0.0334141 0.0234027 0.0289819 0.0272043 0.0361778 0.0348705 0.0364144 0.00332917 + 0.0031585 0.0032417 0.0027772 0.00285767 0.00270932 0.0274248 0.00838452 0.0226106 0.0230748 0.022227 0.0442709 0.0750807 + 0.0105714 0.0224213 0.083018 0.0881704 0.0828354 0.0268766 0.0267374 0.0268718 0.028563 0.0287299 0.0241521 0.0152942 + 0.00574039 0.029362 0.0278212 0.0130322 -0.00562469 -0.00278079 -0.0040608 0.0249101 0.0877549 0.0898673 0.0283431 0.02817 + 0.0278631 0.0132903 0.0349167 0.00110781 0.0153953 0.0156583 0.00524782 0.00563967 0.00476758 0.0302651 0.0719 0.0777854 + 0.0732782 0.0271183 0.0269406 0.0271133 0.0246729 0.0266293 0.0618767 0.0612158 0.0611552 -0.00106334 0.00536848 0.026185 + 0.0262732 0.026172 0.0304437 0.0305242 0.0304238 0.031594 0.03244 0.0325958 0.0675574 0.070155 0.0696512 0.00747829 + 0.00733759 0.00736281 0.0276157 0.0282987 0.0243343 0.0296258 0.0295228 0.0121672 0.0138239 0.0138321 0.0137875 0.00697054 + 0.00685645 0.00679046 0.100196 0.0270093 0.0368477 0.0137149 0.120583 0.122333 0.120888 0.0167946 -0.00666411 -0.00808033 + -0.00821977 0.0112844 0.0115458 0.0292083 0.0396098 0.0659849 0.0669267 0.0672549 0.0264894 0.0324158 0.00233519 0.0023213 + 0.00220029 0.0191113 0.00950793 0.0588292 0.0605613 0.0584849 0.0730076 0.0730742 0.071617 0.0857577 0.0294648 0.02923 + 0.0293541 0.0630075 0.0268341 0.0886374 0.086457 0.0872677 0.0263167 0.0264227 0.0263832 0.101542 0.106097 0.107181 + 0.0101413 0.0168645 0.0770382 0.0780129 0.0276784 0.0301008 -0.000310483 -0.00262914 -0.00198428 0.00998702 0.0100667 0.00989398 + 0.0189018 0.0918936 0.016224 0.0157676 0.0234031 0.0235046 0.0233145 0.0714382 0.0699634 0.0685762 0.0246585 0.0209085 + 0.0202438 0.0121356 0.0299142 0.0299523 0.00463743 0.00360782 0.00346886 0.0619046 0.020148 0.0868721 0.118858 0.0207391 + 0.063186 0.109083 0.0292664 0.0323763 0.0523288 0.0530133 0.0526267 0.0220705 0.00173917 -0.000760972 0.0120618 0.0119031 + 0.0138036 0.00662923 0.0254975 0.025644 0.0255257 0.07011 0.0278601 0.0191637 0.0189196 0.0191071 0.0189939 0.0113969 + 0.0112595 0.0114181 0.0231836 0.0122862 0.0105921 0.0113533 0.0967938 0.00601108 0.00606222 0.00477848 0.0158637 0.0146547 + 0.0153547 -0.00979283 -0.0101118 -0.00815673 0.0237667 0.0264335 0.0240208 0.064972 0.0649519 0.0644134 0.0269516 0.00455225 + 0.0165598 0.0164157 0.0165791 0.0299803 0.0301264 0.0229365 0.0227138 0.0228343 0.00127576 0.0305131 0.0226625 0.024763 + 0.0260501 0.0295956 0.0276611 0.0277624 0.0235976 0.0237099 0.0432887 0.0435345 0.0477624 0.0341726 0.034883 0.0363745 + 0.0233843 0.0262681 0.0264977 0.0264387 7.89027e-05 0.0149685 0.0167466 0.0155576 0.0274371 0.0243174 0.0244306 0.0528167 + 0.00959038 0.00974534 0.00971877 0.0611982 -0.00085324 0.0920679 0.0921361 0.0900254 0.00027014 0.0265741 0.0279795 0.0281223 + 0.0282631 0.0315659 0.00693601 0.00613797 0.00706705 0.00616829 0.0265579 0.0266738 0.0506065 0.0128422 0.0130279 0.0233885 + 0.0232001 0.0233136 0.0107555 0.0108645 0.0109514 0.0121145 0.0121123 0.0122701 0.0456763 0.00122408 0.00135523 0.00134792 + 0.0245005 0.0243714 0.0250339 0.0264046 0.0261974 0.0282854 -0.00189103 0.000181456 -0.000792824 -0.00218246 0.00663757 0.00664542 + 0.0730065 0.0754518 0.0734544 0.0138209 0.0141538 0.0141377 0.0139967 0.013963 0.0137177 0.0298859 0.0341378 0.032824 + 0.00686283 0.0604253 0.0605429 0.00451308 0.0221559 0.0227419 0.0137628 0.00723761 0.00711103 0.00724592 0.000537764 0.000543082 + 0.000425487 0.0123987 0.0120881 0.0127349 0.0145982 0.000426105 0.0713469 0.0101158 0.0123268 0.0267385 0.0266427 0.0265466 + 0.0231778 0.0222734 0.00306818 0.00320711 0.00319392 0.000978116 0.00110508 0.00110038 0.027115 0.0813915 0.0796935 0.079495 + 0.0923818 0.0292802 7.33863e-06 0.0348274 0.0314178 0.0326198 0.0198693 0.0172038 0.0193617 0.0273792 0.0271107 0.0154898 + 0.0136968 0.013757 0.0135706 0.0299181 0.0297917 0.0296805 0.0207328 0.0200623 0.024181 0.0799452 0.0810384 0.0821783 + 0.0256849 0.0268662 0.0295311 0.0115517 0.0116814 0.01152 0.0607513 0.0268087 0.0741038 0.0715967 0.00385904 0.0156403 + 0.0414949 0.0409213 0.0426742 0.00749302 0.00403346 0.00419376 0.00417153 -0.0089853 -0.0104077 -0.0100737 0.0211526 0.0205662 + 0.0212901 0.011487 0.0340133 0.0519274 0.000214406 0.00511167 0.0138076 0.0348941 0.0351416 0.0388764 0.00838367 0.00840654 + 0.00853108 0.0133268 0.0149823 0.0150464 0.0145439 0.0143112 0.024047 0.0233822 0.0233363 0.00061754 0.000592123 0.000472587 + 0.0085787 0.0347568 0.033108 0.000120201 0.0623378 0.0624141 0.0420198 0.0389427 0.0361895 0.0606285 0.0611628 0.0604772 + 0.000119304 0.000270308 0.000112267 0.0876328 0.00954588 0.0505257 0.0460581 0.0439565 -0.0101977 0.0232192 0.0231079 0.0230407 + 0.0241449 0.0244913 0.0623995 0.0602566 0.061752 0.0272268 0.0270413 0.0272463 0.0265971 0.00343171 0.00350942 0.00358196 + 0.0810405 0.0262873 0.0214669 0.0213104 0.0215296 0.0178146 0.0175775 0.0177465 0.0176529 0.0778645 0.0778205 0.0800176 + 0.0693619 0.0126558 0.0151303 0.0145699 0.0088741 0.0090247 0.0116215 0.0042997 0.00734676 0.00389355 0.0211014 0.0265195 + 0.0265652 0.0265125 0.0772134 0.0830249 0.0808852 0.0105558 0.00867978 0.00680786 0.0436052 0.0447769 0.0425515 -0.00980716 + 0.027691 0.0295489 0.0648843 0.0638657 0.0651805 0.0616261 0.00713795 0.00654572 0.0254735 0.0261453 0.0258428 0.0509178 + 0.0231378 0.0285134 0.0284114 0.0223201 0.0221031 0.0222086 0.0112595 0.0305128 0.0748892 0.0759189 0.0769551 0.0637628 + 0.0606437 0.00670173 0.00718343 0.00641355 0.00349387 0.0036417 0.00362515 -0.00923973 0.0107624 0.010757 0.0100897 0.079282 + 0.0790818 0.0791758 0.0610903 0.0273312 0.0169541 0.0173106 0.0175915 0.0780503 0.00855877 0.0393026 0.0442447 0.0457528 + 0.0421146 0.0356813 0.0244614 0.00429406 0.0759377 0.0744263 0.0755222 0.0146552 0.00310054 0.0486313 0.0088332 0.00801447 + 0.00821027 0.00340445 0.00988587 0.0282565 0.0282873 0.0117775 0.0110917 0.0110375 0.00905713 0.0033388 0.00943557 0.00946124 + 0.00931544 0.0386316 0.0370659 0.0399584 0.0299361 0.0320627 0.0294825 0.0294701 0.0127388 0.00600392 0.00520451 0.00625 + 0.0265611 0.0265925 0.0266485 0.00522842 0.00328152 0.00648746 0.0283325 0.0283599 0.0278573 0.00309135 0.0277604 0.00410297 + 0.0442662 0.0250395 0.00209843 0.0230534 0.0219043 0.0220501 0.0220297 0.0146073 0.0143384 0.014263 0.0505021 0.0512421 + 0.00560842 0.0217605 0.0739936 0.0164353 0.0153488 0.019819 0.00625201 0.0146891 0.0141258 0.0143237 0.014383 0.0245088 + 0.0287791 0.0290969 0.0298429 0.029861 0.0289638 0.0267158 0.0450713 0.0047778 0.00470243 0.00483273 0.0297842 0.0278701 + 0.00411791 0.00424364 0.00408083 0.00277565 0.00282926 0.00291201 0.00462802 1.62027e-05 0.000177611 7.59563e-05 0.0744055 0.0640235 + 0.0640961 0.0761138 0.0256033 0.0238116 0.0291889 0.0160305 0.0160436 0.0158873 0.0353886 0.0371893 0.0833194 0.0843069 + 0.0824508 -0.00404647 0.02666 0.0267922 0.0266741 0.0626854 0.012264 0.013497 0.0103881 0.0294488 0.0291725 0.0301183 + 0.030106 0.0525811 0.0530809 0.0539496 0.00924173 0.00907907 0.00917264 0.0167981 0.016313 0.0162102 -0.000667339 -0.0015523 + 0.0214292 -0.00740226 0.0113645 0.0112014 0.0112338 0.0821852 0.0785378 0.080705 0.019713 0.0198261 0.0199029 0.0517941 + 0.0626474 0.00331247 8.00217e-05 0.0108693 0.0987367 0.0981866 0.10088 0.0299186 0.0296377 0.0297356 0.000313474 0.000235221 + 0.00895656 0.0212907 0.0210828 0.0212057 0.0732732 0.0758451 0.00748465 0.0111614 0.0112177 0.0105183 0.0210266 0.0706372 + 0.0669029 0.0668372 0.00975508 0.0263976 0.0112906 0.0106708 0.0110854 0.00653862 0.0537194 0.127164 0.0267988 0.0269335 + -0.00233949 0.0161671 0.0709792 0.0711138 0.00232866 0.00227298 0.00342916 0.0277033 0.00953686 0.00179743 0.0138082 0.0161422 + 0.0185593 0.0127751 0.0129868 0.0266795 0.012658 0.0125619 0.0722542 0.0712831 0.108668 0.107053 -0.00264857 -0.00103139 + -0.00332462 0.0266711 0.00146416 0.00156657 0.00164328 0.00856251 0.0103893 0.0104544 0.0269219 0.0230933 0.00498079 0.0108987 + 0.00839314 0.00827688 0.0275578 0.103308 0.101279 0.104951 0.0140207 0.0260354 0.025581 0.0262225 0.102605 0.00740555 + 0.0123497 0.0299469 0.0301325 0.0299926 0.0292289 0.00700331 0.12312 0.0171481 0.0173224 0.0172922 0.0101704 0.010615 + 0.00996266 0.0255222 0.0253268 0.0255082 0.072196 0.0169238 0.0434156 0.0104133 0.00717476 0.00691815 0.0138962 0.0792286 + 0.0159245 0.0137641 0.0257188 0.0256736 0.0258591 0.0146637 0.01452 0.0144997 0.0103799 0.0366267 0.0369005 0.0357297 + 0.0216644 -0.0044415 0.0237302 0.00772198 0.00671781 0.00416662 0.0634741 0.0615517 0.0579363 0.0592364 0.0659023 0.0573201 + 0.057393 0.0790068 0.0296424 0.0297917 0.0295702 -0.00368423 -0.00180295 -0.00201219 0.0256886 0.089412 0.0901095 0.050923 + 0.0469438 0.0449335 0.0298157 0.0157784 0.0159168 0.0157687 0.0183906 0.00712105 0.00801381 0.0273382 0.0835791 0.0810528 + 0.0870999 0.0266269 0.0267546 0.0271755 0.00773916 0.00554886 0.102563 0.103243 0.100039 0.0780579 0.0211759 0.0210548 + 0.0209755 0.0106839 0.0562998 0.0563064 0.0579816 0.00903295 0.0189979 0.0190031 0.0191756 0.0203598 0.0664643 0.0697025 + 0.0688207 0.0243217 0.0243115 0.0114404 0.0127568 0.0125381 0.0203067 0.0740122 0.0744901 0.0728634 0.123747 0.0655406 + 0.0193571 0.0188526 0.0267702 0.000236215 0.0231657 0.0236243 0.0241263 0.0172502 0.0183136 0.0263038 0.0261954 0.0261575 + 0.00492643 0.00487875 0.0224949 0.0223777 0.0222919 -0.00991066 -0.008485 0.0295131 0.0293617 0.0293142 -0.00375966 0.0740455 + 0.0315805 0.00126755 0.00683952 0.00729761 0.00603843 0.024263 0.0235061 0.0239078 0.0522586 0.0521451 0.0489328 0.0122688 + -0.000855511 0.000436779 0.0268756 -0.00176731 -0.000305731 -0.00081563 0.018299 0.0179626 0.0187184 0.0170798 0.0165232 0.0167293 + 0.0298617 0.0145775 0.024939 0.0250704 0.0251061 0.0479928 0.00327926 0.0279813 0.026255 0.0222131 0.0108257 0.015667 + 0.0158912 0.0237377 -0.0013462 -0.00230211 0.0013071 0.000725386 0.000132407 -0.00847551 0.000122132 -0.00276819 -0.0013898 0.023173 + 0.022183 -0.00950296 0.0330538 0.0306 0.029367 0.00586404 -0.00949088 0.0277967 0.0278758 0.0276325 0.0640536 0.0414097 + 0.0403471 0.0974702 0.00397518 0.0626804 0.0631298 0.094368 0.0936737 0.098881 0.0173393 0.0180129 0.0178172 0.0156342 + 0.015653 0.0551989 0.0546701 0.0536314 0.0406544 0.0269853 0.0547896 0.0544741 0.0566826 0.0120951 0.0118374 0.0537722 + 0.00300178 0.0190523 0.0183292 0.0185538 0.00721785 0.0110722 0.0240666 0.00708653 0.0069669 0.0071198 0.0129219 0.0131934 + 0.0128187 0.0858377 0.083689 0.0177789 0.00282642 0.0285925 0.0284918 0.0797209 0.0787104 0.0318752 0.070715 0.0266369 + 0.026659 0.0265685 0.0558591 0.000143701 0.0157397 0.0640995 0.00936837 0.000204682 0.000310355 0.000311595 0.016645 0.0165506 + 0.0167468 0.0257424 0.0258467 0.0258662 0.0785447 0.0228096 0.0280509 0.0142735 0.0151396 0.0126932 0.0268561 0.015495 + 0.0139342 0.014084 0.0140932 0.000248609 0.0105009 0.0106059 0.0106888 0.0577484 0.00961121 0.0787732 0.0275915 0.0276325 + 0.00444658 0.0195585 0.0712272 0.0154251 0.0186329 0.0167838 0.02235 0.014955 0.0151056 0.0150055 0.0560942 0.0551481 + 0.0562552 0.00355813 0.0279636 0.0281511 0.0282345 0.0631424 0.0134992 0.03044 0.0303899 0.0303232 0.0606155 0.0609416 + 0.0607982 0.0565236 0.0563475 0.0678509 0.0696685 0.0999882 0.0973497 0.0947907 0.0146158 0.0725351 -0.00615351 -0.00491418 + -0.00617769 0.00765645 0.00216585 0.00556894 0.0220517 0.0139389 0.0177015 0.00910721 0.0350087 0.0324995 0.0368973 0.0301828 + 0.0285412 0.0290951 0.0147729 0.0100419 0.0108417 0.00909287 0.00899713 0.00892645 0.0224772 0.0108843 0.0110545 0.0106003 + 0.00127734 0.0531208 0.0262945 0.026369 0.0879953 0.0894712 0.0126466 0.0238179 0.0242878 0.0276852 0.0394562 0.0374277 + 0.0225532 0.0224423 0.0226489 0.0225525 -0.000103577 0.0209522 0.0208019 0.0210126 0.027512 0.00695589 0.00679898 0.00681313 + 0.0106716 0.0106632 0.0105083 -0.00141624 0.0474588 0.0954974 0.096659 0.0222737 0.0725554 0.0727387 0.0668048 0.0598394 + 0.0593849 0.0611348 -0.00751887 0.0233272 0.0236199 0.0239218 0.0248715 0.0511826 0.0440444 0.0468418 0.0180594 0.0087871 + 0.0087757 0.00865977 0.0106969 0.0108616 0.0139021 0.0239768 0.101165 0.0713751 0.0616999 0.0618878 0.00383676 0.00683053 + 0.00547517 0.0719002 0.0711233 0.0665988 0.000103702 0.0001024 0.0322769 0.0148217 0.0146178 0.0147663 0.0219223 0.0218719 + 0.0123342 0.0436075 0.0146709 0.0210215 0.0201831 0.0204627 0.11366 0.112526 0.115088 0.0128749 0.0125567 0.0129842 + 0.0175174 0.00995565 0.00352954 0.0294393 0.0057772 0.10627 0.0268296 0.00475982 0.0135477 -0.00615193 -0.00617094 -0.00478975 + 0.00814489 0.00797135 0.000203692 0.0155235 0.0153921 0.015393 0.0575193 0.0569041 0.0579547 0.118827 0.118807 0.0188187 + 0.00122362 -0.000271099 -0.00149275 -0.000182483 0.0209663 0.0209215 0.0207759 0.0139725 0.0133881 0.0134407 0.0345379 0.104653 + 0.104354 0.000674948 0.0266116 0.0265444 0.0266712 0.00892665 0.112275 0.110774 0.113248 0.00321043 0.00683898 -0.0032624 + 0.0113678 0.0112876 0.0117602 0.00097799 -0.00514037 -0.00671431 -0.0051238 0.0105104 0.010625 0.00257495 0.00264152 0.00248478 + 0.0794639 0.0193709 0.0234829 0.0199088 0.0414694 0.0243736 0.0422666 0.0379005 0.0406356 0.026077 0.0188875 0.0181436 + 0.0191498 0.0929798 0.0136892 0.0142632 0.00277674 0.00266863 0.0135865 -0.00100145 0.000112145 0.0124145 0.01117 0.0110087 + 0.0110384 0.0152551 0.0173843 0.018884 0.0254747 0.0259305 0.0254429 0.0364202 0.0391095 0.0137749 0.0148176 0.0239856 + 0.0241658 0.0241286 0.00314347 0.00233879 0.00201394 0.0230811 0.0206103 0.0278005 0.0278918 0.0276018 0.0672342 -0.00546884 + -0.00721991 -0.00656369 0.00196144 0.0290591 0.016373 0.0164498 0.00246159 0.0270829 0.0272837 0.0272948 0.0389929 -0.00116682 + -0.0023503 0.00996305 0.0322629 0.0258352 0.0377299 0.0394666 0.035633 0.00668749 0.0138836 0.0139337 0.0140658 0.000735316 + 0.0810412 0.0788593 0.0795551 0.0570791 0.0601222 0.0631521 0.0274224 0.0277032 0.0017175 0.0780254 0.00613771 0.00625779 + 0.00631469 0.0126398 0.00708645 0.0314973 0.0295396 0.0317032 0.00255234 0.00259783 0.00271462 0.0170741 0.016476 -0.00381858 + -0.00285149 0.0132749 0.0131171 0.0132113 0.0206922 0.0207986 0.0205594 0.0270918 0.106427 0.0571245 0.0562339 0.0565403 + 0.0174557 -0.00573899 0.0576041 -0.006775 0.0130102 0.0230362 0.0184372 0.017987 0.0177645 0.00381813 0.043255 0.048632 + -0.00659618 -0.00503064 -0.00681115 0.0130334 0.00143223 0.0296515 0.0297806 0.00981665 0.0195955 0.0202959 0.00488786 0.00491541 + 0.00504074 0.0278651 0.0378523 0.0566882 0.0577145 0.0576654 0.000203625 0.0845013 0.0637952 0.0637894 0.06361 0.0473975 + 0.0453997 0.0217489 0.0216187 0.0215763 0.0266059 0.0105123 0.0503395 0.0503118 0.0520707 -0.00839052 -0.00855696 0.0063476 + 0.0608015 0.0608796 0.0623553 0.00724322 0.0310556 0.0249372 0.0298677 0.119803 0.0868127 0.0845531 0.0879103 0.0578668 + 0.0654218 0.0278288 0.028007 0.0280685 0.0458617 0.0464511 0.0474482 0.0116234 0.023975 0.0213761 0.0279273 0.110837 + 0.109302 0.0273955 0.0276643 0.027553 0.0280669 0.0391392 0.0186625 0.0180864 0.0182916 0.003058 0.0263793 0.0262807 + 0.0263345 0.0205468 0.0213884 0.0224848 0.0259544 0.0204598 0.012146 0.0122277 0.0120193 0.0607685 0.0357378 0.0365003 + 0.0371335 0.015857 0.0541905 0.0555369 0.0267083 -0.00452242 0.0263436 0.0010117 0.00201875 0.000653085 0.00945321 0.00914284 + 0.00862392 0.0122844 0.116578 0.116507 0.121673 -0.00478774 0.0118818 0.0152636 0.0131086 0.0987273 0.0148524 0.0132895 + 0.0103129 0.0627888 0.0882116 0.0906185 0.0931991 0.00770477 0.0994836 0.0265493 0.0260804 0.0261331 0.0304249 0.0285528 + 0.0287028 0.0282163 0.0282654 0.0278674 0.00523743 0.0120719 0.0300039 0.0300235 0.0108086 0.0109003 0.0109779 0.0277474 + 0.0274604 0.0279434 0.01169 0.011781 0.0116109 0.0141864 0.028492 0.0199754 0.0197777 0.0198712 0.0713932 0.0211585 + 0.0142337 0.0142084 0.0671609 0.0676136 0.0633158 0.0261061 -0.00790905 0.0773531 0.0272987 0.015117 0.0304343 0.0274352 + 0.027432 0.00292223 0.0156591 0.0155135 -0.000588064 -0.00687018 -0.00588283 -0.00746847 -0.00849044 0.0685997 0.0347522 0.0627744 + 0.0280222 0.0272829 0.0272803 0.0104332 0.0172631 0.0165897 0.0170185 0.0573983 0.0282233 0.0267005 0.0129105 0.050956 + 0.0201077 0.0200052 0.000154681 0.000181837 0.00027361 0.126009 0.12648 0.12812 0.0140577 0.00951302 0.00953503 0.00967848 + 0.014315 0.0164857 0.0158104 0.0164995 0.030641 0.0553606 0.0175001 0.0267238 0.0266259 0.00140928 0.00022869 -0.00602642 + 0.0295981 0.0542511 0.0563289 0.0543639 0.00799983 0.00803005 0.00788073 0.0222159 0.0129596 0.0265849 0.0287331 0.0286264 + 0.0289794 0.00084641 0.0635681 0.0634439 0.00129115 0.000178258 -0.000473262 0.0516726 0.0214018 0.0662138 0.0652198 0.0665321 + 0.0267504 0.0268827 0.0229959 0.000199476 0.0015022 0.0185815 0.00169701 0.00157076 0.00158477 0.0450945 0.00146599 0.0252231 + 0.0252667 0.0259525 0.0212168 0.027238 0.0274707 0.0275018 0.0265417 0.0197861 0.0197641 0.00417866 0.0037367 0.00284727 + 0.0703499 0.0699781 0.00259149 0.00245744 0.00247398 0.000220443 0.000117129 0.000251696 0.0426377 0.0439137 0.0267856 0.00721801 + 0.00723053 0.00281016 0.00268061 0.00269367 0.0119992 0.0118073 0.0119382 0.0831366 0.082608 0.0118394 0.00235286 0.0143764 + 0.014367 0.0142332 0.00471611 0.00474251 0.00485993 0.0234821 0.0226851 0.0232035 0.0230036 -0.0023641 0.0025702 0.0234798 + 0.00488401 0.00486472 0.00476001 0.0305176 0.030566 0.0305163 0.0120257 0.0145029 0.00694522 0.00706766 0.00691761 0.0137689 + 0.0122844 0.0122587 0.0118003 0.0111493 0.0110317 0.0105451 0.0947863 0.0136871 0.013822 0.0137872 0.0776508 0.0744912 + 0.0779184 0.0148141 0.0146771 0.0139792 0.014145 0.0140409 0.0257137 0.0262969 0.0200077 0.0635079 0.0510731 0.0491515 + 0.00496336 0.0483699 0.0820195 0.0840832 0.0149449 0.0145157 0.0145523 0.0266012 0.000243122 0.0170523 0.017286 0.0176487 + 0.0248842 0.0627182 0.0624189 0.0625912 0.0123053 0.00897649 0.0122297 0.00826695 0.000222871 0.0574698 0.0553828 0.0102177 + 0.00942019 0.0226128 0.0139138 0.0148384 0.0217773 0.0278681 0.0915522 0.00529674 0.124633 0.0287765 0.0289319 0.0291185 + 0.009855 0.0601539 0.000759263 0.00142326 0.00144436 0.00156215 0.00243767 0.024016 0.0528312 0.0480705 0.0511267 -0.00467168 + 0.0103546 0.0583412 0.0223668 0.00611825 0.0129052 0.00850947 0.0719716 0.0271918 0.0274376 0.0628173 0.0632001 0.0171298 + 0.0171491 0.0633117 0.0630367 0.0631458 0.0297431 0.0294838 -0.000395594 0.0171706 0.0179236 0.117224 0.0829757 0.0170074 + 0.0207825 0.0571639 0.0570135 0.00434976 0.00644145 0.00346079 0.0263673 0.000874131 0.000756764 0.000763785 0.0303395 0.0864218 + 0.0181254 0.0132891 0.00117444 0.0123849 0.0208932 0.000653598 0.0611463 0.030177 -0.00392355 0.0179911 0.0187426 0.025389 + 0.0253163 0.0252483 0.0256629 0.0257764 0.0271522 0.0273461 0.070324 0.0212895 0.0177286 0.0119552 0.0379485 0.0253489 + 0.000119112 0.00840614 0.0183959 0.0185458 0.0644664 0.0411809 0.0256885 0.0257252 0.00793014 0.00490919 0.0274509 0.0132489 + 0.0134274 0.00774969 0.021096 -0.00991735 -0.0110756 -0.0110133 0.011784 0.0119217 0.00320356 0.000239858 0.00202761 0.0148564 + 0.0127336 0.0424557 0.0426392 0.0408712 0.094138 0.0132535 0.0427974 0.0622165 -0.00204976 0.0711093 0.0713487 0.06444 + 0.0538347 0.0289762 0.0291474 0.0291794 0.0539028 0.0562953 0.0527639 0.0372824 0.0322838 0.0163172 0.0465436 0.0458346 + 0.00399952 0.0688641 0.0806579 0.079422 0.0796221 0.0251688 0.0222322 0.0223467 -0.00742788 -0.00722831 -0.00793943 -0.00637181 + -0.00732985 0.0274713 0.0170429 0.0220649 0.0203677 0.00906625 0.0267155 0.00973651 0.0164242 0.0128086 0.0159205 0.0140992 + 0.012928 0.0143312 0.0084663 0.00828391 0.0084044 0.0243377 0.0243337 0.0242118 0.00832384 0.116125 0.0114586 0.0113327 + 0.0196366 0.0179855 0.0179403 0.0177994 0.0145703 0.0143224 0.0120001 0.0119539 0.0264828 0.00202166 0.00803755 -0.00769368 + -0.00765536 -0.00847584 0.104823 0.0259842 0.0262155 0.0257231 0.0294148 0.0293372 0.049783 0.00840355 0.0373709 0.0342328 + 0.0378092 0.00757882 0.00760777 0.0074631 0.0212314 -0.00855376 0.079646 0.081484 0.0808341 0.00284828 0.00288743 0.00299655 + 0.00359798 0.103666 0.0151836 0.0148246 0.0294669 0.0294336 0.0299893 0.020865 0.0296491 0.0294595 0.021268 0.0763184 + 0.0750384 0.00347347 0.00441473 0.106494 0.101583 0.104934 0.0562248 0.0548739 0.0338013 -0.0109641 -0.00966486 0.0809755 + 0.0266731 0.026706 0.0267672 0.0244957 0.0112977 0.0103584 0.0105529 0.0227071 0.0225301 0.0225818 0.0909245 0.0116965 + 0.000567781 0.0420889 0.0415156 0.0180068 0.017918 0.000356151 0.0247579 0.0821947 0.0834313 0.0836648 0.00849125 0.00741699 + 0.0288488 0.0292818 0.0296011 0.0259076 0.0181879 2.08892e-05 0.0189568 0.0769614 0.0780089 0.000243403 0.00133233 0.0119772 + 0.0118852 -0.000204808 0.0262762 0.0263655 0.0151091 0.013732 0.0636545 0.0631353 0.00109701 0.00158679 0.000440241 0.0119304 + 0.0657561 0.0183355 0.0262091 0.0263911 0.0263187 0.0254356 0.00963999 -0.00640836 0.0546039 0.102168 0.0188882 0.0186914 + 0.0187805 0.013675 0.0776475 0.0354337 0.0373396 0.00564795 0.0112938 0.0149731 0.0158436 0.0157433 0.0156534 0.016072 + 0.0162883 0.0161705 0.0307009 0.0934112 0.0132509 0.0305435 0.0941244 0.0921341 0.0918192 0.00248421 0.0592593 0.0578173 + 0.057644 0.0214607 0.0563963 0.0980611 0.0215268 0.021746 0.0274846 0.0270623 0.0273776 0.00932571 0.0153339 0.00697159 + 0.00690612 0.00706795 0.0161822 0.0129188 0.0131053 0.0133616 0.00810528 0.083394 0.0890734 0.0408996 0.00549295 0.00534177 + 0.0104022 0.103085 0.000201076 0.000314388 0.000189729 0.0143936 0.0151778 0.0147115 -0.00365534 -0.00497691 0.0150305 0.0264541 + 0.0300016 0.0301724 0.0299757 0.0470485 0.0464856 0.0482069 0.0252236 0.0253834 0.0252813 0.0632844 0.0188974 0.0103897 + 0.0125416 0.000100476 0.0402776 0.0393446 0.0372393 0.0585666 0.0593475 0.0584941 0.0334602 0.0333842 0.0197225 0.00988153 + 0.0140472 0.0142205 0.0128441 -0.00845797 0.0165853 0.00869069 0.100198 0.022282 0.0212061 0.0305736 0.0305519 0.00851106 + 0.00850941 0.0751574 0.0127814 0.0125568 0.0104228 0.025719 -0.00241079 0.103498 0.0693063 0.0468105 0.0449309 0.0460764 + 0.0214174 0.0216563 0.0210396 0.0414145 0.0428001 0.067 0.0221012 0.0264975 0.056209 0.0561101 0.017708 0.0181657 + 0.0180454 0.0179833 0.0178612 0.0162712 0.0497863 0.000379642 0.000698127 -0.000950032 0.0273386 0.121708 0.120624 0.123825 + 0.0221047 0.0898658 0.0269678 0.0272062 0.027294 0.0512121 0.00262989 0.0883265 0.000202883 0.0787356 0.00778591 0.0165638 + 0.0123965 0.0120895 0.0125249 0.0979293 0.00857009 -0.00719739 -0.00940524 -0.0101638 0.0812269 0.0803068 0.0811454 0.0219614 + 0.0628695 0.0631336 0.0246132 0.0244702 0.0439471 0.00991019 0.0100705 0.0100583 0.00158139 0.00146775 0.00920146 0.00922947 + 0.00935995 0.013816 0.0139495 0.0139519 0.0567621 0.0604237 0.00968571 0.00228591 0.0765327 0.0751604 0.0110024 0.0111284 + 0.0109774 0.00436495 0.00433435 0.00449811 0.00684452 0.013397 0.013349 0.0123277 0.0128159 0.0126291 0.0127188 0.0282946 + 0.0280616 0.0282618 -0.00904232 -0.00786661 0.0262946 0.0262285 0.0264565 0.027323 8.73548e-05 0.0730141 0.0738103 0.0722793 + 0.101616 0.0597489 0.0660452 0.0132179 0.0129435 0.0133186 0.0136442 0.0134991 0.0135191 0.0026745 0.0239479 0.0137852 + 0.0167615 0.0179043 0.00736636 0.113453 0.0269004 0.0271143 0.0270356 0.102069 0.0193496 0.0138136 0.0143555 0.0143052 + 0.0271117 0.0259294 0.000919272 0.00427462 0.0741839 0.0300636 0.0300011 0.00512226 0.00139538 0.00125792 0.00127237 0.0125629 + 0.0312253 0.0325328 0.0129225 0.0196797 0.0200508 0.0192904 0.0493563 0.0292759 0.0290164 0.0291134 0.00756844 0.0205065 + 0.0210248 0.0208945 0.0203448 0.0926776 0.0913735 0.0096148 0.048536 0.0496461 0.0269531 0.00716801 0.00718836 0.00704225 + 0.00586345 0.00584109 0.00572046 0.110848 0.111904 0.113157 0.017309 0.0205185 0.0162192 0.0498931 0.0468777 0.10738 + 0.105508 0.0278039 0.0255433 0.0249386 0.0250095 0.0241857 0.0138574 0.0618622 0.0613869 0.00160419 0.0201535 0.0202158 + 0.020048 0.0131596 0.0131437 0.0135869 0.0263721 0.00839486 0.0560795 0.0573649 0.0561904 0.0276052 0.0271134 0.027428 + 0.0147471 0.000116927 0.0252343 0.0250715 0.0252871 0.00500855 0.0247913 0.0245712 0.0820955 0.0833732 0.0831025 0.0764101 + 0.0854537 0.0132755 0.0682067 0.0681308 0.0670239 0.0239877 0.0241211 0.0240259 -0.000423045 -0.00176425 0.029279 0.0299164 + 0.0299399 0.0273045 0.0178007 0.0168804 0.0174588 -0.000757705 0.000614344 0.0808959 0.0222158 0.0329754 0.0287353 0.0289919 + 0.0286816 0.00141924 0.0126106 0.0167249 0.0165432 0.0166521 0.0180006 0.0151075 0.0200469 0.05235 0.0164768 0.0139124 + 0.00411423 0.00478164 0.00291733 0.00483323 0.056132 0.075498 0.0805374 0.0796575 0.0191594 0.0201405 0.0200267 0.019954 + 0.0274318 0.0273973 0.0212749 0.0211157 0.0238419 0.0168904 0.0763607 0.0753776 0.0360397 0.00642171 0.00655888 0.0064107 + 0.0202027 0.019707 0.0848022 0.0824917 0.0833344 0.0189393 0.0880712 0.0869902 0.0911794 0.0122871 0.0119964 0.0118406 + 0.012487 0.0121737 0.0116674 0.0479876 0.0483906 0.0737183 0.0318939 0.0204627 0.0136534 0.0675607 0.0118538 0.0150238 + 0.0288885 0.073974 0.0765523 0.0266749 0.0262748 0.0265275 0.0269362 0.0697398 0.0730567 0.0268816 0.0270792 0.0270655 + 0.00776291 0.0451261 0.0395667 0.0426777 0.0241468 0.023739 0.0243294 0.0142682 0.0292881 0.0280074 0.00599062 0.00748405 + 0.0212081 0.019018 0.012191 0.0120139 0.012133 0.11877 0.0263588 0.0259687 0.025924 0.00416474 0.00515996 0.108304 + 0.109673 0.107459 0.0272817 0.0271274 0.0271268 0.0163744 0.0173565 0.0272725 0.0172411 0.0012436 0.00138004 0.0615216 + 0.0140812 0.0142625 0.0274001 0.00131567 0.0760049 0.0745648 0.0758579 0.0120555 0.0198926 0.0193916 0.0191901 -0.00824608 + -0.00872322 0.0134563 0.0102209 0.0147617 0.0149922 0.0144123 0.0169222 0.0175624 0.0917553 0.0594391 0.00176973 0.00325444 + 0.00787802 0.0901307 0.00955107 0.011615 0.0093856 0.0133788 0.0188627 0.02092 0.0137471 0.0878045 0.00472818 0.0548076 + 0.027179 0.0428765 0.1131 0.112022 0.0440258 0.0594165 0.00158335 0.0195174 0.0200184 -0.00456209 -0.00565574 -0.000816754 + 0.00179409 0.0898023 0.0780366 0.0882048 0.0823278 0.0816096 0.00232419 0.00767117 0.109757 0.00983034 0.0525435 0.00198467 + 0.021282 0.0491996 0.0476826 0.0489621 0.0123229 0.0659165 0.0244776 0.0140377 0.0308514 0.0305901 0.0350482 0.0301369 + 0.0665373 0.0213086 0.0217006 0.0210322 0.00754927 0.0076717 0.0082554 0.0168834 0.013874 0.0214847 0.0482053 0.0466423 + 0.0115111 0.0937054 0.00926825 0.0351976 0.0102012 -0.00321157 -0.00898493 0.0297908 -0.003222 0.0345841 8.46167e-05 0.0267506 + 0.00880492 0.00893986 0.00947621 0.0179854 0.0181454 0.018132 0.0108825 0.107803 0.0289312 0.049455 0.0168533 0.0208672 + 0.0188171 0.0037721 0.0149668 0.111096 0.0865634 0.0791382 0.00991025 0.00976379 0.0368649 0.0802328 0.00131943 0.0136754 + 0.0132892 0.0131139 0.0126829 0.0265215 0.016714 0.0195386 0.0219227 0.0132586 0.0131029 0.0131684 0.0186327 0.0546548 + 0.0267255 0.00376327 0.0203113 0.0114748 0.0302248 0.0302061 0.004656 0.0273102 -0.00299216 -0.00474285 0.0503774 0.049522 + 0.0488867 0.0135176 0.0206016 0.0187611 0.0607366 0.0564874 0.0029285 0.00862718 0.024724 0.0136475 0.0131404 0.0130736 + 0.00481437 0.000174198 -0.000841067 0.0126901 0.101326 0.0228331 0.0227439 0.0226431 0.0123131 0.00143662 0.0378397 -0.00863642 + 0.0319624 0.0422186 0.0569248 0.00145009 0.0667698 0.0390308 0.039679 0.0365297 0.0123437 0.0366859 0.0341784 0.0349358 + 0.0265717 0.104441 0.0332032 0.0323465 0.0323815 0.0206168 0.0557253 0.0244954 0.0547675 0.0273568 0.0843945 0.0848414 + 0.0141875 0.0118005 0.0374785 0.0138721 0.0266277 0.02683 0.0267424 0.0102008 -0.00455606 0.0238119 0.00576487 0.00779173 + 0.0139411 0.0267227 0.026784 0.0269003 0.0348094 0.033696 0.0160253 0.00474751 0.0140412 0.0138727 0.00976279 0.00964036 + 0.00980039 0.0334982 0.00906943 0.0182156 0.0651345 0.0140753 0.00837122 0.1099 0.107189 0.109204 0.0180132 0.124367 + 0.0940701 0.0990574 0.098066 0.0519521 0.0175502 0.017377 0.0174451 0.0112869 0.0540174 -0.00606138 0.0276949 0.0272813 + 0.0265612 0.0265623 0.0264744 0.0130331 0.0448004 0.0460439 0.0241222 0.0243221 -0.00343085 0.0026319 0.00251472 0.0141468 + 0.0636485 0.0636304 0.0638002 0.0994624 0.0995459 0.0969574 0.024705 0.0247256 0.0248975 0.0159993 0.0581719 0.0639836 + 0.00236638 0.00221597 0.0139345 0.0138363 0.0140307 0.0292152 0.0289937 0.0291698 0.0160756 0.0179068 0.00340669 0.0130464 + 0.095481 0.0125453 0.0109859 -0.00604926 0.0692146 0.0168913 0.0184047 0.00679858 0.0361733 0.0175236 0.0177149 0.0175593 + 0.0374649 0.0373705 0.0790051 0.0095927 0.0102455 0.00918578 0.0174009 0.0234005 0.0226481 0.0231482 0.0358342 0.0644029 + 0.0640591 0.0273879 0.0274032 0.0199226 0.0109117 0.0100731 0.0152199 0.0259013 0.0196303 0.0230051 0.0232231 0.0230433 + 0.0576898 0.0635107 0.0899666 0.0808311 0.0814366 0.0221883 0.0214045 0.0157889 0.0159667 0.00629415 0.0096915 0.0158464 + 0.0158065 0.0477226 0.0231045 0.0308125 0.0422769 0.000107143 0.010458 0.0163975 0.0162615 0.0180739 0.0186877 0.0186948 + 0.0533447 0.0128019 0.0124112 0.0228867 0.0778102 0.0689874 0.0336397 0.0282109 0.0307098 0.0251737 0.0245657 0.0191353 + 0.0179331 0.0246952 0.0237668 0.0286235 0.00713194 0.0604643 0.0598149 0.0597773 0.0155307 0.0154824 0.0137531 0.0334043 + 0.0694298 -0.00915871 0.0261124 0.0265803 -0.006694 0.0265083 0.0304338 0.030455 0.0135215 0.0124057 0.0157889 0.0156357 + 0.0157226 0.0764729 0.0269625 0.0585718 0.0133938 0.0275458 0.0272559 0.0277075 0.0248192 0.0145767 0.0138199 0.0173268 + 0.0437836 0.0179021 0.0970952 0.0971662 0.0282723 0.0280205 0.0281746 0.0608972 0.0284142 0.0272028 0.0270574 0.0270343 + -0.00355774 -0.00715593 0.013465 0.0137178 0.0137788 0.112067 0.0245329 0.0210167 0.012539 0.0578822 0.0106371 0.00261104 + 0.00265578 0.00915593 0.0136368 0.0130389 0.00202437 0.0143654 0.0227701 0.0129368 0.0132134 0.0132184 0.0239528 0.111512 + 0.10177 0.0271116 0.125697 0.123877 0.0192833 0.011511 0.0108913 0.0115316 0.0139329 0.0141021 0.00224969 0.0244357 + 0.0467137 0.00866889 0.0203408 0.0203882 0.0205399 0.0148647 0.0157993 0.084348 0.0814331 0.083094 0.0254737 0.0256275 + 0.0255362 0.00550986 0.00320601 0.0556816 0.00456457 0.00467491 0.00454592 0.0300997 0.0304125 0.0313884 0.0679117 0.0683474 + 0.0132319 0.0130466 0.0626876 0.10724 0.00500738 0.0282802 0.0279166 0.028097 0.0620599 0.0707425 0.0142423 0.01009 + 0.0100623 0.0195264 0.118855 0.0193322 0.019112 0.0192325 0.0256596 0.0268364 -0.0119147 -0.0104116 0.0118337 0.00725236 + 0.00832051 0.00775911 0.0117905 0.0455071 0.00213305 0.00210184 0.00198534 0.028757 0.0893041 0.0286211 0.028814 0.0285577 + 0.0931781 0.0273968 0.109798 0.109869 0.0417423 -0.00378466 0.0656434 0.0649007 0.0660119 0.00313906 0.00325557 0.0248484 + 0.0108547 0.0175469 0.0174144 0.0175594 0.0142547 0.0137944 0.123244 0.0314725 0.0252799 0.0252517 0.02546 0.0807031 + 0.0304913 0.0145788 0.0144136 0.0144806 0.0259309 0.0248431 0.0239627 0.0224137 0.114035 0.0108147 0.0821479 0.00237301 + 0.00223234 0.00223738 0.0784046 0.0249389 0.0242199 0.0222749 0.0266827 0.0268023 0.0284534 0.0282839 0.0120322 0.0639553 + 0.064144 0.0632129 0.0102875 0.00923523 0.00936266 0.0401911 0.0395837 0.0412693 0.0179908 0.0648012 0.107459 0.0253289 + 0.0197512 0.0201928 0.0251039 0.063399 0.031253 0.0310705 0.021922 0.0228345 0.0234791 0.022599 0.0215274 0.0220281 + -0.000497887 0.0142131 0.022527 0.022535 0.0360604 0.0354061 0.0506678 0.031997 0.112 0.0305854 0.0313527 0.0306268 + 0.0294815 0.0345727 0.0372019 0.0968751 0.00889058 0.00886194 0.00872905 0.00588395 0.025743 0.0250493 0.0304604 0.0133435 + 0.0134619 0.0272666 0.0270539 0.0107988 0.0109241 0.0107819 0.0279361 0.0300014 0.0615478 0.0134153 -0.00109562 0.0181586 + 0.0185244 0.0818892 0.00302355 0.116717 0.0276921 0.0193628 0.0583958 0.0269368 0.0271177 0.0399133 0.0346161 0.0692995 + 0.0655875 0.0170727 0.0264276 0.0287848 0.114489 0.110782 0.0126169 0.0244921 0.0245588 0.024434 0.0273126 0.0272246 + 0.0272565 0.0139672 0.102754 -0.00514262 0.0802719 0.0260239 0.0259301 0.0257845 0.0425791 0.0444453 0.0439557 0.0200066 + 0.0645787 0.00202053 0.0217449 0.0215791 0.0215739 0.122396 0.121062 0.0563733 0.0305188 0.04786 0.0291144 0.0136489 + 0.0137435 0.0443265 0.018593 0.054031 0.0719009 0.0736292 0.00392392 0.00406635 0.00042999 0.064777 0.0641676 0.0642082 + 0.0287144 0.0275773 0.00184383 0.016697 0.0269638 0.0254636 0.0264021 0.0264189 0.0019036 0.00187458 0.00176039 0.118404 + 0.0154868 0.0415562 -0.00425719 -0.003525 -0.00269838 0.00436506 0.00441428 0.00426969 0.0292369 0.0359066 0.0782464 0.0247915 + 0.0510953 0.0188707 0.026614 0.026567 0.026693 0.0270693 0.000292587 0.0194471 0.0379314 0.0681808 0.0684964 0.069777 + 0.0178971 0.00523185 0.00843926 0.0294166 0.0269872 0.0273005 0.0274113 0.0796379 0.0107346 0.052205 0.0299367 0.0300312 + 0.0298243 0.0144197 0.0148029 0.0108596 0.010788 0.121807 0.0174985 0.0528652 0.0469074 0.0227335 0.0228495 0.00657899 + 0.00655574 0.00643401 0.0270392 0.0266178 0.025837 0.027809 0.0280563 0.0279238 0.00738879 0.121455 0.0115115 0.0266976 + 0.0181115 0.0175293 0.0173543 -0.00854875 0.0496944 0.0942122 0.0780483 0.0303057 0.022468 0.0214546 0.0632163 0.0263524 + 0.0431296 0.0264701 0.0083094 0.0118369 0.0135165 0.00523223 0.119495 0.0520637 0.0510376 0.103177 0.105097 0.00682252 + 0.0284219 0.0285434 0.0287541 0.00813433 0.0954232 0.0962628 0.0141969 0.0267003 0.0260467 0.0322164 0.0688463 0.120379 + 0.118753 0.0219167 0.0211781 0.0230179 0.0770327 0.0176536 0.0112925 0.0111365 0.011294 0.107891 0.00891632 0.0982278 + 0.0168311 0.0169435 0.0366233 0.020849 0.0214964 0.0207723 0.00884685 -0.00327299 0.06349 0.0633064 -0.00687128 0.0251641 + 0.0182403 0.00460645 0.00450814 0.00700143 0.00127881 0.0541985 0.0107163 0.0140128 0.0327366 0.0135849 0.0642636 0.065369 + 0.109029 0.0157383 0.00949338 0.0532736 0.0990225 0.0133967 0.0753927 0.0141286 0.014004 0.0017915 0.059111 0.00111132 + 0.00806963 0.00817203 0.00825846 -0.0055516 0.00686603 0.00574347 0.0234277 0.069188 0.0121964 0.0101792 0.0618057 0.0554913 + 0.0264459 0.0268255 0.0263647 0.0240609 0.0238688 0.0219756 0.0218365 -0.00319622 0.0220201 0.0268768 -0.00779975 0.0244732 + -0.00113041 0.024328 0.0293585 -0.00231762 0.0025005 0.104742 0.0105531 0.0145194 0.0121095 0.0345949 0.0336597 0.0334912 + 0.0137673 0.0855199 0.0028391 0.066805 0.0278321 0.00147365 0.0350284 0.00806422 0.00934057 0.00882581 0.0357562 0.0414855 + 0.0801863 0.0268142 0.0138478 0.0377098 0.00800106 0.0284563 0.0289669 0.0287344 0.0279685 0.0117761 0.00411131 0.00411742 + 0.00426843 0.0196593 0.0471612 0.0764886 0.0280911 0.0256321 0.0265548 0.0290508 0.0288605 0.0291423 0.0678507 0.0536113 + 0.0533055 0.0548402 0.00336091 0.0194498 0.0202876 0.0202394 0.0726851 0.0027824 0.0164968 0.00930335 0.028577 0.0172922 + 0.0623927 0.0263976 -0.00753279 0.00241811 0.0076412 0.0204846 0.010153 0.107795 0.0471791 0.0481358 0.0462539 0.0016851 + 0.00991988 0.112328 0.108528 0.0284329 0.0287161 0.0286387 0.0223482 0.0715745 0.0105382 0.029408 0.0292512 0.0295173 + 0.0712558 0.0727917 0.026247 0.0267382 0.0879618 0.0163062 0.0183047 0.0178785 0.00917301 0.00446868 0.0254801 0.0639071 + 0.027733 0.0285214 0.0720729 0.105352 0.10428 0.10696 0.0380604 0.0129407 -0.00468108 0.0607769 0.0611112 0.0612416 + 0.104998 0.105629 0.107246 0.0128228 0.0288461 0.0229196 0.0273771 0.0194857 0.00797496 0.00376409 0.0335042 0.0330999 + 0.0160485 0.0440305 -0.00393636 0.0620482 0.062054 0.061888 0.0112198 0.0486433 0.040871 0.0283844 0.00959398 0.00852518 + 0.0146051 -0.00712328 0.021431 0.0293397 -0.00686931 -0.00760005 -0.00532075 0.0280724 0.0634616 0.0156164 0.0713868 0.0147931 + 0.0293653 0.0189029 0.02838 0.028591 0.061512 0.0153278 0.0154626 0.0831498 0.0259976 0.0260401 -0.00145919 0.0285789 + 0.031328 0.0410738 0.0269732 0.026815 0.0969362 0.0248121 0.0135906 0.0140754 -0.00590858 0.0135751 0.00876854 0.119364 + 0.118201 0.0208801 0.0206727 0.0207394 0.0382916 0.0687082 0.0267332 0.00945794 0.00948244 0.0216483 0.105815 0.0784583 + 0.0207211 0.0166197 0.0170571 0.0164689 0.0584964 0.0117224 0.0223673 0.0257602 0.0775934 0.0792535 -0.00450397 0.0266926 + 0.0266642 0.026889 0.0176949 0.0234147 0.0033837 0.0135309 0.0136555 0.0238534 0.0360354 0.0275135 0.0276991 0.0277106 + 0.0764166 0.0757665 0.0537527 0.053874 0.0182944 0.0070128 0.111699 0.00177413 0.0156527 0.01524 0.0155727 0.00933286 + 0.0335341 0.000705845 0.0571996 0.00770857 0.0110181 0.0289265 0.0264748 0.00375752 0.00374713 0.0634197 0.0913161 0.0998311 + 0.014818 0.0174316 0.0225115 0.0833849 0.100007 0.0653129 0.0654221 0.075854 0.0919346 0.0569035 0.0554847 0.0570024 + 0.0448637 0.0465493 0.00954962 0.00226597 0.00118047 0.00236614 0.025511 0.0125852 0.0134079 0.0141088 0.0291313 0.00667606 + 0.00670467 0.0349952 0.0330878 0.0720098 0.0343615 -0.00237596 0.0138648 0.0108477 0.0254471 0.0255835 0.0255223 0.0105348 + 0.00926394 0.0925037 -0.00210851 0.0279086 0.0278814 0.0281226 0.0270769 0.026937 0.0620147 0.0193149 0.0192164 0.0158895 + 0.0281635 0.00600759 0.0254492 0.0317864 0.031471 0.0703996 0.0697429 0.0282121 0.0284928 0.00314166 0.0527049 0.00229379 + 0.00342138 -0.00798271 0.0464912 0.0480476 0.0602193 0.0602304 0.0592828 0.0256562 0.0164703 0.0246306 0.0247142 0.0245368 + 0.0246822 0.0147508 0.0153608 0.0150479 0.0274272 0.0273973 0.0272491 0.0039835 0.0659605 0.00507852 0.0349512 0.0320726 + 0.0513542 0.0515934 0.0500463 0.0586091 -0.00108696 0.0302279 0.0309782 0.0306671 0.00917125 0.00913977 0.00901846 0.0296794 + 0.0271624 0.027344 0.0424632 0.0261104 0.0261159 0.0259707 0.0332843 0.0147147 -3.96332e-05 0.0544165 0.00688173 0.0464274 + 0.0451994 0.00343813 0.0194884 0.019291 0.0193733 0.0791302 0.0741776 0.0374227 0.038209 0.0282201 0.0629279 0.00585555 + 0.0221246 0.0222945 0.0138893 0.0363771 0.0304629 0.0305273 0.022832 0.0112924 0.00499317 0.00462384 0.0289798 0.0292796 + 0.0109911 0.00546781 0.00600052 0.0120061 0.017045 0.0860304 0.088737 0.0869581 0.0134694 0.00606453 0.00642402 0.0138027 + 0.00641383 0.056806 0.0557883 0.0435431 0.0167734 0.0166037 0.016702 0.00520055 0.0219378 0.0537589 0.0928523 0.0654459 + 0.0296065 0.034333 0.0108788 0.0858473 0.110209 0.0737147 0.023098 0.00451425 0.036078 0.0210299 0.0175818 0.0183101 + 0.0936593 0.0104664 0.0086284 0.00911586 0.0100694 0.00693208 0.0872009 0.0878693 0.0857962 0.0449129 0.0265367 0.0265925 + 0.0648965 0.0318492 0.0321813 0.0328983 0.0879709 0.0679257 0.021153 0.123217 0.0310638 0.0307801 0.0289564 0.0635195 + 0.0528906 0.02176 0.00910808 0.0686809 0.0675483 0.0679773 -0.00020969 0.00764415 0.015921 0.0928253 0.0154664 0.0160309 + 0.0158187 0.0689477 0.0668704 -0.00177735 0.0258129 0.0479327 0.0493828 0.00795542 0.0284123 0.0284408 0.0287457 0.0607578 + 0.0632216 0.0297228 0.0304306 0.0303264 0.00437844 0.00337795 0.00352263 0.0302905 0.0163524 0.0158937 0.0109467 0.0113845 + 0.0200319 0.0202177 0.0201681 0.0469946 0.00158926 0.0616831 0.0610424 0.0612165 0.0111751 0.00393041 0.0452974 0.0466575 + 0.0447627 0.00280975 0.0268423 0.0776398 0.076593 0.0774391 0.00582136 0.0215433 0.0230951 0.0217773 0.0772644 0.0146143 + 0.0149996 0.0372318 0.0192325 0.0270508 0.0266558 0.0165298 0.00210958 0.00314175 0.0999172 0.0747668 0.061388 0.0783382 + 0.0280888 0.0147942 0.0620621 0.0596739 0.0728587 0.0112692 0.0236786 -0.00977691 -0.0113321 0.0171002 0.0874634 0.0903196 + 0.0658701 0.0644476 0.0168547 0.1008 0.0243749 0.0237374 0.0626283 0.00885967 0.00930879 0.062138 0.0628394 0.00601024 + 0.109631 0.0791304 0.0966474 0.0918463 0.0792755 0.0818421 0.0821942 0.0246058 0.024749 0.0247519 0.0776638 0.00447559 + 0.0148571 0.0871957 0.00748262 0.0160864 0.091119 0.0784151 0.0371513 0.0121033 0.0390761 0.0770746 0.029805 0.0298397 + 0.018112 0.0127671 0.0169567 0.0198135 0.0198692 0.0197029 0.0109633 0.0113962 0.0351009 0.0158523 -0.00483791 -0.00470363 + 0.0472871 0.0824871 0.0173503 0.0172268 0.0171897 0.0342399 0.0628549 0.0289846 0.0292025 0.0896075 0.0929753 0.0519646 + 0.0635306 0.00568811 0.0109132 0.0175843 0.0174611 0.0301139 0.0118197 0.0141844 0.0140611 0.0269866 0.0184988 0.0183691 + 0.0183563 0.02393 0.0139257 0.0136544 0.0574201 0.00999468 0.0282806 0.0280311 0.0281923 0.0339734 0.0963516 0.0106636 + 0.0279839 0.0280304 0.026441 0.0248928 0.068003 0.0694293 0.00905614 0.0063207 0.00712237 0.0858635 0.0843843 0.0266276 + 0.0446224 0.0140161 0.0238278 0.0235735 0.102231 0.0828265 0.0169371 0.0971233 0.0943979 0.0943444 0.00955463 -0.00511604 + 0.0882828 -6.42743e-05 0.000571881 0.0203043 0.0175273 0.0172401 0.0165153 0.010943 0.022658 0.023614 0.0234361 0.023625 + 0.0685952 0.0291681 0.0104994 0.0134543 0.0185724 0.00977799 0.0146676 0.00652344 0.0103704 0.0142032 0.0304649 0.030388 + 0.0114334 0.0605255 0.0276759 0.027563 0.0590723 0.0863069 0.105828 0.0261464 0.0173749 0.0173899 0.0246183 0.0244555 + 0.110134 0.0894976 0.0107269 0.0204726 0.0414493 0.0594217 0.0600642 0.0623646 0.0183138 0.0988484 0.0194572 -0.0011948 + 0.00754546 0.0617709 0.062352 0.0680333 0.0788877 0.0142481 0.0131124 0.0137469 0.0335454 0.0140695 0.0187474 0.0028165 + 0.0262579 0.0262897 0.0261886 0.0262431 0.0130995 0.0391118 0.0268703 0.0267781 0.0294331 -0.00564417 0.00983562 0.0281713 + 0.0285167 0.0114638 0.0273941 0.0275343 0.0276293 0.062956 0.0133811 0.00803681 0.000307649 0.0281532 0.0643044 0.0261061 + 0.0263188 0.0261707 0.0292269 0.0290796 0.0293268 0.0375639 0.0405282 0.0391821 0.0277552 0.0290405 0.00710716 0.0886233 + 0.0282438 0.114037 0.0375718 0.0379608 0.0395994 0.0223686 0.0221471 0.0295423 0.0303755 0.0109778 0.0154645 0.0152163 + 0.00324491 0.0692825 0.0603638 0.0782355 0.011929 0.0805551 0.0323663 0.0194823 0.00845744 0.0133723 0.0251789 0.0599431 + 0.0458363 0.0188058 0.017991 0.00249638 0.00790257 0.0168775 0.027428 0.0294637 0.0279316 0.0218499 0.0221604 0.0237541 + 0.0207143 0.0784001 0.0783465 0.0142126 0.0139998 0.0062872 0.0893179 0.0284436 0.0283402 0.0285985 0.0790909 0.020461 + 0.114005 0.0546552 0.0115286 0.0813994 0.0195136 0.00468207 0.0250189 0.016029 0.0137774 0.0308638 0.0192264 0.019311 + 0.00476659 0.00472045 0.00460464 0.0139453 0.017256 0.0248103 0.0884401 0.0866321 0.0371023 0.00602647 0.063137 -0.00804885 + 0.0626126 0.00614496 0.00629781 0.0770724 0.00453104 0.0861518 0.0487851 0.0485007 0.039766 0.0272818 0.02719 0.026635 + 0.0235305 0.0480858 0.0189497 0.058248 0.012714 0.0832877 0.0672755 0.0255253 0.0266782 0.0263343 0.0296704 0.0283537 + 0.0285179 0.0390444 0.0197757 0.0190326 0.0274667 0.0277825 0.0278324 0.0136183 0.0132873 0.0200465 0.0779783 0.0304329 + 0.0309142 -0.00851241 0.0117222 0.0637277 0.0327474 0.0615177 0.061976 0.00174035 0.0142472 0.0220469 0.0218577 0.0771772 + 0.00274391 0.0154048 0.0502294 0.0280958 0.0149949 0.00203996 0.0235845 0.0237866 0.0236781 0.0223887 0.0936518 0.0162058 + 0.0156832 0.0163489 0.0325222 0.000656195 0.000561422 0.000490068 0.0142553 0.0235963 0.0383439 0.0524328 0.0186263 0.01854 + 0.0187195 0.000222392 0.0192855 0.0407733 0.0391524 0.0214561 0.0148116 0.0149562 0.0146799 0.0295769 0.0156973 0.024431 + 0.0244736 0.0734253 0.0243506 0.0237215 0.0238852 -0.00815006 -0.00913505 0.0175136 0.0126294 0.0179147 0.0179715 0.0172017 + 0.0799258 0.082428 0.0598737 0.0598855 0.00553025 0.0961127 0.0661724 0.0300613 0.0299143 0.00306854 0.0256522 0.0140219 + 0.0205848 0.0617328 0.0133099 0.0204339 0.0195209 0.029581 0.0294292 0.0293436 0.0270724 0.0358729 0.0342325 0.00347932 + 0.0149874 -0.00349972 0.0234237 0.0656932 0.0259451 0.0259983 0.0258083 -0.000728344 0.076882 0.0281363 0.0624132 0.0509469 + 0.0495362 0.0451254 0.0817354 0.0301327 0.0281725 0.0283851 0.0283664 0.0418319 0.0436285 0.0439959 0.0436737 0.0312895 + 0.0262873 0.0331719 0.00425109 0.0631709 0.0125219 0.039006 0.0235623 0.0235427 0.0295054 0.0263155 0.0136661 0.103162 + 0.0268486 0.0266137 -0.000776491 0.0149879 0.0238063 0.0134647 0.0193726 0.042183 0.0273268 0.0275328 0.0274592 0.101391 + 0.00255041 0.0275518 0.0276871 0.0275083 0.019943 0.00457632 0.0168951 0.0415465 0.0396353 0.0347101 0.0171894 0.0136088 + 0.0942341 0.0172461 0.0166223 0.0242659 0.078699 0.0253022 0.0272002 0.00663227 0.0304786 0.0178806 0.013721 0.0276229 + 0.0277351 0.0249875 0.00333151 0.0255983 0.0257274 0.021634 0.0223927 0.0214031 0.086596 0.0262379 0.0920668 0.0635284 + 0.0621705 0.0738964 0.0902151 0.0636076 0.0047529 0.00568099 0.0600474 0.0688037 0.0678201 0.0271189 0.0766599 0.025769 + 0.0751367 0.0755384 0.076323 0.0715496 -0.00339931 0.0879091 0.0890046 0.0281964 0.0319032 0.108519 0.103496 0.0587685 + 0.0098245 0.0664548 0.0679545 0.0267942 0.0314763 0.0186965 0.0528085 0.0525501 0.0518973 0.0274715 0.0142191 0.024183 + 0.0849763 0.0888243 0.0258748 0.0263294 0.0262598 0.0148976 0.0152867 0.0149237 0.0425695 0.0550508 0.0538782 0.0269145 + 0.0670127 0.0310399 0.0305953 0.029556 0.0303652 0.00978028 0.0750504 0.0674344 0.00235481 0.0303186 0.0164127 0.0844872 + 0.0695102 0.00291649 0.00302251 0.00289303 -0.00290661 0.0600686 0.0396627 0.0385165 0.0630451 0.111611 0.0271172 0.0849277 + 0.0850844 0.0119547 0.0131627 0.0262633 0.0990855 0.0394279 0.0711611 0.0268361 0.0268279 0.038524 0.0665886 0.0612856 + 0.078373 0.0253016 0.0295168 0.0297084 0.0265612 0.0267405 0.0272651 0.0271774 0.0187335 0.0544167 0.0538469 0.0700769 + 0.00800396 0.0405653 0.0412755 0.0387606 0.111943 0.00379725 0.00396631 0.00386659 0.0140336 0.0290394 0.0292963 0.0245022 + 0.00626515 0.00453116 0.019944 0.0284101 0.013061 0.0238523 0.0265354 0.0249799 0.0248478 0.0243671 0.0349287 0.034301 + 0.06377 0.0626213 0.0316778 0.114179 0.0171667 0.00910298 0.0645422 0.0642632 0.0151491 0.0261774 0.0301152 0.028936 + 0.0286598 0.0559965 0.0225715 0.0838175 0.0292267 0.0292364 0.0634157 0.0585496 0.0187031 0.0629511 0.0258929 0.0255686 + 0.0269255 0.0269395 0.0270383 0.0268355 0.0263324 0.0264388 0.0265413 0.0288637 -0.00342412 0.00676267 0.00672202 0.013863 + 0.121012 0.0809875 0.020556 0.0209281 0.00299932 0.00309838 0.00297425 0.00897696 0.0226893 0.0285702 0.0800637 0.0709677 + 0.0262224 0.0263077 0.026096 0.0801522 0.0185531 0.0554442 0.0217492 0.0339639 0.00860886 0.026682 0.0284766 0.0203419 + 0.0235219 0.0727705 0.0205532 0.0207992 0.0203185 0.029508 0.0293687 0.0296697 0.0263937 0.0703478 0.00805651 0.00793991 + 0.00790674 0.00650299 0.0183454 0.0743007 0.0187711 0.00385741 0.0268818 0.026755 0.0266021 0.0275752 0.079197 0.101149 + 0.102347 0.0252782 0.0251182 0.0251906 0.0130565 0.0828755 0.0213272 0.0262632 0.0224709 0.0666296 0.067913 0.00904868 + -0.00306461 0.0285833 0.0151553 0.0135256 0.0164663 0.0207533 0.0732491 0.0981236 0.0385624 0.0720004 0.0143747 0.0150528 + 0.0146029 0.01741 0.0170258 0.0635279 0.0193697 0.122929 0.125042 0.0153402 0.0291513 0.0250871 0.0247672 -2.15572e-06 + 0.0192067 0.0240338 0.0242132 0.0266516 0.0138866 0.025246 0.0249074 0.0246635 0.0280361 0.028296 0.0282684 0.0227062 + 0.0417922 0.0518835 0.0511731 0.0503418 0.0645122 0.0661716 0.11613 0.0160385 0.0301299 0.00423748 0.0162411 0.0670635 + 0.0206748 0.0344715 0.0190479 0.0354987 0.040026 0.0705746 0.0216659 0.0791933 0.0782606 0.0196443 0.0264467 0.0776049 + 0.0268433 0.0268411 0.0267887 0.010959 0.0368954 0.0277814 0.027605 0.0277565 0.0784673 0.0271961 0.0256728 0.0262916 + 0.026116 0.0817621 0.0138247 0.0387527 0.0379241 0.0250611 0.0255984 0.00200803 0.0134664 0.00891045 0.0760814 0.0774928 + 0.0152325 0.0259973 0.0206752 0.07438 0.075107 0.0553451 0.0484707 0.0125389 0.025767 0.00985062 0.0267589 0.0259557 + 0.0117451 0.00768615 0.030124 0.0847323 0.0353895 0.0331875 0.0603612 0.0264805 0.0345484 0.0735792 0.0490885 0.037696 + 0.0318168 0.0283437 0.0285221 0.0288407 0.0184189 0.0269866 0.0268459 0.0270285 0.0581453 0.0303345 0.0177018 0.0084653 + 0.00840066 0.00854803 0.0254016 0.0253115 0.0131618 0.00670342 0.0156858 0.0171536 0.0170435 0.0169859 0.0174141 0.0185474 + 0.0222489 0.0215843 0.0592929 0.0183642 0.0300238 0.0174208 0.0623147 0.0618258 0.0619709 0.0265826 0.0271089 0.0269661 + 0.030665 0.0688846 0.00079808 0.0703085 0.0246467 0.029906 0.049719 0.0100324 0.010676 0.0621747 0.0792184 0.0166546 + 0.0664044 0.0656619 0.0242991 0.0236874 0.0850281 0.0128965 -0.00233263 0.040705 0.0528873 0.0264248 0.0264361 0.0264051 + 0.0456492 0.0283432 0.0505036 0.126127 0.0292317 0.0389789 0.0262659 0.0590091 0.0445556 -0.00118322 0.000113123 0.062269 + 0.0511255 0.0253582 0.0254366 0.0507963 0.025899 0.0258335 0.026023 0.0258573 0.0556987 0.0621976 0.0260079 0.0259705 + 0.0259437 0.0203111 0.0302835 0.0266476 -0.00414165 0.0163512 0.016538 0.0164029 0.0643269 0.0137478 0.0722233 0.0401562 + 0.0165435 0.0167027 0.0105147 0.0270363 0.0236803 0.019427 0.048292 0.0465902 0.0478455 0.0251418 0.0332496 0.0340536 + 0.01509 0.0113573 0.011444 0.0666189 0.00614043 0.00611583 0.00599615 0.0224132 0.117429 0.0255272 0.00263114 0.076646 + 0.0781828 0.0799128 0.0284289 0.0205002 0.0142428 0.0134026 0.0621088 0.0615877 0.0253184 0.0274709 0.0564756 0.0048165 + 0.0311642 0.0267116 0.013707 0.00841018 -0.00508625 0.0211077 0.0689068 0.0271621 0.0175222 0.0089746 0.0274725 0.0159879 + 0.0101567 0.0209839 0.0272108 0.0115191 0.0474893 0.013148 0.0259166 0.0233576 0.0144785 0.0863261 0.0861732 0.00323605 + 0.0579923 0.0578707 0.117386 0.118222 0.0286764 0.0288215 0.0533585 0.0516322 0.0259667 0.0259167 0.0260789 0.0260288 + 0.0262556 0.0288035 0.0229091 0.0193686 0.0192246 0.0272032 0.0274298 0.0266347 0.0264626 0.0405555 0.0269362 0.0412805 + 0.0260774 0.0263068 0.0262367 0.0244578 0.0243411 0.0182507 0.00647284 0.0561592 0.0246432 0.00501903 0.0910096 0.0722461 + 0.0127543 0.0168651 0.0240342 0.0239466 0.0670416 0.0300355 0.045882 0.0119351 0.027182 0.021212 -0.00496772 0.0118306 + 0.0143571 0.0131137 0.0171283 0.0169917 0.0163898 0.0181686 0.0300638 0.0184146 0.0334624 0.0277473 0.0275544 0.00341148 + 0.0439393 0.0206757 0.0687697 0.068564 0.0698942 0.0238045 0.0277172 0.0283751 0.0269551 0.0228157 0.0226055 0.0650922 + 0.0271474 0.0254785 0.0708499 0.0790061 0.0500891 0.0480002 0.0164753 0.0398436 0.0266751 0.0039505 -0.00598927 0.0104988 + 0.0442165 0.0243811 0.0461411 0.0515422 0.0498549 0.0285261 0.0238532 0.0518672 0.0114108 0.0391252 0.0391983 0.0736897 + 0.0134986 -0.0057118 0.0805571 0.0222209 0.0216756 0.0259992 0.0446049 0.0234512 0.0234554 0.0236334 0.0284872 0.0704466 + 0.0242001 0.0240638 0.0674134 0.0186676 0.0153957 0.0281499 0.0181605 0.0611097 0.0259213 0.0281125 0.0279471 0.0141356 + 0.0142553 0.0737192 0.0302302 0.0297991 0.0295262 0.0297094 0.0153318 0.0416225 0.0217832 0.0848659 0.0231325 0.0388013 + 0.0295867 0.0190178 0.0778588 0.0785415 0.0630263 0.0275243 0.0272768 0.0548244 0.0095842 0.0225252 0.0250771 0.0264853 + 0.0155072 0.0270809 0.0267331 0.0693414 0.0296665 0.027694 0.0274587 0.0276631 0.0246892 0.024528 0.0372306 0.0275936 + 0.000331491 0.000330582 0.0288306 0.0182961 0.0432144 0.0619795 0.00468226 0.0456745 0.0760625 0.0476117 0.00168885 0.0558144 + 0.0239523 0.0288628 0.0732716 0.0573822 0.0276112 0.0278628 0.0899051 0.089844 0.0919806 0.0190127 0.0420938 0.000684928 + 0.00213201 0.0535057 0.0538091 0.0267462 0.0594673 0.0229434 0.027916 0.0197007 0.046941 0.0451829 0.0166557 0.0344736 + 0.0667293 0.0221146 0.0213987 0.021626 0.0295969 0.0630703 0.0627167 0.0289397 0.0231022 0.0629985 0.0264834 0.0258411 + 0.025712 0.0608547 0.0264679 0.0301816 0.0269448 0.011338 0.0587414 0.0254294 0.0252205 0.0253334 0.0238469 0.0275583 + 0.0874011 0.0217664 0.0504303 0.0487151 0.0168069 0.0174424 0.0170208 0.0142312 0.009998 0.0264936 0.0114848 0.0237807 + 0.024061 -0.00623881 0.0667827 0.0270985 0.0352608 0.0266878 0.0265722 -0.00394317 0.0269862 0.0395644 0.0185275 0.00468184 + 0.0284173 0.0279893 0.00235139 0.0164314 0.0269985 0.027091 0.00428076 0.066893 0.0268447 0.0154358 0.025954 0.0260644 + 0.0261379 0.0264868 0.0491814 0.0165784 0.02727 0.00405658 0.0285484 0.0281902 0.0162106 0.0288469 0.0286893 0.0273269 + 0.0116069 0.0552096 0.0153731 0.0263239 0.0185845 0.0622775 0.0251843 0.0168362 0.118019 0.0195324 0.0405624 0.0302518 + 0.024844 0.0253665 -0.00314803 0.0274003 0.0275502 0.022 0.0159957 0.0159504 0.0274322 0.012649 0.0127149 0.0277662 + 0.0280232 0.0214685 0.025504 0.0252005 0.0255505 0.0265813 0.0266796 0.0276368 0.00462841 0.062503 0.0261461 0.0261292 + 0.069656 0.01255 0.0168221 0.0104407 0.0274788 0.0152326 0.018784 0.0769041 0.0250239 0.0248546 0.0249275 0.0646814 + 0.0183824 0.0185601 0.025022 0.00597156 0.0614955 0.0109802 0.0389791 0.0257982 0.0264366 0.0149076 0.000180882 0.0239179 + 0.0184889 0.0177017 0.0236307 0.0234455 0.0541944 0.0232737 0.0279639 0.0278847 0.0410004 0.0190751 0.0261353 0.0116684 + 0.0543892 0.0630728 0.0260999 0.0154863 0.0272651 0.0270672 0.0271865 0.0269185 0.026889 0.0053746 0.015157 0.0234521 + 0.00618602 0.0248178 0.0674596 0.0676509 0.0664368 0.0267968 0.0264871 0.0264961 0.0267023 0.023551 0.0232805 0.00434586 + 0.00449199 0.0117664 0.0491427 0.0238484 0.0280441 0.0264866 0.0264117 0.0262919 0.0113299 0.0157452 0.028771 0.054125 + 0.0284233 0.0282478 0.027963 0.0349343 0.0233404 0.0939894 0.0268558 0.0736974 0.0747212 0.00240709 0.0550457 0.0189856 + 0.00225333 0.00236087 0.00223754 0.128083 0.0211088 0.0211593 0.0124785 0.117964 0.0302052 0.0277848 0.0263185 0.00210351 + 0.0266396 0.0267672 0.0266902 0.0694768 0.0374319 0.0226266 0.0226096 0.0224484 -0.009579 0.0232865 0.0224678 0.0274398 + 0.00793632 0.0242577 0.0858267 0.0146184 0.0202182 0.0301687 0.0302822 0.0297871 0.0296007 0.0562924 0.0176174 0.0586852 + 0.0227979 0.022701 0.0268084 0.0243147 0.061296 0.0586146 0.0587157 0.0592993 0.0170517 -0.00654039 0.0267848 0.00612737 + 0.00212671 0.0103684 0.0287763 0.0245991 0.0242553 0.0273566 0.0274186 0.027437 0.0275437 0.011297 0.0151816 0.0253392 + 0.0568013 0.0258921 0.0104467 0.0110573 0.0313056 0.0298598 0.0333488 0.0287001 0.0581996 0.0421855 0.0533542 0.0541274 + 0.0268961 0.00294424 0.00284238 0.0280595 0.0455945 0.0290439 0.0287623 0.0192471 0.0246035 0.0246104 0.0244546 0.0221511 + 0.0223081 0.0221296 0.0221071 0.022288 0.0222687 0.0283281 0.0140148 0.0111031 0.0276937 0.0277674 0.0232667 0.0230927 + 0.0232743 0.0299956 0.0299052 0.0297728 0.0284917 0.0122899 0.0657716 0.0118008 0.0238782 0.0260056 0.0260362 0.0723293 + 0.0290104 0.0172412 0.0907569 0.061074 0.0613426 0.0286672 0.0284802 0.015001 0.0645774 0.0279971 0.0205769 0.0229091 + 0.0230837 0.0269957 0.0110392 0.0506166 0.00644893 0.00659516 0.00651958 0.00727746 0.0260068 0.0021335 0.0124241 9.01431e-08 + 0.0264316 0.0359414 0.00138077 0.00820311 0.0271398 0.00687962 0.0872066 0.0298244 0.00596421 0.00604085 0.00611258 0.0271518 + 0.0281509 0.0267912 0.00630041 0.0098593 0.0608164 0.0268788 0.0267161 0.117234 0.000114556 0.0302496 0.0277571 0.0264255 + 0.0269251 0.0267431 0.0267796 0.0268839 0.026609 0.0207122 0.00201613 0.0271399 0.0271809 0.0262831 0.0172568 0.0132158 + 0.0241743 0.0345702 0.0217539 0.0218918 0.0217085 0.0277858 0.0171877 0.0152862 0.0156094 0.056511 0.0288705 0.0119734 + 0.0152576 -0.000226834 0.000101118 5.69432e-05 0.0269947 0.0264215 0.00815366 0.00927978 0.0286142 0.0270486 0.0260616 0.0273254 + 0.0274778 0.0271711 0.0272235 0.0279332 0.00340799 0.00352203 0.0273735 0.0157771 0.0670504 0.0167156 0.0273839 0.0276867 + 0.0626074 0.0627071 0.0279552 0.0281416 0.0227847 0.0292578 0.0173929 0.0269491 0.0207599 0.0268384 0.0123738 0.0128936 + 0.012445 0.0127036 0.0290692 0.027284 0.0276077 0.107682 0.0140297 0.0305961 0.0299432 0.0215086 0.021649 0.0214524 + 0.0282779 0.0279434 0.0266928 0.0266313 0.0105766 0.00739581 0.0103866 0.0126728 0.0172673 0.0285361 0.0293263 0.0265575 + 0.0127359 0.0127238 0.0128483 0.0301781 0.0650171 0.0210923 0.00963166 0.0273175 0.0271937 0.0274371 0.0281784 0.00202988 + 0.02783 0.0271374 0.0659195 0.0301505 0.0253284 0.0147526 0.0817351 0.0258474 0.0260173 0.0112548 0.0530876 0.0567475 + 0.0288485 0.0292809 0.0288623 0.0250413 0.0290089 0.0283868 0.0287703 0.0124019 0.054386 0.0238296 0.023795 0.0121999 + 0.0280845 0.0283469 0.0281836 0.0255199 0.0256872 0.0609584 0.0612427 0.0261768 0.0393631 0.0121392 0.0299245 0.0300822 + 0.0644006 0.0662158 0.074728 0.0720772 0.0736412 0.0248933 0.0276615 0.0274741 0.0277304 0.026554 0.025101 0.0257589 + 0.0257152 0.0345568 0.0282302 0.0284855 0.00190391 0.00884491 0.0268322 0.0129832 0.0290263 0.0259724 0.0606458 0.0634392 + 0.116431 0.0332958 0.0619176 0.00778389 0.0176823 0.0287354 0.0291328 0.0139883 0.0273637 0.0271992 0.0273589 0.0495025 + 0.0281541 0.0840456 0.0274449 0.0159426 0.0298603 0.0270852 0.0413739 0.0662995 0.0272664 0.0275314 0.027743 0.0076152 + 0.0265837 0.02673 0.0522379 0.0264798 0.0226456 0.0228211 0.0228036 0.0385395 0.0256387 0.0303939 0.0303314 0.0583259 + 0.0573842 0.0301545 0.03001 0.0299329 0.0694612 0.022198 0.0615338 0.0082997 0.0264669 0.0575115 0.0266865 0.00453039 + 0.0043816 0.00441469 0.0545679 0.0536628 0.0241394 0.024298 0.0243004 0.0593083 0.0253954 0.0253589 0.0255295 0.0272644 + 0.0274989 0.0279579 0.00659971 0.0287289 0.026804 0.0228976 0.0228834 0.0227119 0.0138462 0.0271663 0.0270216 0.0271759 + 0.0262717 0.0264595 0.0821745 0.0189815 0.0302843 0.0230729 0.0278679 0.0843318 0.0304483 0.0186693 0.0188593 0.0252326 + 0.025121 0.0250151 0.0298727 0.060299 0.0303411 0.0301866 0.0276731 0.0302466 0.0300831 0.0263016 0.02644 0.022833 + 0.0226617 0.0227242 0.0321325 0.0593454 0.027451 0.0274131 0.0274809 0.0226957 0.0624675 0.00191272 0.0145571 0.0229159 + 0.0782287 0.0311306 0.0638717 0.0776465 0.0244568 0.0225243 0.000206148 0.0234574 0.00838616 0.0119283 0.0125859 0.024176 + 0.0276995 0.0228743 0.0262489 0.0261667 0.0263479 0.0212545 0.0213122 0.0270469 0.0652584 0.0833963 0.083961 0.0199754 + 0.0199465 0.019793 0.0634307 0.0278572 0.0022308 0.00106338 0.0225394 0.0295947 0.0265537 0.0457921 0.0474298 0.0287783 + 0.028751 0.0270323 0.00179392 0.0119837 0.0124103 0.029228 0.0291462 0.0223538 0.0269897 0.0271781 0.0293639 0.029762 + 0.0298143 0.00774663 0.00779433 0.0277594 0.0559995 0.0545511 0.0621262 0.0629579 0.0275087 0.0276379 0.0278351 0.00281007 + 0.0211155 0.0265783 0.0269364 0.0264273 0.0302528 0.0132954 0.00789035 0.114073 0.00832645 0.0298113 0.021059 0.0274902 + 0.0593271 0.00945878 0.0265717 0.0301027 0.026336 0.0793393 0.0136833 0.0607027 0.0250029 0.0617473 0.0259976 0.00478502 + 0.00463008 0.00467267 0.0304329 0.0265359 0.026503 0.0303698 0.0146238 0.0277312 0.0279163 0.0614033 0.0644364 0.0249441 + 0.0276449 0.0357192 0.0143737 0.026956 0.0623884 0.0271119 0.0270922 0.0272005 0.0285383 0.017884 0.060754 0.0627191 + 0.0266813 0.0233757 0.0249113 0.029595 0.0296342 0.0225215 0.020864 0.0209198 0.0617325 0.000274089 0.000413882 0.00028613 + 0.0270216 0.0128948 0.013648 0.026576 0.0289803 0.0240825 0.0257477 0.00751714 0.0388423 0.0329224 0.0366429 0.0269009 + 0.0632445 0.0294053 0.0294397 0.0274886 0.0275293 0.0305001 0.0206656 0.0279661 0.00738698 0.0449106 0.0458663 0.0310786 + 0.0270447 0.00306493 0.0218494 0.00180903 0.0288407 0.0289402 0.0246502 0.0244706 0.0245443 0.026978 0.0319156 0.0270132 + 0.0265751 0.0265801 0.0266984 0.027421 0.0110622 0.0287027 0.0270042 0.0207247 0.0255769 0.0289947 0.0215689 0.0292238 + 0.0328007 0.0294499 0.0502808 0.0267036 0.00397936 0.0435725 0.0443738 0.0241414 0.0240296 0.0269185 0.0224555 0.0614595 + 0.0206696 0.0289192 0.0269019 0.0149388 0.0291317 0.0270305 0.0268752 0.0270051 0.0274463 0.0279464 0.0281444 0.0282189 + 0.0273567 0.0135418 0.0260287 0.00896977 0.0231337 0.00168198 0.0629563 0.0491056 0.0476002 0.0467734 0.026 0.0267063 + 0.07635 0.0205304 0.0289996 0.027754 0.0266194 0.0266495 0.0204763 0.0117089 0.0269246 0.0067146 0.0129986 0.0125671 + 0.0179955 0.0247289 0.0300974 0.0244546 0.0198212 0.0623281 0.0287596 0.0474373 0.0337788 0.0120923 0.0279094 0.0281379 + 0.0251902 0.106476 0.0260133 0.0261197 0.111292 0.0116603 0.0798501 0.0613826 0.0045612 0.0273469 0.0189076 0.0179702 + 0.0199636 0.0261002 0.0268529 0.0116038 0.020423 0.0206156 0.00374209 0.00362682 0.0131694 0.0222605 0.0223231 0.00257148 + 0.0292591 0.0291552 0.0294058 0.0261575 0.0260605 0.0480562 0.0097033 0.0257772 0.0282841 0.0280637 0.029633 0.0265617 + 0.0265552 0.0255047 0.0123821 0.0267831 0.0196127 0.0197656 0.0210164 0.0201287 0.0277803 0.0278186 0.0290822 0.0289927 + 0.0142144 0.0271998 0.0268138 0.0272023 0.0265272 0.0265215 0.0304222 0.0257312 0.0259472 0.022324 0.0269396 0.0216637 + 0.0217248 0.0285614 0.0484699 0.0219719 0.0219487 0.0217911 0.0273648 0.026262 0.029756 0.0299388 0.0298467 0.0290888 + 0.0260357 0.00350558 0.0205625 0.0289447 0.0203709 0.0845048 0.0314081 0.0263448 0.0291215 0.0284895 0.0282158 0.0441103 + 0.0272052 0.0250127 0.028757 0.060053 0.0637844 0.0637694 0.0637862 0.0260628 0.0259712 0.0287549 0.0288555 0.0366368 + 0.0288758 0.0290743 0.00362594 0.0636654 0.0280505 0.0263844 0.0298353 0.0269643 0.0270231 0.00962774 0.0281009 0.0202203 + 0.0200313 0.0200802 0.0266776 0.0275543 0.0289782 0.0282567 0.00905639 0.111895 0.0227187 0.0265333 0.0220526 0.0218647 + 0.0219158 0.0270006 0.0221845 0.0220167 0.0222008 0.0265089 0.0265172 0.0255149 0.0617347 0.0137393 0.00298118 0.00384556 + 0.0202314 0.128691 0.0227878 0.0253274 0.02018 0.0617976 0.0277296 0.0279861 0.029199 0.0278509 0.0277743 0.022337 + 0.0221671 0.0216985 0.0266546 0.0274871 0.0267034 0.0267723 0.0280668 0.0279676 0.0264377 0.0265187 0.0275361 0.0270452 + 0.0272934 0.0239766 0.0241394 0.0432951 0.0654975 0.0282211 0.0281716 0.0705032 0.0242669 0.0243539 0.0244763 0.0281066 + 0.027388 0.0263232 0.034864 0.0154912 0.0259278 0.0304565 0.0288406 0.0576344 0.0272612 0.0264852 0.0298298 0.0296434 + 0.0296987 0.0269402 0.0276012 0.0273798 0.0243602 0.0242907 0.0195627 0.0197025 0.0195144 0.0158626 0.00739821 0.0266581 + 0.0287251 0.028968 0.0263525 0.0245726 0.0261961 0.0263905 0.00967986 0.0254572 0.0256133 0.0254889 0.0273539 0.026005 + 0.0260993 0.0261226 0.0196547 0.0248098 0.0250834 0.0248876 0.0250584 0.018876 0.0190596 0.019025 0.0279215 0.0192057 + 0.0193549 0.0191715 0.013394 0.023118 0.0232174 0.0230348 0.0254512 0.0292092 0.0275336 0.025934 0.0258946 0.0289813 + 0.0286867 0.0284542 0.0287187 0.0278195 0.0260456 0.0246848 0.0247537 0.0256691 0.0238114 0.023818 0.0265003 0.0265813 + 0.0264278 0.0254272 0.0255609 0.0215902 0.0265067 0.0639028 0.0213929 0.0268431 0.0276656 0.0223694 0.0223842 0.0225536 + 0.0265654 0.0276854 -0.00971581 0.062054 0.0271548 0.0269501 0.0270719 0.0306935 0.0267134 0.0219256 0.0219852 0.0221233 + 0.0271113 0.0252326 0.0641555 0.0137526 0.026124 0.0262997 0.0262731 0.0264268 0.026787 0.0289767 0.0291793 0.0797381 + 0.0294065 0.0194776 0.0196337 0.01946 0.0273822 0.024749 0.0249278 0.0296521 0.0138326 0.0141736 0.0272935 0.0490766 + 0.027019 0.0270549 0.0273686 0.0258426 0.0264691 0.0277542 0.0277308 0.0230077 0.0231948 0.0678026 0.0082256 0.00871739 + 0.0265769 0.027929 0.0277671 0.0251259 0.0251083 0.0249257 0.0250761 0.0289868 0.0288754 0.0245504 0.0269288 0.0177766 + 0.0179591 0.0179284 0.0253131 0.0241101 0.024176 0.0295138 0.0297178 0.02705 0.0233124 0.0231853 0.0233744 0.0305132 + 0.0150124 0.0270359 0.0241904 0.0258239 0.0239755 0.0264299 0.0173097 0.0174948 0.0174449 0.0172636 0.0298898 0.0253634 + 0.028283 0.0281027 0.0283569 0.0199402 0.0198912 0.0197512 0.0249112 0.0247138 0.0256563 0.0281724 0.0275605 0.0255802 + 0.0254515 0.0252092 0.0289319 0.0261934 0.0250051 0.0217257 0.0215355 0.0215881 0.0202695 0.0215313 0.0633402 0.0641314 + 0.0612961 0.0214289 0.0216101 0.0215871 0.0253996 0.0268352 0.0269452 0.0173982 0.0265685 0.0257908 0.0296279 0.0297292 + 0.017351 0.0171693 0.017216 0.0253568 0.0254959 0.0262731 0.0252027 0.0221057 0.0599475 0.0592512 0.0598886 0.026917 + 0.0267372 0.0267167 0.0225938 0.0223947 0.00781285 0.0258732 0.0258126 0.0221846 0.0263235 0.0229787 0.0259962 0.0258647 + 0.00850993 0.00866567 0.0247894 0.0188038 0.018841 0.0189901 0.0194669 0.0192794 0.0193268 0.0257778 0.0256596 0.0218149 + 0.0217739 0.0217683 0.0213358 0.0264634 0.0223724 0.0217074 0.0216831 0.0215299 0.0135709 0.0264371 0.0652062 0.0274916 + 0.000134118 0.00665047 0.028489 0.0287328 0.0248563 0.00516199 0.0253003 0.0425972 0.0293375 0.0292081 0.0253829 0.0255944 + 0.0271479 0.027386 0.0272984 0.0255706 0.0288516 0.0251961 0.0253297 0.0215545 0.0187803 0.0189698 0.0189187 -0.00342427 + 0.0186572 0.024341 0.0242265 0.0244027 0.0239816 0.0262914 0.025915 0.0260319 0.0329147 0.0255298 0.0195582 0.0195308 + 0.019377 0.0265978 0.0200405 0.0127945 0.0122586 0.0295451 0.0293692 0.0295518 0.0284204 0.025335 0.022919 0.0231011 + 0.0245574 0.0229203 0.0263557 0.026506 0.0234747 0.0250586 0.0252226 0.0250833 0.0140702 0.0140965 0.0142356 0.0262564 + 0.027085 0.0269898 0.0253426 0.0257065 0.0187311 0.0249057 0.0247985 0.022061 0.0258731 0.0227838 0.0236821 0.0706655 + 0.0248033 0.0246867 0.0243658 0.0214739 0.0232544 0.0231245 0.0221975 0.0222028 0.026838 0.0274255 0.0251208 0.0246085 + 0.0215762 0.0239312 0.0238466 0.0298296 0.0251108 0.0282502 0.0252976 0.0265463 0.0175206 0.0174929 0.0173446 0.0247031 + 0.0245945 0.0251374 0.0234389 0.023383 0.0240625 0.0239769 0.0253277 0.0157007 0.0157464 0.0158756 0.0241809 0.024143 + 0.0243001 0.0265418 0.019815 0.0197626 0.0196243 0.0186193 0.0184727 0.0217781 0.0251569 0.00429003 0.00200716 0.027222 + 0.0269883 0.0270497 0.0182894 0.0184349 0.0257312 0.0268928 0.0268815 0.0269934 0.0223332 0.022529 0.0271872 0.0273608 + 0.0273924 0.0609666 0.0608758 0.0249544 0.0878845 0.0259073 0.0249107 0.0206381 0.0216654 0.0214687 0.0249436 0.0251391 + 0.0159102 0.0168523 0.0167184 0.0168977 0.0211891 0.0213471 0.0211658 0.0264515 0.0250051 0.0251002 0.0258044 0.0221735 + 0.0223316 0.0267538 0.0497702 0.0621429 0.0166186 0.0165917 0.0164453 0.0263748 0.0245789 0.0249399 0.0244983 0.025791 + 0.0220014 0.0142887 0.0144279 0.0142626 0.0243854 0.0280422 0.0169942 0.017169 0.0171416 0.0232972 0.0268719 0.0202416 + 0.0204227 0.0122505 0.0123889 0.0234827 0.0233982 0.0253873 0.00808585 0.0230706 0.0228511 0.0188467 0.0252144 0.0254441 + 0.0195726 0.0269385 0.0238476 0.0226604 0.0225055 0.0213794 0.021289 0.0219613 0.0221222 0.0239908 0.0242044 0.0270569 + 0.0268255 0.0164725 0.0245137 0.0274492 0.0144018 0.0212797 0.025053 0.0176971 0.0176694 0.0231992 0.0273365 0.019661 + 0.0198451 0.0198105 0.0220413 0.0218603 0.0218865 0.0165842 0.0167629 0.023579 0.0237636 0.0240949 0.0264621 0.0287923 + 0.0220416 0.0245235 0.0232452 0.0234975 0.0213214 0.0224507 0.0239197 0.0237458 0.0236246 0.0238078 0.0166288 0.0252194 + 0.0241572 0.0242529 0.0188687 0.0246814 0.0267894 0.0248293 0.0186815 0.0231477 0.0229918 0.0230416 0.0243521 0.0243541 + 0.0273085 0.0615523 0.0200923 0.0142091 0.0219807 0.0219991 0.0287365 0.0246226 0.0300302 0.0289368 0.0287662 0.00998287 + 0.0133362 0.013378 0.0135033 0.00995367 0.0221374 0.0219429 0.0218133 0.0186468 0.0188329 0.017317 0.0240564 0.0242733 + 0.0250226 0.0214179 0.021225 0.0194046 0.0208747 0.0210684 0.0210263 0.0189534 0.0187676 0.0188144 0.023673 0.0209502 + 0.0209719 0.0211344 0.01914 0.0190007 0.0248922 0.0199899 0.0273586 0.0273473 0.0211851 0.0135488 0.019712 0.0635784 + 0.0162997 0.0178463 0.0227946 0.0164534 0.0162713 0.0163186 0.0229954 0.0146562 0.0146124 0.0144829 0.0193099 0.0192767 + 0.0191223 0.0199016 0.0199535 0.0237693 0.0254212 0.0253802 0.0255807 0.0664362 0.0234315 0.0185091 0.0186916 0.0173043 + 0.0199984 0.0229167 0.0256736 0.0238106 0.023985 0.0239907 0.0267097 0.0260347 0.0261069 0.0215158 0.0210348 0.0208813 + 0.0129398 0.0134628 0.0169883 0.017035 0.0191479 0.0248632 0.0224873 0.0226638 0.0234993 0.0236864 0.0268453 0.0295081 + 0.0268699 0.0232283 0.0232474 0.0212469 0.0212714 0.0203604 0.0204095 0.0262394 0.0260555 0.0299937 0.0271272 0.02693 + 0.0134625 0.0135886 0.0134218 0.0136345 0.0214053 0.0185445 0.0230444 0.0230594 0.0257681 0.0175754 0.0174397 0.017622 + 0.0235666 0.0231758 0.02366 0.0218687 0.0220512 0.0220339 0.0197116 0.0268179 0.0135486 0.0225853 0.0231801 0.0231656 + 0.0230088 0.0167924 0.0169397 0.0167653 0.0256948 0.0191874 0.0208362 0.0237427 0.017372 0.0222551 0.0133801 0.0248567 + 0.0169667 0.0219943 0.0228593 0.0227308 0.0194507 0.0195768 0.0194013 0.0260965 0.0262946 0.0243058 0.0191965 0.0193498 + 0.0230691 0.0229371 0.0214135 0.0212287 0.0209883 0.0210887 0.0273987 0.0223177 0.0224837 0.0195376 0.019347 0.0220027 + 0.0264091 0.0223888 0.0222495 0.0228651 0.0120678 0.0122261 0.0122007 0.0238474 0.0273388 0.0225082 0.0226818 0.0206992 + 0.0225056 0.0247158 0.0244543 0.0241469 0.0229954 0.0163269 0.0239884 0.0223487 0.0220539 0.0204962 0.0204473 0.0203075 + 0.0261088 0.0259301 0.0260845 0.0144409 0.0158325 0.0160091 0.0159647 0.0218109 0.0163543 0.0161818 0.0217875 0.0221478 + 0.0236938 0.0233214 0.0143118 0.0142696 0.021806 0.0267605 0.0247331 0.0187984 0.0189455 0.0187616 0.0183253 0.0183525 + 0.0185041 0.025861 0.0257429 0.0258909 0.0259507 0.0250251 0.0251623 0.0250236 0.0161546 0.02064 0.025165 0.0204508 + 0.0202624 0.0203113 0.0218647 0.0217275 0.0128439 0.0128705 0.0130058 0.0202505 0.0214531 0.0216342 0.0247452 0.0264178 + 0.0275362 0.0251769 0.0160969 0.0162745 0.0162292 0.0250739 0.0212201 0.0219596 0.0234581 0.0236341 0.0225285 0.0222169 + 0.0224503 0.019661 0.0194722 0.019522 0.0210864 0.0224677 0.0137606 0.0136336 0.0138022 0.0135922 0.0134245 0.0134655 + 0.0206203 0.0207763 0.0205943 0.0275456 0.0251678 0.0209133 0.0211055 0.0168541 0.0160516 0.0252215 0.0174864 0.0176241 + 0.0176023 0.0235081 0.0184953 0.0183267 0.0275335 0.0189174 0.0207506 0.0190565 0.0190068 0.0264417 0.0240278 0.0239181 + 0.0129784 0.021832 0.0164957 0.0256733 0.0233874 0.0231851 0.0232298 0.0250403 0.0293543 0.0261629 0.0260543 0.0272876 + 0.0157876 0.0223532 0.0244594 0.0216688 0.0184572 0.0182689 0.0213709 0.0244094 0.0148733 0.0147013 0.0147434 0.0211978 + 0.0217927 0.0238082 0.021172 0.0246956 0.0218503 0.0246085 0.016527 0.0166731 0.0164998 0.0184768 0.0217279 0.0241516 + 0.0211412 0.0210027 0.0145719 0.0144011 0.0144427 0.0229291 0.0166459 0.012683 0.0128185 0.0152515 0.0209753 0.0137167 + 0.0138438 0.013675 0.0166274 0.0167633 0.0301519 0.030031 0.0878283 0.0190921 0.0225416 0.0205891 0.0206406 0.0228833 + 0.0207803 0.0621566 0.0226956 0.0225616 0.0227492 0.0212612 0.0126567 0.0221394 0.0219536 0.0227369 0.0171144 0.014398 + 0.0132981 0.0131313 0.013172 0.0201713 0.0135107 0.0136427 0.0134752 0.01453 0.0259663 0.0213723 0.0140969 0.0136086 + 0.0216742 0.0256637 0.0145309 0.0177515 0.0238083 0.0239765 0.01388 0.0140133 0.0138452 0.0230147 0.0205853 0.0217681 + 0.0132538 0.0192084 0.0203372 0.0266861 0.0260892 0.021964 0.0220477 0.0221629 0.0129248 0.0127595 0.0127995 0.0137125 + 0.0188196 0.0241712 0.0247498 0.0227252 0.0235636 0.0130056 0.0158764 0.0159028 0.0160477 0.0143196 0.0144555 0.0180676 + 0.018251 0.0182115 0.0254827 0.0130908 0.0129651 0.0229366 0.0270297 0.0209476 0.0269297 0.0710338 0.0199824 0.0183255 + 0.0207017 0.0207546 0.0288647 0.0226178 0.0176198 0.0174837 0.0176656 0.0133391 0.0189887 0.0188358 0.0190158 0.0142309 + 0.0143593 0.0141892 0.0208951 0.0207936 0.0253081 0.0233344 0.0233224 0.0188631 0.022399 0.0225669 0.0201232 0.0208814 + 0.0143178 0.0159194 0.0206873 0.0236343 0.0133444 0.0132138 0.0133797 0.0193333 0.0168082 0.022513 0.0218381 0.0107215 + 0.0107502 0.0108798 0.0230291 0.0171035 0.0169555 0.0171286 0.0205103 0.0139351 0.0140438 0.0138797 0.0139052 0.0263006 + 0.0263906 0.0201143 0.0264462 0.0185822 0.0186288 0.0210077 0.020796 0.0220198 0.0135462 0.0136779 0.0167006 0.02006 + 0.0199207 0.0275852 0.0158748 0.0198673 0.0197319 0.0205496 0.0202615 0.0201522 0.0250081 0.0148282 0.0146987 0.014871 + 0.0172739 0.0412755 0.0164664 0.0164345 0.0162891 0.0192319 0.0147219 0.0148595 0.0146909 0.0220893 0.023824 0.0202563 + 0.0204384 0.0204122 0.0203911 0.0199954 0.0201898 0.0163118 0.0200026 0.019434 0.0192959 0.0194856 0.0196749 0.0226621 + 0.0146138 0.0272301 0.0623907 0.0207048 0.0205131 0.0206255 0.0636277 0.0202094 0.0200248 0.014555 0.0193833 0.019245 + 0.0172083 0.0173582 0.0171859 0.0242119 0.0240167 0.0245188 0.0102209 0.0216583 0.0181425 0.0198505 0.0242962 0.0184438 + 0.0184907 0.013213 0.0257545 0.0258668 0.0233236 0.0149156 0.0187197 0.0171231 0.0227918 0.0227488 0.0181327 0.0195847 + 0.0232804 0.0214777 0.0195552 0.0195817 0.0197385 0.0157431 0.0215023 0.019843 0.0247841 0.0204007 0.0205933 0.0205411 + 0.0196697 0.0198618 0.0192577 0.0191181 0.0193161 0.0245576 0.0243698 0.0243679 0.020102 0.0201976 0.0190434 0.0192234 + 0.0186331 0.0216664 0.0170345 0.0232599 0.0165545 0.0170215 0.0171967 0.0185758 0.0187558 0.0187286 0.0156986 0.0109609 + 0.0111204 0.0110824 0.0141478 0.0139781 0.0140201 0.0175743 0.0174383 0.0130462 0.0130871 0.0181475 0.0179503 0.0184474 + 0.0234914 0.023482 0.0183809 0.0185319 0.019701 0.0109223 0.0159734 0.0161194 0.0159478 0.0207884 0.0208111 0.019794 + 0.0196058 0.0235563 0.0237635 0.0236919 0.0238398 0.0155249 0.0155522 0.0156952 0.0169804 0.0262196 0.0191947 0.0183957 + 0.0221959 0.0119895 0.0119632 0.0118311 0.0176149 0.0177916 0.0177642 0.0199336 0.0228059 0.01601 0.0160373 0.017756 + 0.0177108 0.0216272 0.0170492 0.0216471 0.0190717 0.0108841 0.0107248 0.0107628 0.0268934 0.01462 0.0144854 0.0146551 + 0.0151065 0.0181064 0.0222389 0.0123852 0.0122213 0.012261 0.023122 0.0196587 0.0198404 0.0198141 0.0139582 0.0141236 + 0.0185922 0.0161841 0.0163621 0.0163169 0.0194188 0.0135066 0.0161409 0.019092 0.0110439 0.0204466 0.0202536 0.0202977 + 0.0148945 0.0147504 0.012058 0.0120974 0.0124251 0.0139853 0.019332 0.0184067 0.0189003 0.0144758 0.0145657 0.0156563 + 0.0166792 0.0230695 0.0229315 0.019748 0.0206025 0.0207676 0.0183582 0.018222 0.018731 0.0204012 0.0204059 0.0168058 + 0.0149569 0.015137 0.0150887 0.0185451 0.0154064 0.0155785 0.0155434 0.0181802 0.0180456 0.0182248 0.020809 0.0187826 + 0.0189659 0.0216855 0.0189695 0.0238963 0.0237024 0.0100143 0.00988669 0.0100399 0.0211775 0.0213391 0.0211556 0.0620518 + 0.0156681 0.0183625 0.0168472 0.016813 0.0216116 0.0166315 0.0126404 0.0125156 0.0126801 0.0118572 0.0228723 0.0228547 + 0.0169896 0.0189044 0.0143155 0.0144495 0.0173963 0.0172524 0.014915 0.01956 0.0121485 0.0123075 0.0122815 0.0160915 + 0.0214178 0.0216066 0.0215835 0.020596 0.0189055 0.0268913 0.0263538 0.0167201 0.0169002 0.0158303 0.0153823 0.0268194 + 0.0255759 0.0254062 0.025623 0.0185218 0.018555 0.0186886 0.0175288 0.0160528 0.0160083 0.0158769 0.0159204 0.0202859 + 0.0204447 0.0168197 0.0200787 0.0180901 0.0182542 0.0189465 0.0168867 0.0170603 0.0106038 0.0104453 0.010483 0.0260691 + 0.0179388 0.0178021 0.0179849 0.0161393 0.0106421 0.0138204 0.0121221 0.0173514 0.0172129 0.0173905 0.0243386 0.0245248 + 0.0243508 0.0202911 0.0175294 0.017998 0.0142274 0.0126744 0.0126344 0.0125096 0.0198084 0.0196225 0.0203562 0.0154095 + 0.0223749 0.0266342 0.0169426 0.0180239 0.0182015 0.0181743 0.0154372 0.0155794 0.0157175 0.0133488 0.013216 0.0133709 + 0.0190983 0.0181803 0.0200545 0.01831 0.018173 0.0145538 0.014651 0.0212232 0.0213825 0.0272728 0.0147415 0.0145695 + 0.0209584 0.0208027 0.0209838 0.00993828 0.0100658 0.00991242 0.0101937 0.0101678 0.0190459 0.0152649 0.0153075 0.0154388 + 0.0155247 0.0203197 0.0167628 0.0138469 0.0192515 0.0184562 0.0181062 0.0209945 0.0222729 0.0268542 0.0191068 0.0270815 + 0.0162092 0.0175243 0.0102871 0.0101295 0.0101669 0.0619723 0.0175482 0.0118631 0.0117016 0.0117396 0.0152027 0.0153629 + 0.0153349 0.0192191 0.0194001 0.0193769 0.0103248 0.0618828 0.0156545 0.0154815 0.0172226 0.0147906 0.00978521 0.00963247 + 0.00965825 0.0171308 0.0208937 0.0198486 0.0223892 0.00950579 0.0188086 0.0189613 0.016429 0.0165809 0.0164031 0.0178706 + 0.017996 0.00953162 0.0178044 0.0218078 0.0169476 0.0172239 0.0173996 0.0291513 0.0170761 0.0130518 0.0131848 0.0217491 + 0.0193704 0.016587 0.0167662 0.0168745 0.0196852 0.0119019 0.0120257 0.0140843 0.0140471 0.0139128 0.0166743 0.0165406 + 0.0212962 0.0179961 0.0197074 0.0169275 0.0201036 0.0194308 0.0162604 0.0200387 0.0120644 0.0196067 0.0197632 0.0135132 + 0.0136189 0.0168471 0.0206279 0.0170067 0.0108386 0.0170756 0.0172551 0.0125851 0.0127555 0.0154805 0.0167275 0.0169018 + 0.0210327 0.0178925 0.0163813 0.00975939 0.0207236 0.0263776 0.0125496 0.0210762 0.0212724 0.0213727 0.0626132 0.0173927 + 0.0172573 0.0166089 0.0167474 0.0109989 0.01907 0.0145982 0.014773 0.0152675 0.0221891 0.0168336 0.0191578 0.0188578 + 0.0132581 0.0130838 0.0131669 0.0230291 0.0180757 0.0173024 0.00840087 0.00855817 0.00852143 0.0191452 0.0167806 0.0207544 + 0.018372 0.00836792 0.015071 0.01524 0.015213 0.0149201 0.0208853 0.0201297 0.019169 0.0168585 0.0271579 0.018897 + 0.0166288 0.0164953 0.0214066 0.0196537 0.0134283 0.0133516 0.0135209 0.0165004 0.0103474 0.010322 0.0148495 0.0150174 + 0.0149907 0.0183351 0.0163525 0.013436 0.00726426 0.00738635 0.00723886 0.0212729 0.0210774 0.0196211 0.0100096 0.00985256 + 0.00988993 0.0151765 0.0153501 0.0128957 0.0130315 0.013083 0.0132482 0.013683 0.0136564 0.0135196 0.010047 0.0192429 + 0.0194253 0.0118502 0.0118112 0.0116882 0.00969605 0.00973315 0.0139245 0.0199042 0.0187326 0.0130189 0.0204896 0.0155694 + 0.0128877 0.020283 0.0156116 0.0145269 0.0176623 0.0174805 0.0175231 0.0115157 0.0116731 0.0116469 0.020101 0.0200745 + 0.0150971 0.0152707 0.015187 0.0180857 0.0150984 0.0132417 0.0160069 0.0130484 0.0131788 0.0212222 0.0161929 0.0162316 + 0.0163631 0.00736105 0.0203863 0.0202042 0.0202303 0.0155672 0.0124699 0.0148262 0.0257631 0.0127103 0.00848471 0.0198004 + 0.0145198 0.0143849 0.0153939 0.0174535 0.0164855 0.0173839 0.0175357 0.00937948 0.00775593 0.00791007 0.00788125 0.0083314 + 0.020199 0.0178601 0.00817857 0.00821442 0.0136464 0.013481 0.0190191 0.0176419 0.0209326 0.0209074 0.0119344 0.0116489 + 0.0179094 0.016146 0.00829566 0.0140991 0.0138867 0.0172119 0.0115779 0.0114169 0.0114558 0.0139 0.0138731 0.013736 + 0.0267978 0.00814279 0.0158333 0.0137783 0.0136028 0.0136974 0.0104758 0.0137596 0.0194728 0.0139667 0.0138698 0.0137804 + 0.0121328 0.0122589 0.019284 0.0127237 0.0128546 0.0160963 0.0159638 0.0275129 0.0273494 0.0182008 0.0148305 0.0150049 + 0.0149299 0.015305 0.0151743 0.0153484 0.00960678 0.00973374 0.0173484 0.0142911 0.0153494 0.0147349 0.0183941 0.014351 + 0.016185 0.013117 0.0150442 0.0148704 0.0128832 0.0130134 0.0147903 0.0143559 0.0189578 0.0187711 0.0155232 0.0176773 + 0.0177225 0.0154433 0.0154787 0.0156101 0.0638056 0.0637075 0.0237522 0.0235754 0.0170244 0.0141855 0.0147371 0.0222947 + 0.0221595 0.0223511 0.0188907 0.0179494 0.0165399 0.0164092 0.0181253 0.0151312 0.0150009 0.0149301 0.016581 0.0125454 + 0.0150863 0.00665162 0.00677324 0.00662672 0.0195081 0.0269043 0.0270705 0.00601377 0.00604883 0.00616318 0.0153962 0.0152378 + 0.0130587 0.018051 0.0129206 0.0143777 0.0119738 0.00799028 0.00802603 0.0210104 0.0210314 0.0114422 0.0113592 0.0115271 + 0.0112022 0.0113586 0.0113326 0.0166731 0.012555 0.0182297 0.0161401 0.0141416 0.0140121 0.0185587 0.0184066 0.018588 + 0.013747 0.013615 0.0137755 0.0111763 0.0160214 0.0145869 0.0140453 0.0117599 0.0116274 0.0117816 0.0129521 0.0183417 + 0.0185367 0.011805 0.0128801 0.00940489 0.0206237 0.00828681 0.0084445 0.0152191 0.015134 0.0147394 0.0146275 0.0114401 + 0.020465 0.0182623 0.011307 0.012093 0.0166854 0.0139718 0.0195156 0.0144637 0.0146436 0.0162362 0.01771 0.0178857 + 0.00638459 0.00650553 0.00635962 0.0166326 0.00674797 0.0166593 0.0170757 0.011918 0.0620476 0.0117719 0.00697 0.00711694 + 0.00709171 0.0137989 0.0127654 0.0128052 0.0118504 0.01184 0.0180597 0.0181567 0.0182659 0.0168773 0.0169206 0.017053 + 0.0164075 0.0146595 0.013096 0.0129705 0.0131363 0.0149129 0.0135462 0.0178262 0.00611845 0.00623887 0.00609336 0.0129307 + 0.0128907 0.0104791 0.010636 0.0106026 0.00753401 0.00750873 0.00892546 0.00907636 0.00905085 0.0167555 0.0107943 0.0107601 + 0.0183685 0.0184607 0.0185498 0.0120158 0.0118842 0.0164532 0.0141306 0.0139527 0.0173936 0.0135567 0.0135968 0.0137242 + 0.0164501 0.0139317 0.0137591 0.0159624 0.0172518 0.00648057 0.0116168 0.00775747 0.0076412 0.00779243 0.0144181 0.00760563 + 0.0117056 0.0148313 0.0175749 0.0177243 0.0155621 0.0157322 0.0157055 0.011227 0.0152192 0.0179241 0.0128981 0.014455 + 0.0129274 0.00435368 0.00447067 0.00432635 0.0110717 0.0110971 0.0116995 0.018122 0.0144886 0.0140574 0.0139295 0.0202836 + 0.00935374 0.0092021 0.00922773 0.00748987 0.0137241 0.0178481 0.0186082 0.011567 0.0115417 0.0138513 0.0152635 0.0160592 + 0.0119743 0.0136296 0.0137938 0.0137672 0.0135798 0.00949475 0.00945792 0.00933974 0.0159292 0.0160741 0.0167119 0.0146163 + 0.0104153 0.0102949 0.0104527 0.0137648 0.0141502 0.0133297 0.0134925 0.0134669 0.0116517 0.0161401 0.0117329 0.0115712 + 0.01161 0.0170805 0.0146388 0.0132118 0.0118046 0.0117674 0.0116413 0.0150216 0.0148502 0.0148889 0.00679807 0.00694473 + 0.0069197 0.0154362 0.0150919 0.00768204 0.0076567 0.0129615 0.013169 0.0130441 0.0147488 0.0147887 0.0142275 0.0141313 + 0.0134478 0.00621389 0.014446 0.0162635 0.0119267 0.0172581 0.0170773 0.00444454 0.0129753 0.011027 0.011207 0.00780499 + 0.0113507 0.0112723 0.0132824 0.0133155 0.00745419 0.0148762 0.0116035 0.00624431 0.0061291 0.00627724 0.0127259 0.0131942 + 0.0133566 0.0120554 0.0114794 0.00957692 0.0130014 0.0128761 0.0128359 0.0201068 0.0131502 0.0059462 0.00598132 0.00609497 + 0.00930218 0.0126336 0.0134141 0.0142756 0.0163202 0.0111657 0.0110055 0.0178123 0.0176294 0.0114936 0.0159828 0.0161274 + 0.0249736 0.0248166 0.0250122 0.0127358 0.0152224 0.00649654 0.00661373 0.00646546 0.011444 0.00606031 0.0127088 0.0165838 + 0.00682562 0.00694331 0.00679426 0.0111119 0.01309 0.00585318 0.00597318 0.00582806 0.0118857 0.00978809 0.00994295 0.00988964 + 0.011204 0.0132183 0.0133823 0.0121818 0.00591179 0.00667677 0.0124214 0.0120187 0.0143932 0.014582 0.0162722 0.0160949 + 0.0146285 0.0157225 0.013252 0.0133958 0.0105744 0.0105453 0.0104202 0.00741894 0.00757022 0.0155879 0.0157583 0.0114445 + 0.0115774 0.0124605 0.0127583 0.0129856 0.0189514 0.0160647 0.0157863 0.00849888 0.00852385 0.00864905 0.0160838 0.00767685 + 0.00783051 0.0177757 0.0127953 0.0126704 0.01157 0.0117291 0.0129181 0.0149581 0.0112567 0.0112951 0.0105659 0.0125052 + 0.0123805 0.0131278 0.0127607 0.0130105 0.0144243 0.0139314 0.014118 0.0141589 0.0143028 0.0151688 0.0147604 0.012691 + 0.0125602 0.0092014 0.00904671 0.00908314 0.0107003 0.0120528 0.0154794 0.00634815 0.00623162 0.00637977 0.00832252 0.00835047 + 0.00847467 0.00594809 0.00652817 0.00664532 0.0141065 0.0112522 0.0138125 0.0136835 0.0096139 0.0106867 0.010528 0.0131673 + 0.0152953 0.00757387 0.00769215 0.00754157 0.0117251 0.0179956 0.0129248 0.0120419 0.0111355 0.0111726 0.00576344 0.00579801 + 0.0139669 0.010441 0.0103082 0.0101424 0.0102837 0.0130559 0.00730317 0.00733858 0.0153055 0.0121743 0.0123455 0.0179605 + 0.0118903 0.00464295 0.00452576 0.00863896 0.00879208 0.00875675 0.0180656 0.0182156 0.0180426 0.0119864 0.0116613 0.0118348 + 0.0161886 0.0143043 0.0141028 0.0152178 0.0123409 0.0122167 0.0164063 0.0113808 0.0114486 0.009382 0.0092543 0.0156108 + 0.0118243 0.0157497 0.0156065 0.0157766 0.0118709 0.00982399 0.00998062 0.00994311 0.00972558 0.0117341 0.0111832 0.0128022 + 0.0114109 0.00742278 0.0148166 0.0132227 0.0125912 0.0160543 0.0126017 0.012476 0.00820116 0.00835448 0.00832131 0.062057 + 0.00941645 0.00928728 0.00942107 0.0115653 0.0116003 0.011384 0.013143 0.0105123 0.00438275 0.00449642 0.0043509 0.0132954 + 0.00860249 0.0149256 0.015113 0.0117265 0.0115262 0.0114034 0.0103778 0.0102575 0.0168587 0.0166727 0.0167711 0.0172774 + 0.017425 0.0144663 0.01734 0.011672 0.0118952 0.016459 0.0162869 0.016313 0.0104074 0.0106939 0.0105737 0.0107321 + 0.00877477 0.00889992 0.016736 0.0105357 0.0104987 0.00925966 0.0142798 0.0108886 0.0107229 0.0103323 0.0192111 0.0110535 + 0.0114874 0.0113651 0.0147856 0.00688816 0.00700581 0.00685679 0.0161702 0.00820091 0.00822622 0.00835025 0.0137877 0.00421113 + 0.00418457 0.0040672 0.00787363 0.0152765 0.0154199 0.015244 0.0115216 0.0206056 0.0112856 0.0113116 0.00473278 0.00458826 + 0.00460743 0.0067389 0.0151245 0.00294258 0.00279811 0.00283222 0.00860724 0.00872686 0.00857352 0.012755 0.0125357 0.0138881 + 0.00689445 0.00290861 0.0118387 0.00553633 0.00542306 0.00557092 0.00923777 0.00772267 0.0075903 0.0102495 0.00747894 0.00736052 + 0.00751078 0.0136722 0.00602372 0.00614366 0.00599824 0.00276429 0.0122286 0.0123885 0.0123621 0.00538877 0.00287459 0.00962947 + 0.00862454 0.00865001 0.0111272 0.00297663 0.0109466 0.01128 0.0113228 0.0111881 0.00550202 0.0085663 0.00872011 0.0114687 + 0.011301 0.011222 0.00938423 0.00922893 0.00926568 0.00978629 0.0113262 0.00273016 0.0050959 0.00524109 0.0052101 0.00846875 + 0.0132574 0.0115454 0.00236527 0.00222117 0.00225547 0.0139951 0.00535433 0.00258565 0.00261984 0.0115463 0.0117057 0.00722288 + 0.00718755 0.00707231 0.012436 0.012111 0.0119474 0.0103873 0.0102633 0.0125191 0.012356 0.0123909 0.0027474 0.00288221 + 0.0105935 0.00763189 0.0076098 0.00910268 0.0103698 0.0151748 0.015001 0.0114685 0.0115391 0.00956461 0.00346407 0.00331717 + 0.00335193 0.0110244 0.00943073 0.00930415 0.0103396 0.0171992 0.00870089 0.014182 0.0146561 0.0144847 0.0106694 0.0108271 + 0.0116092 0.0125607 0.0124924 0.0126571 0.0126263 0.0152703 0.0105589 0.0149551 0.0101577 0.00874937 0.00721081 0.00732892 + 0.00832486 0.00998872 0.0106611 0.0153063 0.0108007 0.0113792 0.00955812 0.00913608 0.010092 0.0123008 0.0124652 0.0132626 + 0.0143469 0.0144784 0.00460057 0.004567 0.00446161 0.00239956 0.00703676 0.0135512 0.0133837 0.00703705 0.0053564 0.00263045 + 0.00248933 0.00252314 0.00423873 0.00380222 0.00391385 0.00376861 0.0144827 0.00910347 0.00227116 0.00241323 0.00238031 0.00200224 + 0.00185843 0.00189359 0.00387998 0.0160117 0.0049756 0.00505368 0.00405947 0.00394777 0.0102194 0.011774 0.00409294 0.0140158 + 0.0139257 0.019057 0.0189118 0.0190983 0.0100383 0.0102056 0.00968423 0.0110166 0.0111052 0.00981541 0.00965903 0.0119068 + 0.0120682 0.00826009 0.00823494 0.00811448 0.0104518 0.0104836 0.0106057 0.00392484 0.00404246 0.00504568 0.00512559 0.0116602 + 0.0103997 0.0150343 0.0149344 0.0151343 0.015209 0.00773259 0.00349781 0.0117533 0.0101224 0.010002 0.0124831 0.0123105 + 0.0020372 0.00522769 0.0050821 0.00511569 0.0100918 0.00937873 0.00953081 0.0095066 0.00520691 0.00524129 0.00276535 0.00278964 + 0.00290685 0.0076294 0.0141465 0.01263 0.00968784 0.00925318 0.00405662 0.00419943 0.00417507 0.0082597 0.0141761 0.00682326 + 0.00545702 0.00560437 0.00880047 0.0112805 0.00697484 0.00799978 0.00784768 0.0078833 0.0109386 0.00434079 0.00431716 0.012255 + 0.00431679 0.00417113 0.00420455 0.00981106 0.00996431 0.0199592 0.0201489 0.00868387 0.0142153 0.0147891 0.0147623 0.0106567 + 0.0127537 0.0129353 0.0102951 0.0103275 0.0127053 0.00997219 0.00228059 0.00213873 0.00217261 0.0095323 0.00373467 0.00911056 + 0.0111363 0.00616875 0.0109685 0.0099648 0.00984483 0.0117031 0.00358959 0.00362354 0.00837681 0.00822381 0.0113875 0.011497 + 0.00639307 0.00654225 0.00650739 0.00983702 0.0114898 0.00841277 0.00541886 0.00553841 0.00539404 0.0106111 0.00203119 0.00446284 + 0.0102209 0.0100999 0.00940581 0.00551374 0.00955726 0.00532002 0.00546759 0.0100909 0.0114357 0.00448485 0.0108164 0.00897677 + 0.00912772 0.012306 0.0106387 0.00790984 0.00803547 0.0112142 0.0113374 0.0113618 0.00197681 0.00211327 0.00208619 0.00921986 + 0.0111909 0.00460655 0.00463118 0.00474957 0.0101374 0.00714382 0.00701542 0.0125946 0.00919903 0.013615 0.0135233 0.00937467 + 0.0115075 0.00220599 0.00223934 0.00234763 0.009184 0.00906534 0.00527169 0.00530529 0.00541773 0.00715248 0.0150667 0.00254754 + 0.00266003 0.00635798 0.00401693 0.00387475 0.00389955 0.00895091 0.00910209 0.00965714 0.00803052 0.00221809 0.00538597 0.00684851 + 0.0107688 0.00753477 0.00953992 0.0117165 0.0116377 0.00932992 0.00947463 0.00959356 0.00944159 0.0146986 0.0115951 0.0158037 + 0.0158285 0.00914716 0.009029 0.0134118 0.00699379 0.0120221 0.00409441 0.00564984 0.00573362 0.00570818 0.0112877 0.0122631 + 0.0122957 0.0146594 0.0146195 0.00927841 0.0040811 0.00199707 0.0132508 0.00810695 0.00760622 0.00775438 0.00772935 0.0112806 + 0.00907508 0.00966788 0.0105269 0.0106837 0.0106547 0.00887425 0.00891123 0.01022 0.0102449 0.0103749 0.00935387 0.00088315 + 0.000916356 0.00101944 0.0109949 0.0111254 0.0109695 0.0106393 0.010882 0.00825244 0.00837602 0.00178569 0.00175006 0.00164252 + 0.0122267 0.0121461 0.0123937 0.0104 0.0105291 0.00741154 0.0140119 0.00814368 0.00817518 0.00830039 0.00247571 0.0147543 + 0.0149259 0.0137096 0.011413 0.0125186 0.00986304 0.0100158 0.00999023 0.00899237 0.00231444 0.00898542 0.00885169 0.00210439 + 0.00196255 0.00880158 0.00883798 0.00611493 0.00626277 0.0180348 0.0178752 0.0112433 0.00845282 0.00194518 0.00205309 0.00191466 + 0.00604842 0.00361525 0.00375851 0.00373229 0.0101302 0.009973 0.0100088 0.0052618 0.00357188 0.00360842 0.00336777 0.00347862 + 0.00333388 0.00808176 0.00796205 0.00344465 0.00892701 0.00895058 0.00211137 0.00214607 0.0104622 0.010363 0.0105213 0.00711732 + 0.006967 0.00700202 0.0118562 0.00608354 0.0062 0.0142535 0.00393922 0.0031642 0.00305329 0.00319797 0.00351265 0.0107131 + 0.00632345 0.0064726 0.0125686 0.0108459 0.0121767 0.0170545 0.0099083 0.00594336 0.00609106 0.00605966 0.00373126 0.0050152 + 0.0049811 0.00486815 0.00308718 0.0127879 0.00844898 0.00992715 0.0100846 0.00370075 0.00384602 0.00556339 0.00728949 0.0025095 + 0.00875939 0.00864532 0.0074331 0.00729106 0.00735047 0.00739247 0.00727394 0.0123126 0.0100626 0.0009856 0.0101402 0.00997637 + 0.00153589 0.00143028 0.00157225 0.0127538 0.00802609 0.00153903 0.00143121 0.00156967 0.0110458 0.00580307 0.01141 0.00766104 + 0.00167902 0.0111566 0.0127878 0.0136783 0.0138467 0.0138057 0.00807119 0.00587844 0.00620738 0.0103092 0.0102199 0.00180652 + 0.0047249 0.00798292 0.00785321 0.0032107 0.00307003 0.00309386 0.00442888 0.00963029 0.00867523 0.00330904 0.00443517 0.00875042 + 0.0101825 0.00958124 0.00945453 0.0110352 0.0110989 0.00687961 0.00295327 0.00483418 0.00687368 0.00699525 0.00575932 0.0108533 + 0.00676941 0.0068403 0.00824888 0.00813034 0.00500318 0.00514853 0.00511759 0.0115496 0.0109673 0.00846247 0.00834004 0.00849574 + 0.0108121 0.0107844 0.00329986 0.0100041 0.0106842 0.0108391 0.0108156 0.00978527 0.00981081 0.00993561 0.00672733 0.00724214 + 0.00177463 0.00653059 0.00593582 0.00605235 0.00670198 0.00428293 0.00084931 0.00315524 0.00318927 0.00776953 0.00771 0.00166724 + 0.00662087 0.0129444 0.0130827 0.00614591 0.00509391 0.00512828 0.0155373 0.0106789 0.00808064 0.00796419 0.00811644 0.00850351 + 0.00838616 0.00853951 0.00853015 0.00568316 0.00565834 0.00738361 0.0153881 0.00529958 0.00532474 0.00544403 0.0102414 0.0111617 + 0.0116213 0.0114643 0.00795381 0.00810248 0.00807723 0.00975103 0.0128213 0.0100562 0.00862471 0.00422519 0.00407965 0.00411332 + 0.0076508 0.00768627 0.00160653 0.00900149 0.0088519 0.00887558 0.00602569 0.00794428 0.00741072 0.00349582 0.00347451 0.00341067 + 0.00326586 0.00550846 0.00543327 0.00535473 0.00916369 0.00183531 0.00195212 0.00181473 0.00897692 0.00439492 0.00792832 0.00833312 + 0.00577378 0.0056257 0.00566013 0.00520093 0.00105262 0.00805639 0.00359077 0.00795455 0.00783815 0.00489319 0.00491769 0.0050365 + 0.00745746 0.00192996 0.0125897 0.00118955 0.00115643 0.00105315 0.000951102 0.00108824 0.0147171 0.00599833 0.0108014 0.0105551 + 0.00799401 0.00613977 0.00599112 0.00143415 0.00139849 0.00129456 0.00617445 0.00725794 0.00526365 0.00163593 0.00755935 0.00643783 + 0.00685188 0.00962593 0.00978197 0.00975204 0.00756225 0.00150308 0.0015389 0.00244177 0.00152899 0.00167854 0.00920255 0.017602 + 0.00297694 0.00300084 0.00311768 0.00917744 0.00778215 0.00568431 0.00943116 0.00965375 0.0094849 0.0289903 0.0111107 0.00882558 + 0.0074371 0.00494686 0.0100921 0.00927921 0.00792819 0.005279 0.00987431 0.0140895 0.00580825 0.00970984 0.00769593 0.00773149 + 0.0069562 0.00671248 0.00674721 0.00686225 0.00710675 0.00164426 0.00912713 0.00859909 0.00872403 0.00714244 0.00915265 0.00307895 + 0.00304489 0.00293485 0.000843452 0.00088006 0.000980908 0.00993495 0.00692195 0.00680733 0.00726797 0.00424892 0.00658101 0.00101737 + 0.00781217 0.00501175 0.00688682 0.00677166 0.00656297 0.00659764 0.0110485 0.00702074 0.00192762 0.00206975 0.00667682 0.010212 + 0.0089559 0.00730402 0.0208282 0.0208576 0.00140349 0.00662217 0.00665668 0.00587721 0.00477455 0.00479889 0.00894666 0.00543176 + 0.00948011 0.00091593 0.00884343 0.00119118 0.00122613 0.0013743 0.00148215 0.00134532 0.0067079 0.00146518 0.00149733 0.00160371 + 0.00822361 0.0083738 0.000779686 0.000814833 0.00482359 0.00494448 0.00546793 0.00980754 0.00655928 0.00659037 0.00480003 0.00672676 + 0.0066128 0.00673695 0.00655576 0.00783451 0.00768355 0.00771574 0.00476918 0.00465133 0.00479609 0.00517264 0.0087985 0.00922746 + 0.00590012 0.00631439 0.00628922 0.00589822 0.00931953 0.00831017 0.00646296 0.00653167 0.00662312 0.00123805 0.0058818 0.00576549 + 0.00591264 0.0095031 0.00644187 0.00647293 0.00646006 0.00660636 0.00619498 0.00633976 0.0031413 0.00312071 0.00301064 0.00620901 + 0.0062939 0.00632457 0.0102213 0.00185742 0.00197399 0.00425905 0.0017494 0.00189013 0.00185576 0.00649247 0.0102049 0.00763147 + 0.00706656 0.00537568 0.00508428 0.00835008 0.010355 0.00665236 0.00290057 0.00286021 0.00907405 0.00617694 0.00558884 0.00804478 + 0.00602919 0.00854869 0.0086739 0.00584271 0.00867567 0.00631488 0.00642644 0.00575265 0.00563685 0.00566305 0.00558662 0.0137729 + 0.0138098 0.00318705 0.00409831 0.00413074 0.00423163 0.00864766 0.00641094 0.00871051 0.00574134 0.00581772 0.00670314 0.00590318 + 0.00758 0.00754449 0.00742885 0.00561396 0.00772181 0.00132992 0.00437021 0.00425234 0.00439502 0.00120865 0.00674301 0.00748725 + 0.0101969 0.0102836 0.000943707 0.00108248 0.00104495 0.00585301 0.00573938 0.0058876 0.00809825 0.00566401 0.00573615 0.00303112 + 0.0128397 0.00628865 0.00622425 0.006105 0.00624202 0.00596726 0.00626459 0.00615015 0.00629921 0.00689713 0.00468128 0.00883277 + 0.00824894 0.00839895 0.00740846 0.00882724 0.0049127 0.00476594 0.00391465 0.00379775 0.00951202 0.00817085 0.00859035 0.00679278 + 0.00667685 0.0068277 0.00151198 0.0092824 0.00135942 0.00125377 0.00139107 0.00570476 0.00519638 0.0078025 0.00413707 0.000544291 + 0.000443529 0.000576029 0.0049669 0.00178351 0.00572899 0.00561543 0.00900153 0.00885035 0.00887574 0.00579594 0.00582711 0.00699218 + 0.00797905 0.00559651 0.00739342 0.00597905 0.00677837 0.00528451 0.00410315 0.00812864 0.00521214 0.00427706 0.00505006 0.00493701 + 0.00481611 0.00643504 0.00571842 0.00749942 0.00581594 0.00824327 0.0084038 0.00396324 0.00282508 0.0029689 0.00547794 0.00551229 + 0.00288409 0.00840107 0.00827664 0.00842836 0.00465344 0.00513282 0.00270806 0.00281535 0.00675234 0.00275643 0.00279074 0.00717899 + 0.00693114 0.00415389 0.00427206 0.00412962 0.00767581 0.00783099 0.00780423 0.00640973 0.00125861 0.00559131 0.00110933 0.00100676 + 0.0011474 0.00475578 0.00478737 0.00490256 0.0047214 0.00460915 0.00505971 0.00398743 0.00401161 0.00808695 0.00427079 0.0101706 + 0.00438471 0.00452988 0.00450551 0.00462893 0.00402538 0.00164339 0.00107279 0.000966847 0.00110209 0.00726209 0.00468754 0.00457514 + 0.0079189 0.00129469 0.00386956 0.00351999 0.00363212 0.00448824 0.006702 0.000678428 0.0071676 0.00451295 0.00465631 0.00448957 + 0.00724269 0.00727802 0.0038121 0.00188223 0.00202291 0.00669189 0.000888853 0.000745724 0.000786845 0.000995707 0.000905729 0.00267504 + 0.00587414 0.00589843 0.00601871 0.00805104 0.00503464 0.0044067 0.00752436 0.0070929 0.0045411 0.00404599 0.00419094 0.00512501 + 0.00558308 0.00410524 0.00424771 0.000928549 0.00731543 0.00654173 0.00758427 0.0077072 0.00607594 0.00352697 0.00366683 0.00653295 + 0.00639151 0.00527463 0.00689893 0.005065 0.00453791 0.00723277 0.0015377 0.00167718 0.00171464 0.00694255 0.00489333 0.00427036 + 0.00415684 0.00423081 0.0027501 0.00289319 0.00285938 0.00581855 0.00412565 0.00844768 0.00621665 0.00414914 0.00684277 0.00377963 + 0.00560943 0.0054625 0.00549395 0.00397984 0.00157075 0.00283646 0.0027198 0.00382105 0.00400651 0.00403382 0.00244164 0.0027156 + 0.00515707 0.00611559 0.0122273 0.00182097 0.00455706 0.00139343 0.00125122 0.00128862 0.00389172 0.00437706 0.00681694 0.00413468 + 0.00251121 0.00239457 0.00253327 0.0039915 0.00112267 0.00429342 0.00618907 0.00630927 0.00616377 0.00646038 0.00787116 0.00264681 + 0.00273902 0.00286993 0.0071238 0.00357946 0.00361189 0.00364184 0.000907393 0.00102163 0.000881024 0.00706108 0.00383591 0.00372151 + 0.0042238 0.00564295 0.00890068 0.00384546 0.00578278 0.00230492 0.00377046 0.00655244 0.00640309 0.0046767 0.0022855 0.00217741 + 0.0023202 0.00393403 0.00396774 0.00135645 0.00474426 0.00512164 0.00301934 0.00592982 0.00549698 0.00169829 0.00430377 0.00415643 + 0.00358638 0.00361034 0.00358604 0.00346898 0.00149944 0.00146302 0.00241733 0.00441821 0.00344902 0.00553312 0.00537357 0.00421497 + 0.00269965 0.00284055 0.00281594 0.00298627 0.00200503 0.00343343 0.00207697 0.000970075 0.00109711 0.00657646 0.00586662 0.00376913 + 0.00369403 0.00362917 0.00155986 0.00985267 0.00196737 0.00519031 0.00303662 0.00292528 0.00351718 0.00363447 0.00349295 0.000700559 + 0.000569299 0.000587524 0.00648549 0.00198995 0.00185013 0.00115897 0.00126656 0.00113087 0.00195743 0.00209793 0.00604339 0.00558099 + 0.00186776 0.00277091 0.000995996 0.0037106 0.00374439 0.00385603 0.00355563 0.00264087 0.00278375 0.00260644 0.00973016 0.00988543 + 0.00202046 0.00213709 0.00199709 0.0052244 0.0053459 0.00520821 0.0079132 0.00267293 0.00281302 0.00658719 0.00131944 0.0014532 + 0.00543325 0.00528572 0.00313028 0.00181698 0.00192394 0.00292958 0.00268126 0.00257211 0.00382234 0.00464302 0.0145833 0.001185 + 0.00167947 0.00213093 0.00742053 0.0073371 0.00715694 0.00573769 0.00259927 0.00450906 0.000507689 0.000550638 0.000645954 0.00784308 + 0.0032907 0.0031768 0.00375694 0.00386947 0.00337581 0.00269633 0.00172834 0.00183681 0.00232838 0.00132333 0.00102365 0.00797602 + 0.00809947 0.007937 0.0015903 0.000458263 0.00426872 0.00335168 0.00988855 0.00278836 0.00450708 0.00337161 0.00211367 0.00682378 + 0.00698613 0.00715613 0.00377623 0.00365881 0.00380066 0.00367955 0.00399002 0.00150379 0.00142212 0.00145254 0.00233123 0.00253756 + 0.00370375 0.00105179 0.000916884 0.000944001 0.00256492 0.000810519 0.00365657 0.00534854 0.00344232 0.00189747 0.00171024 0.00239396 + 0.0025104 0.00237011 0.000534827 0.000668229 0.000638296 0.00575416 0.00436092 0.00569453 0.00453323 0.00265009 0.00309725 0.00255657 + 0.000703635 0.00060378 0.00395753 0.00323468 0.00493827 0.00508177 0.00506165 0.00335724 0.00218684 0.00157108 0.00257975 0.0026982 + 0.00118619 0.00171464 0.00186655 0.00178589 0.000772394 0.0012849 0.00131535 0.00225361 0.00718486 0.00496776 0.00107645 0.000558772 + 0.00134331 0.00415685 0.00399744 0.00260319 0.00274352 0.00194272 0.00208957 0.00103228 0.0011382 0.00099382 0.00223021 0.00585091 + 0.00182339 0.00295078 0.00284012 0.0026246 0.00336575 0.00502549 0.00322316 0.00372778 0.000551171 0.000680829 0.00461938 0.00650285 + 0.00581983 0.00531071 0.00385134 0.00169971 0.00216236 0.00174299 0.00171835 0.00312118 0.00116312 0.00112913 0.00406921 0.00193304 + 0.00219569 0.000687941 0.00470686 0.00229758 0.00497182 0.00121357 0.00366199 0.00132568 0.00146685 0.000836684 0.000859491 0.00174161 + 0.00188012 0.00492536 0.00352171 0.00255257 0.00293574 0.002788 0.00136233 0.00368322 0.00066347 0.00301073 0.0020649 0.00216166 + 0.00232024 0.00143227 0.00227818 0.00342408 0.00733984 0.00746099 0.00201489 0.00178883 0.0013988 0.000473932 0.000505696 0.000607518 + 0.0025828 0.00272522 0.0014268 0.0026509 0.00253439 0.00267528 0.00171481 0.0016091 0.000411795 0.003708 0.00382521 0.000730261 + 0.000752553 0.00456235 0.00712753 0.00353472 0.0049544 0.000206954 9.71689e-05 0.000209265 0.00499706 0.00484335 0.00551301 0.000426846 + 0.00044218 0.00756503 0.00114822 0.00286637 0.00255885 0.00486278 0.00105301 0.00118364 0.00175814 0.00522666 0.00514921 0.0050747 + 0.00224043 0.0011788 0.00114902 0.00126051 0.00112633 0.00325688 0.00340141 0.00128793 0.00117422 0.001307 8.42098e-05 0.0011556 + -1.48333e-06 5.08332e-05 0.00234671 0.00202624 0.00187657 0.00242868 0.00122198 0.00111702 0.000151372 0.00369051 0.000920005 0.000810263 + 0.000955564 0.00744697 0.00759749 0.00123802 0.00261237 0.00076592 0.000848695 0.000967954 0.002503 0.0033776 0.00247208 0.00254343 + 0.000743837 7.60095e-05 0.00415961 0.00489011 0.00404499 0.0038927 0.00107091 0.000591592 0.000728365 0.0012137 0.00673063 0.00676273 + 0.000806029 0.000710372 0.00399224 0.000889507 0.000766351 9.37701e-05 8.98163e-05 0.00535838 0.00394915 0.00399015 0.000101138 0.00086108 + 0.00246331 9.19956e-05 0.00819816 0.0056801 0.00101438 0.000447873 0.0003671 0.000507524 0.00018204 0.000866941 0.00119792 0.00239136 + 0.00381342 0.00520472 0.00274894 0.00286421 5.96199e-06 0.00082204 0.000672711 0.00286311 0.00270736 0.00209192 0.000704658 0.00113208 + 0.000967346 0.00242296 0.00245615 0.00117588 0.000643939 0.000538661 9.19055e-06 0.00300983 0.00106325 0.00062485 0.006264 0.00430252 + 0.00442018 0.00314574 0.00166022 0.00150691 0.00158053 0.00110113 0.00122376 0.00133754 0.000319129 4.01959e-06 7.87728e-06 4.43833e-07 + -4.39102e-06 8.69071e-06 6.38725e-05 0.00506178 0.00669774 0.00180301 0.00173143 0.000463173 5.40194e-06 0.000596006 0.00321492 0.00324281 + 0.000520188 0.000885466 0.000990523 0.000932286 0.00109347 0.000937381 0.00104276 0.000907305 0.00253208 0.00150905 0.00164736 0.00162603 + 0.00269262 0.00300307 7.61182e-06 0.000473792 0.000132014 0.00036499 0.000793685 0.0049793 0.000516785 0.00128263 0.000745498 0.000738688 + 0.00080907 0.000585288 0.00382361 0.00176369 0.0026085 0.00534734 0.00288883 0.00291048 0.00057919 0.000443758 0.000479171 0.000622387 + 0.000650556 0.000755605 0.00153119 0.00239404 0.00225064 0.000381983 0.000331924 0.00153522 0.000369219 0.000345312 0.000314062 0.00373071 + 0.00375864 0.00385993 0.00193845 4.22978e-06 0.0146576 0.00163812 0.00178946 0.00876164 0.00868934 0.0120547 0.0105464 9.29085e-07 + 0.00117569 0.00134959 0.00891699 0.00329565 0.00639239 0.0014926 0.00135198 0.000887976 0.00623266 0.0118894 0.00120286 0.0103859 + 1.41155e-05 0.00780823 0.00762707 0.0118553 0.0119454 0.00860647 0.0161235 0.0159153 -5.758e-06 0.000104977 5.05857e-07 0.0148294 + 0.0149967 0.0252354 0.0120133 0.0108495 0.0133949 0.013589 0.0122068 0.0105178 0.0106829 -7.23384e-06 0.0031474 0.00937211 + 0.0103553 0.00377405 0.00362404 0.00940949 0.00749251 2.23186e-06 1.26216e-06 -8.64507e-07 1.35069e-05 0.0164601 0.0166452 0.0239348 + 0.00904872 0.00921024 0.0253751 0.0129031 0.00450011 0.00466054 0.0132275 0.0133144 0.000327854 0.000441848 7.58965e-06 0.00970942 + 0.00605983 0.0151782 0.0187472 0.0222611 0.00105058 0.00588926 0.00604428 0.00545457 0.00530048 0.00952334 0.0226295 0.0228241 + 0.0153628 0.0154632 0.00989327 0.0181473 0.0262944 0.0262272 0.00956399 0.0189369 0.018739 0.0235654 0.00713191 0.00731127 + 0.00481396 0.0172297 0.0170163 0.0241014 0.000368364 0.0263048 0.0263791 0.000327034 -8.49161e-05 -0.000221553 6.72597e-06 5.42791e-06 + 0.00701525 0.00685719 0.0034515 0.0128814 0.0250865 0.017373 0.01759 0.0116874 0.00981704 0.0241773 6.15175e-06 0.0155438 + 0.0115182 0.00407686 0.00392339 0.0263692 0.0264364 0.0198831 0.0201139 0.0264272 0.013055 0.0247609 0.0249182 0.023382 + 0.0021032 0.0249352 -1.05044e-07 0.0241127 0.0193127 0.0195178 0.0255063 0.0224377 0.024293 0.0196987 0.0198102 0.0262252 + 0.015645 0.0142835 0.0256348 0.0230118 0.0228265 0.00621472 0.00870823 0.00889541 3.24224e-06 9.48445e-05 0.0242517 0.0244484 + 0.0123686 0.0260556 0.0261486 0.0159055 0.00090254 0.0022607 0.0137324 0.022641 0.0227537 0.0259656 0.014459 0.0157287 + 0.00376349 0.0264549 0.0265193 0.00255409 0.0170155 0.0172233 4.63233e-06 0.0010379 2.0114e-06 1.35362e-05 0.0164586 0.0189025 + 0.019129 0.00423111 0.0214584 0.0203043 0.00857872 0.00437805 0.0256222 0.0258519 0.00593406 0.00575978 0.00561105 0.0178009 + 0.0175887 0.0246076 0.0218549 0.0019566 7.57663e-06 0.0155708 0.01536 0.0127423 0.00972828 0.00829059 0.00810956 0.00421686 + 0.00792962 0.00542913 0.0261511 0.00527528 0.00634088 0.0065217 -6.61129e-05 0.000279436 0.00667029 0.00743574 0.00761642 3.62123e-06 + 1.97161e-06 1.21826e-05 -1.3107e-05 0.0179673 -1.18481e-05 0.000518438 0.0020422 0.000720363 0.00122208 0.00322333 0.000713876 0.00190328 + 0.000802558 0.00856351 0.00844139 0.00859146 0.000747636 0.00041066 0.000612921 0.00214246 0.00199962 0.00203478 0.000679556 0.00227749 + 0.00135837 0.00305177 0.00262694 0.00189241 0.000605337 0.00204622 0.00216191 0.00243998 0.00714661 0.00702936 0.000780781 0.00111936 + 0.00276744 0.00230079 0.00178579 0.00167975 0.00319092 0.00333157 0.00330754 0.000630998 0.000497572 0.000535843 0.000456375 0.000376831 + 0.000367805 0.00030808 0.000418506 0.00523223 0.00537881 0.00363341 0.00164497 0.00412797 0.00416504 0.00426208 0.00564895 0.000510793 + 0.000473779 0.00215357 0.000489785 0.000414044 0.000644619 0.00494006 0.00482641 0.00302502 0.00146514 0.00142821 0.00132197 0.000532605 + 0.0087499 0.00877466 0.00218468 0.00251872 0.00266202 0.00653494 0.00157425 0.00178783 0.00307398 0.00296469 0.00310835 0.000364407 + 0.000661398 0.00290835 0.000741519 0.000624499 0.000834763 0.000680569 0.000647763 0.000707223 0.000334415 0.00248663 0.00314185 0.000387553 + 0.000767745 0.00146924 0.00280472 0.00508589 0.00573178 0.00200819 0.00186683 0.00265373 0.0026879 0.00136466 0.000971168 0.000856947 + 0.000288427 0.00325874 0.0010614 0.00082732 0.00361613 0.000407892 0.00306335 0.00320808 0.00941923 0.009297 0.00945378 0.00132705 + 0.00129408 0.00240822 0.00103757 0.0032319 0.000414626 0.000348026 0.00353095 0.000545483 0.00108446 0.00108515 0.000669595 0.000598798 + 0.000493782 0.00401535 0.000343597 0.00337673 0.00248184 0.00485494 0.00500185 0.000948918 0.000813332 0.000845264 0.00137211 0.00148546 + 0.00124621 0.000832132 0.00067785 0.00356537 0.00353176 0.00342013 0.00378896 0.000564116 0.000439914 0.000459097 0.00151074 0.00139988 + 0.00153832 0.000813161 0.000902599 0.000783529 0.00155318 0.00555645 0.00339997 0.00184512 0.00173388 0.000306258 0.000294545 0.00481036 + 0.00484445 0.00495722 0.00170982 0.00182056 0.000948073 0.000772876 0.000792816 0.00627613 0.000513208 0.001391 0.000468144 0.00317579 + 0.00367685 0.00206793 0.0019575 0.000838253 0.000337369 0.000362789 0.000608623 0.00328077 0.00316269 0.00330356 0.00157899 0.00154878 + 0.000545864 0.0030228 0.00482245 0.000415431 0.000385943 0.00375196 0.00327954 0.00167399 0.00401286 0.00215427 0.00226514 0.00162017 + 0.00353597 0.00161083 0.00178748 0.00390071 0.00237609 0.00249197 0.000697819 0.00229122 0.00217853 0.00193058 0.00204355 0.00221209 + 0.00339636 0.00240524 0.00243393 0.00228997 0.00150015 0.00182134 0.00038829 0.00234793 0.00363296 0.000572522 0.00272211 0.000376909 + 0.00441462 0.00439046 0.00389385 0.0019643 0.0021074 0.00207229 0.00192894 0.0054437 0.00164912 0.00224662 0.00257798 0.00254371 + 0.00274173 0.00111048 0.004707 0.00474208 0.00729662 0.0024953 0.00246711 0.0101385 0.00235931 0.00175027 0.00259983 0.00271397 + 0.0021611 0.00204456 0.00218607 0.00536468 0.0053304 0.00521732 0.00249753 0.00813764 0.00828964 0.00774831 0.00392364 0.00211789 + 0.00342122 0.00575056 0.00206832 0.00462959 0.00459595 0.00448313 0.00241801 0.00162038 0.00160065 0.00455747 0.00377822 0.00189861 + 0.00192699 0.00418103 0.00237439 0.00326844 0.00246844 0.00436617 0.00830739 0.00832401 0.00135568 0.00493122 0.000980841 0.00226352 + 0.00663239 0.000925737 0.00232357 0.00777615 0.00244272 0.000727048 0.00687975 0.00432694 0.00298208 0.00278525 0.00252298 0.00282615 + 0.00293423 0.0059044 0.00578827 0.00230178 0.00339134 0.00350473 0.00335931 0.00309779 0.00307386 0.00295765 0.00185695 0.00171449 + 0.00429636 0.00207018 0.00329763 0.00315492 0.00318708 0.00470045 0.00481841 0.00664149 0.00338634 0.00326628 0.00340978 0.00221574 + 0.00652874 0.0035455 0.00246324 0.00403596 0.00780362 0.00793381 0.00510568 0.0051832 0.00514918 0.00503596 0.00578402 0.0059322 + 0.00567054 0.00101213 0.00499134 0.00384157 0.00369803 0.00504976 0.00447305 0.00469778 0.00466376 0.0045513 0.00311306 0.00388979 + 0.0104714 0.0106005 0.00316599 0.00304919 0.00872615 0.00859992 0.00354153 0.00344867 0.000572638 0.00293175 0.00334285 0.00238895 + 0.00303583 0.003566 0.00529631 0.0040015 0.000440801 0.00348782 0.00323469 0.0038079 0.00395455 0.00424392 0.00409958 0.00344213 + 0.00678207 0.0027917 0.000741671 0.00304514 0.00488912 0.00477621 0.00492313 0.00563477 0.00175453 0.00358396 0.00473185 0.00421388 + 0.00435663 0.00432055 0.00487856 0.00464869 0.0045031 0.00453199 0.00375556 0.00496203 0.00359915 0.00220712 0.00365743 0.00377876 + 0.00328293 0.00262819 0.00560958 0.00333006 0.00321803 0.00398531 0.00417829 0.0040604 0.00420283 0.00355332 0.00403532 0.00444922 + 0.00536892 0.00548864 0.00121062 0.0034733 0.00539893 0.00623002 0.000443427 0.00513843 0.00232461 0.00461496 0.00476184 0.00473191 + 0.00414717 0.00429301 0.00766073 0.000320615 0.00172118 0.014243 0.0144131 0.000876586 0.000593467 0.00391821 0.00606844 0.00505426 + 0.00490764 0.00356269 0.003454 0.00223362 0.00304671 0.00484857 0.00630257 0.00634202 0.0228712 0.00439141 0.00451733 0.000645962 + 0.0127145 0.00502096 0.00516813 0.00513539 0.0023258 0.00554662 0.00293259 0.00515566 0.0054714 0.0049878 0.00458733 0.00469963 + 0.00558778 0.00570375 0.0055568 0.00324168 0.00327532 0.0124498 0.00797347 0.00793796 0.00783515 0.00641323 0.00637861 0.00691183 + 0.00479412 0.000489945 0.00458535 0.00592207 0.00443911 0.0046797 0.00456699 0.00364253 0.00235479 0.00563324 0.00408503 0.0150315 + 0.00717174 0.00713791 0.00702416 0.00633452 0.00645635 0.00801831 0.00577812 0.000362908 0.00524993 0.00513058 0.00209063 0.00567259 + 0.00520083 0.00496711 0.00547194 0.00544113 0.00543125 0.00557671 0.00554076 0.00312732 0.004877 0.00595659 0.00648293 0.00644819 + 0.00633375 0.00887454 0.00218086 0.00561862 0.00573468 0.00610518 0.00660225 0.00672436 0.00589802 0.00532546 0.00870921 0.00740243 + 0.00743925 0.00755197 0.0099086 0.00221243 0.00518074 0.00386874 0.00592331 0.00342448 0.0036694 0.00625401 0.00531451 0.00527536 + 0.00957433 0.00598744 0.00613805 0.00484381 0.00432082 0.00728646 0.00732206 0.00649167 0.0055338 0.00556542 0.00516257 0.00540058 + 0.00498071 0.00508308 0.00552165 0.00789357 0.00447258 0.00651765 0.00525149 0.0108913 0.0110127 0.00735833 0.00927441 0.0093109 + 0.00942969 0.00520666 0.00666717 0.00640569 0.00654975 0.00701691 0.00713763 0.00912639 0.00528511 0.00800913 0.00816111 0.0057566 + 0.00587287 0.00572381 0.0104451 0.00607063 0.00595653 0.00117586 0.0016084 0.00877495 0.00881095 0.00892885 0.00583224 0.0102455 + 0.00750933 0.00693202 0.000511969 0.00601921 0.00708225 0.00443908 0.00785588 0.00901123 0.00126042 0.0061973 0.00615897 0.0081522 + 0.00498696 0.00540933 0.00743275 0.00755739 0.0068706 0.0068136 0.00696386 0.00693626 0.00394274 0.00846736 0.00616807 0.00628599 + 0.0141106 0.00889259 0.0056567 0.00651026 0.00580866 0.00800156 0.0081241 0.00631656 0.00787775 0.00658167 0.0133028 0.0134294 + 0.0063684 0.00638589 0.00643061 0.00325333 0.00482881 0.00440508 0.00704724 0.0147847 0.0149142 0.00842388 0.00728731 0.00734838 + 0.00665859 0.0059672 0.00720754 0.0033279 0.00635573 0.00550242 0.0094663 0.00678264 0.0081754 0.00802633 0.00805171 0.00663182 + 0.00510425 0.00669934 0.00437121 0.00433709 0.00723017 0.00738064 0.00735326 0.00684823 0.00761535 0.00677788 0.00344473 0.00524132 + 0.00564111 0.00865705 0.00862092 0.00770361 0.00854728 0.0086671 0.00666969 0.00806166 0.00776696 0.0120945 0.00719766 0.00758163 + 0.00745846 0.00704617 0.0069973 0.00711453 0.0074835 0.00719557 0.00731477 0.0074733 0.00986778 0.0076482 0.00780114 0.00777357 + 0.0103219 0.00507013 0.00785221 0.00869888 0.00882426 0.00741465 0.00692237 0.000381171 0.00726477 0.00872922 0.00869314 0.00857552 + 0.00812669 0.00818799 0.0100219 0.00834085 0.00708238 0.0124149 0.00759139 0.00584016 0.00610245 0.00827436 0.00822373 0.0083769 + 0.008975 0.00910092 0.00895004 0.00716363 0.00753283 0.00618476 0.00876537 0.00849408 0.00781169 0.00793133 0.00777999 0.0112566 + 0.0111005 0.0048681 0.0077406 0.00746408 0.0135997 0.00761464 0.00773384 0.00737308 0.00621938 0.00569549 0.00733598 0.00721368 + 0.00704163 0.00719396 0.00458184 0.00446353 0.00721795 0.0168397 0.0167004 0.00636422 0.00891952 0.00818942 0.00817791 0.00815267 + 0.0117866 0.00798589 0.00810476 0.00795302 0.00830497 0.00865277 0.00880291 0.00875557 0.00750087 0.00940379 0.00814385 0.0110954 + 0.00907611 0.0124301 0.0161669 0.0161932 0.0104506 0.0102961 0.0082566 0.00839514 0.00517952 0.00529473 0.00919241 0.0119067 + 0.00843143 0.0103057 0.00857754 0.00869975 0.00840979 0.00858457 0.00888326 0.00762451 0.00983576 0.00996276 0.00623739 0.0163361 + 0.0112203 0.0170188 0.0121035 0.0122274 0.00934755 0.00815027 0.00907536 0.00922929 0.00920085 0.00800522 0.00885657 0.00731106 + 0.00804029 0.0085268 0.00852537 0.00850012 0.00552559 0.0106158 0.00884707 0.0101173 0.00925236 0.0104626 0.00703533 0.0104248 + 0.0105538 0.00857384 0.00844918 0.00867981 0.010974 0.010936 0.00968263 0.00926515 0.0113389 0.0084745 0.00898606 0.00883283 + 0.0086488 0.00905131 0.0107754 0.00867707 0.00903979 0.00916224 0.00962209 0.00977831 0.00716255 0.00731314 0.00955597 0.00942907 + 0.00895459 0.00789903 0.00950694 0.00966264 0.00932816 0.00915592 0.00861156 0.00786719 0.00986108 0.00900131 0.00896507 0.00707542 + 0.0136375 0.00861106 0.00911954 0.00970728 0.00903764 0.0112311 0.00892147 0.00910871 0.00884931 0.00745197 0.0100547 0.010117 + 0.00933626 0.00930156 0.00917354 0.00974141 0.0100153 0.00912598 0.00900011 0.00410973 0.00422747 0.0054101 0.00938481 0.00829946 + 0.0111509 0.0112816 0.00946929 0.00959576 0.0102707 0.00969561 0.0108645 0.00596733 0.00954028 0.00770204 0.00993867 0.0101015 + 0.0100611 0.00958334 0.00873901 0.0110509 0.00701229 0.00697735 0.00600155 0.00945479 0.00870351 0.00855194 0.0101557 0.00603613 + 0.0104904 0.00624612 0.00718848 0.0101072 0.0102311 0.0100747 0.0108079 0.0122666 0.0107093 0.00890044 0.00807035 0.00842213 + 0.0142722 0.00989785 0.00935236 0.00981891 0.00902651 0.0126019 0.0145751 0.0105334 0.0106918 0.0106612 0.00949111 0.0128477 + 0.0127191 0.00930269 0.00917658 0.00845809 0.0106489 0.013516 0.0097704 0.011089 0.0123602 0.00965099 0.0103473 0.0103259 + 0.0101878 0.0100437 0.0078714 0.0168882 0.0112492 0.00791912 0.0115946 0.0139416 0.0126865 0.01118 0.016929 0.0167778 + 0.00973639 0.0102877 0.0104114 0.0102545 0.0104959 0.0106225 0.0181977 0.0114391 0.0104526 0.0104227 0.0102966 0.0109739 + 0.011134 0.0111024 0.013646 0.00608045 0.0108989 0.0110232 0.00434541 0.00976056 0.00992086 0.0107254 0.010697 0.00970823 + 0.0115326 0.0105691 0.0120438 0.0121659 0.0156337 0.0156604 0.00709249 0.00396737 0.0116941 0.0105783 0.0113331 0.0092774 + 0.0091539 0.0128524 0.00958535 0.0114189 0.01158 0.0161399 0.0159951 0.0109382 0.0110624 0.011211 0.00604626 0.0108508 + 0.011886 0.0133881 0.0133486 0.0128076 0.0123393 0.0124647 0.0123057 0.0101981 0.0105797 0.0111856 0.0108242 0.0131817 + 0.0219157 0.0217654 0.0123948 0.00960647 0.0146976 0.014876 0.0109551 0.0109439 0.00705736 0.0131184 0.013238 0.0130866 + 0.0109292 0.0130138 0.0119796 0.0113715 0.00930396 0.0110201 0.0108902 0.0108174 0.0110492 0.0116554 0.00690941 0.0109151 + 0.0113833 0.0112946 0.0124304 0.0121425 0.0118645 0.0120297 0.0119951 0.0107605 0.00384994 0.0126065 0.0124599 0.0121747 + 0.0123031 0.012971 0.0131093 0.011494 0.0112605 0.011752 0.0101653 0.0184402 0.0184558 0.0122014 0.0120704 0.0120959 + 0.00961106 0.0117448 0.0195796 0.0194325 0.0127197 0.0134206 0.0135478 0.0123147 0.0124822 0.0124471 0.0149576 0.0126379 + 0.0116316 0.00915119 0.0134698 0.0125277 0.0118172 0.00819747 0.0110704 0.0126467 0.0126107 0.00823322 0.0119407 0.012527 + 0.0126574 0.0124933 0.0132168 0.0112059 0.0213968 0.0119369 0.00935634 0.00939294 0.0129505 0.0127903 0.0107344 0.00826913 + 0.00892517 0.0121928 0.0137154 0.0138516 0.013691 0.0128848 0.0141832 0.0143186 0.0103749 0.0101747 0.0139778 0.00879938 + 0.0116297 0.0130505 0.0135104 0.0117538 0.0135405 0.017669 0.0177167 0.0178526 0.0121371 0.0120133 0.0123307 0.0153691 + 0.0152338 0.0102065 0.0119371 0.0107677 0.0153922 0.0107699 0.0129386 0.0131061 0.013058 0.00902539 0.0124961 0.0153529 + 0.0137193 0.0126773 0.0138043 0.00831356 0.0121567 0.0211955 0.0126834 0.0128113 0.015745 0.0157882 0.0168076 0.0168522 + 0.0169871 0.012978 0.00903089 0.0128069 0.0135698 0.0146538 0.0147997 0.0112115 0.020491 0.0203103 0.0203373 0.00986071 + 0.00790293 0.0133047 0.0127757 0.0140172 0.01314 0.0132744 0.0100418 0.0153017 0.0154443 0.0133426 0.0133091 0.0124263 + 0.0125898 0.0155703 0.0155267 0.0138272 0.0143385 0.0145072 0.0119098 0.00827624 0.0156992 0.0156561 0.0155244 0.00954842 + 0.00992251 0.0133099 0.0133432 0.0136042 0.0200709 0.0117785 0.0141439 0.0135713 0.0106048 0.0134365 0.0143139 0.0134718 + 0.0134357 0.0106314 0.0144889 0.0123677 0.0100175 0.00777969 0.0137338 0.0117768 0.0097044 0.0110749 0.0126241 0.0132798 + 0.0197146 0.0090562 0.0142046 0.0140389 0.0140627 0.0168088 0.0142993 0.0135769 0.0156595 0.0157021 0.0156132 0.013905 + 0.0149662 0.0148055 0.0149829 0.0125546 0.0157849 0.0141024 0.0140731 0.0273049 0.0170316 0.0169893 0.0142048 0.0140372 + 0.0131362 0.0174389 0.0172711 0.0140612 0.0143835 0.0151309 0.00783048 0.0147084 0.0150884 0.0109479 0.0139744 0.0179002 + 0.0134837 0.0152619 0.0143755 0.0161006 0.016246 0.00785595 0.0151807 0.0151599 0.0145454 0.0132807 0.0157426 0.017032 + 0.0144047 0.0136755 0.0183972 0.0117792 0.0156146 0.0149973 0.0151336 0.014962 0.0151311 0.015436 0.0159184 0.0156402 + 0.0156008 0.0171666 0.0148225 0.0146823 0.014679 0.0143492 0.0148279 0.0180279 0.0178847 0.0159492 0.0161276 0.0138925 + 0.0154629 0.0162278 0.0174841 0.0131765 0.00805439 0.0155193 0.0154882 0.0153527 0.0194504 0.019324 0.0195098 0.0181685 + 0.0183061 0.0191385 0.0190964 0.0189658 0.0164185 0.0165648 0.0163919 0.0184897 0.0184381 0.0183011 0.014568 0.0145414 + 0.0156151 0.0153124 0.0151325 0.0192448 0.0151959 0.0198668 0.0169125 0.0158748 0.0158232 0.0159681 0.0157954 0.0152615 + 0.0164054 0.0105023 0.0103738 0.0128449 0.0174116 0.0175617 0.0161131 0.0158545 0.0156785 0.0176192 0.0155047 0.0151569 + 0.0158166 0.0167178 0.0150978 0.0164405 0.0166202 0.0165792 0.0167384 0.0185343 0.0163612 0.0169361 0.0171177 0.0176634 + 0.0158314 0.0169422 0.0219689 0.0220229 0.0154712 0.0163492 0.0161665 0.0158933 0.015866 0.0145154 0.0122741 0.012231 + 0.0165385 0.0180284 0.0157723 0.0197686 0.0159913 0.0178469 0.0213488 0.0153283 0.0168972 0.0186018 0.0159559 0.0158117 + 0.0141672 0.0150459 0.0124614 0.0161838 0.0163171 0.0172124 0.0155674 0.0165365 0.0179417 0.0234053 0.0234903 0.0236116 + 0.0182593 0.0182132 0.0153254 0.0158388 0.0160509 0.0163039 0.0165119 0.0165391 0.0164948 0.0186752 0.0154833 0.0172366 + 0.0139333 0.0180923 0.0182455 0.0166601 0.0168957 0.016483 0.0150607 0.0169562 0.0168145 0.0158954 0.0175877 0.0174384 + 0.0191836 0.012391 0.0123518 0.0173002 0.0166732 0.0169394 0.0174366 0.0176187 0.0162726 0.0177381 0.0179155 0.0177581 + 0.0177116 0.0103989 0.0102718 0.0179413 0.0178945 0.0169791 0.016799 0.0171585 0.0177152 0.0178504 0.0261908 0.0260171 + 0.0193253 0.0192853 0.0191374 0.0160072 0.0192656 0.0153552 0.0174654 0.0156411 0.0171045 0.0212108 0.0212583 0.0123351 + 0.0183528 0.0101681 0.0100438 0.018936 0.0190888 0.0167578 0.0183998 0.019451 0.0199193 0.0156967 0.0175812 0.0175335 + 0.0268662 0.0121884 0.0121491 0.0163393 0.0184233 0.019529 0.019142 0.018078 0.0159455 0.0172989 0.0177645 0.0185851 + 0.0208324 0.0206819 0.0233275 0.0235077 0.0234527 0.0186397 0.0188274 0.0153929 0.0170872 0.0241569 0.0241659 0.0150441 + 0.0164859 0.0143746 0.0165225 0.0190243 0.0159205 0.0189095 0.0278729 0.0279265 0.018298 0.0181198 0.0181467 0.0190965 + 0.01835 0.0185377 0.0177927 0.0266434 0.0268691 0.018676 0.0178452 0.0179875 0.0178037 0.0214859 0.0154979 0.0101436 + 0.0180363 0.0179888 0.0257956 0.0245392 0.0150875 0.0211197 0.021068 0.0209293 0.021502 0.0213183 0.0193227 0.0197886 + 0.0199453 0.0186243 0.0182812 0.0182554 0.0185925 0.0166097 0.0172897 0.0217768 0.01927 0.019695 0.0181693 0.0216211 + 0.0190663 0.0190483 0.0183542 0.0184982 0.0183131 0.0203102 0.0204685 0.0187233 0.0191579 0.0193457 0.0194231 0.0219125 + 0.0196115 0.0185529 0.0186909 0.0189947 0.0178306 0.016711 0.018656 0.020878 0.0208297 0.0206888 0.0222155 0.024182 + 0.0239968 0.0241799 0.0188702 0.0205178 0.01854 0.0178049 0.017119 0.0172625 0.0198724 0.019499 0.0180794 0.0186832 + 0.0187812 0.0186291 0.0188619 0.0102205 0.0196869 0.0264172 0.0182706 0.0186836 0.0201276 0.0210172 0.0195038 0.0237986 + 0.0238454 0.0240231 0.0210173 0.0177029 0.0192024 0.019014 0.0196817 0.0198705 0.0198221 0.0187106 0.0213604 0.0215223 + 0.0187657 0.0251911 0.0182152 0.0242477 0.0184304 0.0192354 0.0193905 0.0195347 0.0193748 0.0196324 0.0194772 0.0195988 + 0.019768 0.0191153 0.0196327 0.0206513 0.0199211 0.0205353 0.0203628 0.0214821 0.0199156 0.0236377 0.02065 0.020205 + 0.0204594 0.0184496 0.0162291 0.0162731 0.0208411 0.0194878 0.0208343 0.0197259 0.0145957 0.0149027 0.0150443 0.022828 + 0.0251458 0.0200628 0.0163618 0.0187394 0.0213636 0.0210675 0.0187255 0.0211716 0.0198826 0.0204198 0.0205695 0.0203812 + 0.0204928 0.0203351 0.0205176 0.027046 0.0203606 0.020543 0.0180313 0.024045 0.0211132 0.0163656 0.0210895 0.0212549 + 0.0201447 0.0209334 0.0211285 0.0210856 0.0218314 0.02164 0.0205991 0.0214407 0.0199706 0.0200181 0.0204012 0.0173479 + 0.0181654 0.021556 0.020694 0.0206719 0.0162195 0.020006 0.0125226 0.0206393 0.0207875 0.0149186 0.0158506 0.0188084 + 0.0218873 0.0270492 0.0207433 0.018457 0.019296 0.0149612 0.021705 0.0244359 0.0252458 0.027687 0.027506 0.0206468 + 0.0248856 0.0257976 0.0256275 0.0256919 0.0229395 0.0231084 0.0242346 0.0241925 0.0201783 0.0151859 0.0198963 0.0214711 + 0.0216724 0.0216274 0.0156838 0.0213107 0.0231489 0.0218863 0.0209832 0.0150035 0.0212 0.0210407 0.0224141 0.0225801 + 0.0232697 0.0220794 0.0220691 0.0219068 0.0220879 0.0211772 0.0213266 0.0265274 0.022233 0.0206755 0.0219269 0.0212769 + 0.0211146 0.0210895 0.018288 0.0147352 0.0137409 0.0136036 0.0213726 0.0210648 0.0201527 0.0220205 0.0222192 0.0221673 + 0.0225677 0.022773 0.0227273 0.0217211 0.00445715 0.0134376 0.0133033 0.0224071 0.0215231 0.0205303 0.0225943 0.0224302 + 0.0150475 0.022602 0.024729 0.0212815 0.0131406 0.0209802 0.0215019 0.0214494 0.0185805 0.0227605 0.0218715 0.021543 + 0.0216785 0.058501 0.0208825 0.0219269 0.0221078 0.0239801 0.0229239 0.0254506 0.0164505 0.0219699 0.0216087 0.0241428 + 0.0282284 0.0199961 0.0258812 0.0258403 0.0256699 0.02049 0.0239301 0.0238722 0.027177 0.0236906 0.0272645 0.0218616 + 0.0125487 0.0216939 0.021147 0.00719291 0.0236358 0.0236889 0.0258049 0.0231236 0.0233355 0.0232818 0.0220704 0.0125746 + 0.0242861 0.0224712 0.0222696 0.023117 0.0229507 0.0231266 0.0225415 0.0124407 0.0269101 0.0224213 0.0150083 0.023286 + 0.0166277 0.0208581 0.0273126 0.0234618 0.0218177 0.0254384 0.0252956 0.0252572 0.0226252 0.0215679 0.0214618 0.0243262 + 0.0245082 0.0207001 0.0200223 0.0234382 0.0195348 0.0227232 0.0124675 0.0123345 0.021746 0.0232355 0.0208813 0.0229634 + 0.0231381 0.0171671 0.017122 0.0223732 0.0227346 0.0229719 0.0228259 0.0222501 0.0240603 0.0239924 0.0238732 0.0211398 + 0.0194634 0.0239081 0.0241194 0.024901 0.0264721 0.0238119 0.0239951 0.0229769 0.0214333 0.0234711 0.0238231 0.0241333 + 0.0248371 0.0250248 0.0236305 0.0207894 0.0229024 0.0230451 0.0243254 0.0239763 0.022929 0.0231982 0.0237059 0.0236301 + 0.0235076 0.0207391 0.0234302 0.00599701 0.0233609 0.0232939 0.0231918 0.0107764 0.0235978 0.0237524 0.0235434 0.0264633 + 0.0170774 0.023846 0.0241791 0.00579737 0.0233492 0.0237777 0.0244056 0.0241635 0.0217252 0.0244867 0.0247032 0.0246393 + 0.0232928 0.028262 0.0253376 0.0255336 0.0232776 0.0120601 0.0123002 0.0118421 0.00839816 0.00925521 0.0235091 0.025827 + 0.0238074 0.0236385 0.0227731 0.0239634 0.0162937 0.0230536 0.0153599 0.0236597 0.0236506 0.0246254 0.0246746 0.024816 + 0.0244019 0.0226718 0.0243318 0.0238139 0.0233705 0.02034 0.0236342 0.0205 0.0247649 0.0236433 0.0250738 0.0252999 + 0.0215645 0.066494 0.0659089 0.0667632 0.0261748 0.0179689 0.0235117 0.0247899 0.0246198 0.0247717 0.0212976 0.0205684 + 0.0207252 0.0245407 0.0249949 0.0248119 0.0249648 0.0248368 0.0243496 0.0214179 0.0264852 0.026483 0.0265635 0.0253564 + 0.0251825 0.0234731 0.0125223 0.0251013 0.0636015 0.0252899 0.024149 0.0201858 0.0233009 0.0265777 0.0267373 0.0250149 + 0.0261832 0.0249192 0.0256911 0.0258955 0.02582 0.0244668 0.0239889 0.0238437 0.0251359 0.0246727 0.023435 0.0265832 + 0.0265857 0.0244918 0.0243146 0.0256841 0.0178188 0.0132031 0.0244185 0.0259936 0.0218398 0.0271631 0.0262856 0.0265196 + 0.0264405 0.0239424 0.0245664 0.0256771 0.0258794 0.0471089 0.0255156 0.017874 0.025557 0.0251902 0.024852 0.0209296 + 0.0234666 0.0268684 0.0264783 0.0257419 0.0264343 0.0260432 0.0529644 0.0179016 0.0249143 0.0251708 0.0145467 0.0145211 + 0.023637 0.0250095 0.0261074 0.0246357 0.0244647 0.0257417 0.0246176 0.0262267 0.0271219 0.0259805 0.0260731 0.0254467 + 0.0235694 0.0266199 0.0267564 0.0249937 0.0164815 0.0167171 0.0252862 0.0252953 0.0271966 0.0273808 0.0259681 0.0245509 + 0.0269102 0.02613 0.0259655 0.0257652 0.0257078 0.0265892 0.0236957 0.0149605 0.02653 0.0271243 0.0273342 0.0271173 + 0.0258601 0.0266321 0.0275142 0.0277523 0.025435 0.0264533 0.0263452 0.0256508 0.0234273 0.0255792 0.0628454 0.0625926 + 0.026777 0.0497422 0.0277288 0.0254502 0.0263596 0.0236722 0.0266362 0.0273156 0.0269112 0.0269141 0.0245162 0.0813242 + 0.0802463 0.0267547 0.0260593 0.0234871 0.0266579 0.0262087 0.0237527 0.0254868 0.0196008 0.0267537 0.0253721 0.0268163 + 0.0277793 0.0280185 0.0279249 0.0232139 0.0271115 0.0273309 0.0260775 0.0251482 0.0278898 0.0281471 0.0153011 0.0257565 + 0.0257569 0.0267078 0.0267731 0.0265982 0.0154816 0.0267042 0.0265472 0.0762631 0.0264702 0.0954933 0.0254198 0.0276814 + 0.0230542 0.0272841 0.0246537 0.0248576 0.0263767 0.0262203 0.0233106 0.0284054 0.0286397 0.0285397 0.0266731 0.0263856 + 0.014114 0.026203 0.0294008 0.0291696 0.0258636 0.0258812 0.0275388 0.0265649 0.0267449 0.0254236 0.0938835 0.026742 + 0.0256691 0.025555 0.0255396 0.0269391 0.0282975 0.0274551 0.0276231 0.0197387 0.0260418 0.0274458 0.0267749 0.0269265 + 0.0290072 0.0292293 0.029124 0.0101558 0.0282137 0.0284717 0.0643257 0.0287162 0.0250311 0.0267856 0.0223515 0.0278582 + 0.0288937 0.0289963 0.0256292 0.0264447 0.0278307 0.0489818 0.0497087 0.0136964 0.0132075 0.028547 0.0190312 0.102491 + 0.0280921 0.0282554 0.0271038 0.0277609 0.0279167 0.0226923 0.0272684 0.0258355 0.0279323 0.0276816 0.0277162 0.0283216 + 0.0284565 0.0286972 0.0262129 0.0281639 0.0220731 0.0266056 0.0274753 0.0275238 -0.0032962 -0.00106049 0.0287563 0.0294427 + 0.0297236 0.026321 0.0284875 0.0279415 0.0285929 0.0288005 0.1114 0.0200484 0.00467011 0.0252761 0.028221 0.0279722 + 0.0279729 0.0293085 0.0228653 0.0277603 0.0281902 0.0277489 0.0277486 0.0303516 0.0448038 0.0503216 0.0300759 0.030229 + 0.0226739 0.0746113 0.0732645 0.0930261 0.0121476 0.0183485 0.0244769 0.0288693 0.029557 0.017894 0.0272787 0.0198931 + 0.0267664 0.0142409 0.0890129 0.0301821 0.0303146 0.0272401 0.0284276 0.0281898 0.0281591 0.0287765 0.0264378 0.0266318 + 0.0263868 0.0263719 0.0274111 0.0290921 0.0265563 0.0732099 0.0722834 0.027946 0.0243613 0.0266893 0.0284725 -0.0106207 + -0.00874284 0.0265445 0.0265899 0.0264849 0.00646911 0.0132485 0.0293049 0.030451 0.0305173 0.0224847 0.00495106 0.0257762 + 0.0267332 0.0249479 -0.0128733 -0.013008 0.0192908 0.034079 0.0392095 0.068976 0.0201559 0.0293499 0.0650222 0.023233 + 0.0236934 0.0213389 0.0236169 0.0104693 0.027582 0.0300238 0.0285885 0.0263979 0.0230762 0.0289473 0.0228774 0.0294418 + 0.0267499 0.0286921 0.0264992 0.0286545 0.00710658 0.0243056 0.0300007 0.0259541 0.0201875 0.0247565 0.0270452 0.0233911 + 0.0229939 0.0228369 0.0133012 0.012843 0.0871963 0.0246926 0.0657357 0.0635794 0.0335347 0.0269127 0.0264792 0.0157239 + 0.0211304 0.0263682 0.0261471 0.0285947 0.0269631 0.0266218 0.0266833 0.0241741 0.0277662 0.0277551 0.0279545 0.027498 + 0.0245507 -0.0126297 -0.0122803 0.0274084 0.0231508 0.00308747 0.0197667 0.0242591 0.0300758 0.0195967 0.0576753 0.0280945 + 0.0143447 0.0245755 0.0277897 0.0276345 0.0266096 0.0267918 0.0268096 0.0472164 0.0287093 0.0235008 0.030103 0.0273378 + 0.0285112 0.028333 0.028419 0.0342388 0.0267102 0.026577 0.0285116 0.0285229 0.0287321 0.0239955 0.0812997 0.00661213 + 0.0280426 0.00685431 0.0303615 0.0232232 0.0238131 0.0267321 0.030549 0.0136393 0.0194886 0.0188158 0.088059 0.027047 + 0.0269289 0.0269233 0.0301755 0.0199596 0.0198159 0.05734 0.0573819 0.0564334 0.030247 0.023092 0.0230429 0.0299206 + 0.0290364 0.0615303 0.0268264 0.0267541 0.0283227 0.0303675 0.0304217 0.0274061 0.0268061 0.0228467 0.0298837 0.0268554 + 0.0286581 0.0302629 0.0255983 0.0255108 0.0295834 0.0296299 0.0297434 0.0273352 0.0275745 0.022429 0.02565 0.0207859 + 0.0266785 0.0279953 0.0266329 0.0199536 0.0278784 0.0265774 0.0279578 0.0263495 0.0305528 0.0282831 0.0296384 0.010004 + 0.0144282 0.0133657 0.00741781 0.0638386 0.0294044 0.0203529 0.00147172 0.035214 0.019405 0.0162306 0.0622537 0.064539 + 0.0276414 0.027002 0.0269085 0.0281546 0.0238379 0.0244629 0.016006 0.0271367 0.0268146 0.0267999 0.0292865 0.0290146 + 0.0298737 0.0268844 0.0304931 0.0716378 0.0267328 0.0193071 0.0153988 0.0295245 0.0305024 0.027727 0.0249173 0.0453826 + 0.0287397 0.0270235 0.0297847 0.0295359 0.0295777 0.0114049 0.0110809 0.0108477 0.0284416 0.0285452 0.0292261 0.0282133 + 0.0738071 0.0681732 0.05494 0.0806713 0.0266979 0.0267632 0.0271961 0.0270861 0.0270532 0.0247995 0.0377511 0.0125308 + 0.0305562 0.0272769 0.0271837 0.0185993 0.0523903 0.0268138 0.0484703 0.0492662 0.0472017 0.0263088 0.0226984 0.0225486 + 0.0581769 0.0267657 0.0674775 0.0273954 0.00601279 0.0279565 0.130502 0.128588 0.126461 0.0267879 0.0251933 0.02458 + 0.0274864 0.0268312 0.129291 0.127698 0.0277776 0.0275353 0.0260837 0.0246136 0.0503031 0.0512117 0.0521683 0.0287257 + 0.0222419 0.0301788 0.0268901 0.0196792 0.0132253 0.00164963 0.0177839 0.0291316 0.014497 0.0206358 0.0115448 0.0270942 + 0.0263873 0.0269321 0.0289286 0.029187 0.0267306 0.013696 0.0137592 0.0137626 0.0451496 0.0163268 0.0275791 0.00814233 + 0.00919998 0.00811218 0.0929715 0.0269229 0.028375 0.0231056 0.0302523 0.0289657 0.0272363 0.0271343 0.0271112 0.100679 + 0.0988222 0.0967 0.03031 0.00126199 0.070694 0.0715108 0.0262339 0.027296 0.0239569 0.0233048 0.00973455 0.0269033 + 0.0270149 0.0138112 0.0683477 0.0648321 0.000727886 0.0218924 0.0286524 0.086358 0.0267285 0.0269905 0.0224768 0.0231857 + 0.00382009 0.0181455 0.0275355 0.0276742 0.0280839 0.0274628 0.0281439 0.0656969 0.0262317 0.0224342 0.0285638 0.0303833 + 0.0253246 0.0563631 0.02728 0.0271906 0.0279673 0.022751 0.0228182 0.0164896 0.000221028 0.0134432 0.0284876 0.0288863 + 0.025801 0.0277216 0.0274524 0.047166 0.0267892 0.0221968 0.0191937 0.00461967 0.0294258 0.0528169 0.0268959 0.0274172 + 0.0184754 0.0270885 0.0502729 0.0281108 0.0279696 0.0201971 0.0279871 0.0128797 0.0297887 0.0268982 0.0284357 0.030093 + 0.0273876 0.0896659 0.0756191 0.00512273 0.0269231 0.0255996 0.0250299 0.0270358 0.0920333 0.0901079 0.0257198 0.0264701 + 0.0292581 0.0265699 0.0269862 0.0823763 0.059294 0.058431 0.00564874 0.00795276 0.0915823 0.0855203 4.81353e-05 0.0248893 + 0.0247504 0.039723 0.026243 0.0754188 0.0744193 0.0189816 0.0293572 0.0290547 0.0191639 0.063678 0.0218955 0.0194311 + 0.0266487 0.026819 0.0653439 0.0694392 0.0174036 0.0275557 0.0275722 0.0274362 0.0282001 0.00341604 0.0160919 0.0057994 + 0.0299191 0.0255041 0.0249057 0.000202075 0.0082687 0.0271101 0.0166613 0.0262827 0.026903 0.0262722 0.057651 0.0274357 + 0.0295402 -0.00295515 0.0316221 0.0266023 0.0268017 0.0682205 0.0518095 -0.00212716 0.0282937 0.0226828 0.0643902 0.00736694 + 0.0210975 0.0271228 0.0535518 0.0268295 0.0274511 0.0791719 0.0286756 0.0347946 0.0575198 0.0329379 0.0331797 0.0322697 + 0.0559294 0.0701255 0.0277133 0.0276859 0.0551938 0.0133148 0.0268306 0.0143948 0.0264745 0.0249386 0.0604372 0.0251115 + 0.0265137 0.0267553 0.00795705 0.0527781 0.0533585 0.0273436 0.0276014 0.0276078 0.0254075 0.0256343 0.0825582 0.0273385 + 0.0278275 0.0226545 0.0231815 0.0077776 0.0599907 0.0616005 0.0637436 0.0274729 0.0221001 0.0174683 0.0375151 0.0111428 + 0.039863 0.0215348 0.0291897 0.0132978 0.0265433 0.0274705 0.0292021 0.0276905 0.0271637 0.0580265 0.0549353 0.017606 + 0.0174079 0.0305162 0.0299414 0.0308944 0.0209881 0.0297227 0.0251127 0.0546845 0.0311484 0.02732 0.0526163 0.0684026 + 0.0329239 0.0127388 0.011178 0.0701949 0.0148693 0.0274373 0.0750595 0.0267 0.0465957 0.0520154 0.0266725 0.0492915 + 0.09838 0.0498519 0.020397 0.0217623 0.0272087 0.0833445 0.0840605 0.0137051 0.0282894 0.0267558 0.00805232 0.0101769 + 0.0164706 0.00699596 0.0362068 0.00935673 0.0178853 0.0530454 0.00881837 0.0296819 0.0300409 0.0267693 0.0293545 0.0652161 + 0.0121888 0.00974979 0.0104513 0.00759656 0.0212939 0.0148496 0.0152953 0.027378 0.0558306 0.0117311 0.0545379 0.0270276 + 0.0258631 0.0257566 0.0271834 -0.00406229 0.0136856 0.0362695 0.0291316 0.0594664 0.0475494 0.0278617 6.45267e-05 0.0376317 + 0.0266125 0.0198965 0.0603739 0.0605681 0.0269318 0.0588474 0.0661892 0.0104725 0.0558283 0.0136118 0.0259487 0.0512352 + 0.0406221 0.0451794 0.00974803 0.00898161 0.00897246 0.0279568 0.0218035 0.0824447 0.08585 0.0876782 0.00376154 0.0673113 + 0.0239553 0.0750847 0.00561541 0.0225074 0.0379574 0.00114163 0.0787479 0.0268309 0.0274694 0.0269655 0.0408722 0.0403969 + 0.00311445 0.0690139 0.0690792 0.0269198 0.054856 0.0545855 0.0264116 0.0339518 0.0336424 0.0184214 0.0664847 0.000204695 + 0.0296128 0.0277666 0.028117 0.0690999 0.0780129 0.0789327 0.0767346 0.016845 0.0264579 0.0125946 0.011891 0.0298382 + 0.0282691 0.070967 0.040664 0.0433046 0.019371 0.0157291 0.0694461 0.0393247 0.0387559 0.0211499 0.0181707 0.0190709 + 0.0190371 0.0238005 0.0244855 0.0257954 0.0188039 0.0287706 0.0234183 0.0172337 0.075798 0.0483506 0.0619224 0.026165 + 0.0456039 0.042602 0.0770758 0.0437853 0.0298116 0.0293432 0.0837574 0.02698 0.022449 0.0205605 0.0219539 0.0107516 + 0.057345 0.0449677 0.047028 0.0219385 0.0583072 0.0582451 0.0590649 0.00466231 0.0585634 0.0265978 0.0427673 0.0847261 + 0.0599013 0.0605105 0.0644123 0.0591329 0.0577788 -0.0052007 0.0261395 0.00349875 0.0719725 0.0568778 0.0266747 0.0134011 + 0.0135298 0.0457208 0.0159257 0.0432483 0.0275013 0.00402048 0.0260613 0.0263294 0.0421551 0.0145528 0.124326 0.0587654 + 0.0425255 0.0967994 0.000658593 0.0637898 0.0100682 0.027036 0.0527811 0.060145 0.0106239 0.0112786 0.0109265 0.000864372 + 0.0283448 0.0187593 0.0237733 0.0307401 0.0268373 0.0686289 0.0677689 0.0652002 0.0272965 0.0158076 0.0451289 0.0443306 + 0.0270929 1.02531e-05 0.0251779 0.0270583 0.0462406 0.0107572 0.0609147 0.0604402 0.0616064 0.0188736 0.0324282 0.021037 + 0.0240348 0.016046 0.00683622 0.00763139 0.00745424 0.0267153 0.00736455 0.114072 0.115984 0.0121576 0.0123222 0.0661214 + 0.086264 0.0724094 0.020561 0.108094 0.0247718 0.0183874 0.0849835 0.0150897 0.01562 0.0876344 0.00844162 0.0113467 + 0.0243943 0.0181193 0.0133774 0.0139003 0.0836342 0.011645 0.0120203 0.027676 0.0512016 0.0507577 0.0197406 0.00935074 + 0.0162096 0.0480912 0.0890723 0.0256183 0.0118877 0.0115333 0.0857678 0.0091807 0.00743106 0.00873133 0.00479143 0.00820362 + 0.0827218 0.00992012 0.0103495 0.024271 0.0307922 0.0620645 -0.00103742 -0.00106604 0.0270978 0.0190816 0.0198079 0.0145912 + 0.0146736 0.0137867 0.106273 0.110836 0.0621264 0.053641 0.00641619 0.00972664 0.00888527 0.0125218 0.0206941 0.0245371 + 0.0116629 0.0118702 0.0659144 0.131366 0.132416 0.0107308 0.0212906 0.0159252 0.0165969 0.0232212 0.0579152 0.00224846 + 0.00322099 0.00579482 0.00479555 0.06608 0.0444412 0.00849986 0.0600069 0.0597834 0.0655327 0.0147798 0.00698391 0.0359864 + 0.0264865 0.0345485 0.0370699 0.0530337 0.0514163 0.012461 0.0120586 0.0274789 0.0110381 0.0103727 0.0665526 0.00834178 + 0.013599 0.0216911 0.0634997 0.0222231 0.0144102 0.00823413 0.00881513 0.00599391 0.0066948 0.00970942 0.000299244 0.0794579 + 0.0849922 0.0638257 0.0137503 0.0136445 0.0136177 0.0340962 0.00589135 0.00706313 0.0125413 0.00482834 0.0836057 0.066418 + 0.0265896 0.0263847 6.44085e-06 0.0142462 0.0596979 0.0137008 0.0132172 0.00391925 0.0696683 0.0277184 0.0607018 0.0603196 + 0.0517962 0.028074 0.0276391 0.0366452 0.0121205 0.0102685 0.0598177 0.0592414 0.00241837 0.125327 0.128108 0.0145606 + 0.00730268 0.0065536 0.0195926 -0.00738799 -0.00660299 0.0671136 0.00669201 0.0117548 0.00854974 0.0280921 0.00456117 0.0134355 + 0.0805905 0.0113827 -0.00306338 -0.00195384 0.0196694 0.0208017 0.00500904 0.00583876 0.0617192 0.0269877 0.0199005 0.0228668 + 0.0127931 0.00906098 0.0132975 0.0253826 0.0558514 0.115202 0.110582 0.028632 0.0189735 0.0269406 0.00102795 0.00420402 + 0.0188164 0.0605702 0.0172869 0.0202813 0.010315 0.0539731 0.0566325 0.0278457 0.0732087 0.00819697 0.0171761 0.019031 + 0.0132025 0.000140503 0.034691 -0.00836229 -0.00743771 0.027546 0.027546 0.0265612 0.0501547 0.0959078 0.101237 0.097064 + -0.00209996 0.0301574 0.094139 0.00163635 0.015053 0.118964 0.114402 0.0677739 0.127346 0.0342559 0.0607105 0.0201853 + 0.000184501 0.0260041 0.068932 0.0123294 0.027551 -0.00565477 -0.0047555 0.014523 0.00861709 0.113661 0.114398 0.0177686 + 0.0125776 0.0127704 0.114869 0.0149052 0.0201715 0.0261317 0.0292475 0.0270973 0.132751 0.129808 0.00296591 0.00200131 + 0.00321105 0.027151 0.0906022 -0.0115925 0.0316506 0.0543545 -0.00353436 0.0262075 0.023961 0.0341295 0.0380593 -0.0064615 + 0.0106067 0.0110185 0.0265357 0.00724041 0.0143057 0.0140298 0.0667531 0.0739274 0.011337 0.0267333 0.00159795 0.00116822 + 0.0764189 0.0266424 0.0624617 0.0259082 0.0146537 0.0145247 0.0142936 -0.010058 -0.0108571 0.0258309 0.0482225 0.0100601 + 0.0219313 0.005876 0.0312889 0.0661468 0.0247212 0.0508764 0.0289004 0.0237401 0.00473173 0.0277545 0.0582629 0.0304364 + 0.107123 0.101777 0.014211 -0.00542194 -0.00421089 0.01627 0.123273 0.00730572 0.00392665 0.00655961 -0.012315 -0.0122586 + 0.0226952 0.000911544 -0.00194693 0.000736561 0.0145671 0.0144672 0.0774623 -0.00246898 0.0809449 0.123016 0.119378 -0.0123916 + -0.012849 -0.0109961 0.0283347 0.0655414 0.0564816 0.00341952 0.0276297 -0.00588665 -0.00854579 0.0248344 0.0840825 0.00585354 + 0.0750541 0.0758494 -0.00934638 0.00455431 0.0207227 0.00102496 0.0021672 -0.00976089 -0.00720447 -0.00461743 -0.0102518 -0.00947817 + -0.0122951 0.0698719 0.0737324 0.0618167 -0.0108188 -0.0120642 0.0144553 0.0289233 0.012926 0.0123932 0.0162979 0.0235069 + -0.0117734 -0.0107553 0.0119871 0.0244165 -0.0021543 -0.00339646 0.102679 0.104574 0.106087 0.0831921 0.0636895 0.0793241 + 0.111544 0.107066 0.0091785 0.00979688 -0.00168661 0.0194764 0.0779067 0.0290072 0.015669 0.132462 0.129761 0.0289697 + 0.0268127 0.0341054 0.0209394 0.00454119 0.0433738 0.0245385 0.0164239 0.00990267 2.85627e-05 0.00111536 0.10871 0.0295085 + 0.116819 -0.0117384 -0.0103982 0.0668978 0.0850527 0.0290084 0.0173199 0.0678903 0.0256256 0.0824631 0.053332 0.024833 + 0.0149955 0.0872131 0.00215556 0.1281 0.0378118 0.0113122 0.0147296 0.0820833 0.0301672 0.126107 0.121864 0.039472 + 0.0274547 -0.00305113 0.1149 0.0155057 0.0141918 0.0626504 0.0269152 0.0880717 0.0849106 0.0927339 0.0324102 0.131747 + 0.129194 0.0228465 0.00788169 0.00792221 0.00729877 0.0283045 0.0141317 -0.00200772 0.0798264 0.0163997 0.0396942 0.0243028 + 0.0737004 0.0288941 0.00395697 0.0627764 0.0115564 0.027557 0.0781711 0.00379207 0.0969829 0.0100058 0.00167896 0.0268085 + 0.0268104 0.0242433 0.0201235 0.0073934 -0.00534653 -0.00621391 0.0245729 0.0580227 0.0622945 0.0585808 0.00571058 0.00575368 + 0.00890012 0.0449633 0.00985075 0.01418 0.0761304 0.0639609 0.0259101 0.0257085 0.0439172 0.0142381 0.0257049 0.037135 + 0.0139038 0.023837 0.0251627 0.0782751 0.0267389 0.0273232 0.0203104 0.0126277 0.00872417 0.108107 0.0452357 0.0095282 + 0.0101794 0.0908066 0.0429833 0.0417975 0.0106745 0.0185625 0.0584264 0.0228626 0.0225236 0.0469973 0.0522482 0.03153 + 0.0798997 0.0671626 0.0147962 -0.0052431 0.0621644 0.0268953 0.00969142 0.0267525 0.0280129 0.0169143 0.0198803 0.0131382 + 0.0236836 0.12198 0.0645168 0.00947565 0.0273397 0.0142738 0.0273281 0.0225122 0.0519555 -0.000906984 0.0122606 0.00926329 + 0.0641785 -0.00475362 0.00559249 0.0591284 0.000257601 0.0105698 0.0152339 0.115943 0.00396018 0.023127 0.00429815 0.0743311 + 0.0669573 -0.00269346 0.0583116 0.0108786 0.0136602 0.0134887 0.00210706 0.00700948 0.00786341 0.0622372 0.0257472 0.0606667 + 0.0802424 0.0234691 0.039583 0.018371 0.00130715 0.0446806 0.00948662 0.109308 -0.00108091 0.0243893 0.0610243 0.00768791 + 0.00954068 0.0169408 -9.21718e-05 0.0193696 0.0229632 0.0102395 0.0284652 0.0227116 0.011162 0.0910116 0.0915196 0.0721065 + 0.119509 0.0600242 0.0391142 0.0386732 0.0287359 0.0109879 0.0166187 0.0318371 0.0355531 0.00570848 0.000264642 0.00625365 + 0.0744129 0.0284805 0.00498042 0.0329691 0.0537135 0.0159914 0.0665236 0.0396289 0.0214543 0.0331235 0.0363982 0.0397405 + 0.0157179 0.0231774 0.0244567 0.0319333 0.0775895 0.00842795 0.0178921 0.00377655 -0.000861718 0.0741181 0.0195113 0.00545325 + 0.016877 0.0695634 0.125818 0.0553519 0.055479 0.127553 -0.00175681 -0.000134352 0.0277511 0.0610423 0.0229255 0.0223429 + 0.059054 0.0204008 0.0143733 0.0141793 0.0194078 0.116083 0.0560661 0.0425052 0.0190695 0.0838614 0.0251168 0.0545224 + 0.0636584 0.0144933 0.020482 0.0209029 0.0284368 0.00533004 0.0452494 0.0516293 0.028377 0.00344784 0.0319141 0.0660915 + 0.000321242 0.0138687 0.0865645 0.0816705 0.00518686 0.0240818 0.0736599 0.00383206 0.0132241 0.0325864 0.064034 0.0216209 + 0.114829 0.0262047 0.0288649 0.092359 0.0284755 0.0156427 0.0184136 0.0174438 0.0171465 0.0117194 0.0285987 0.00926945 + 0.0957479 0.00213751 0.0234165 0.0108302 0.00823813 0.0111273 0.00547328 0.0598905 0.0288445 0.00149539 0.0146957 0.0282008 + 0.0115599 0.021714 0.000192875 0.0155716 0.0270568 0.0284676 0.0195514 0.0599848 0.00567421 0.00599903 0.00526341 0.00040559 + 0.00748948 0.00513398 0.0259859 0.0633683 0.0204061 0.000426157 0.0521183 -0.00104816 0.0551073 0.00299597 0.0740211 0.0031679 + 0.0590573 0.0281727 0.0275509 0.0157369 0.0136135 0.0124153 0.00794361 0.0138157 0.0132172 0.0913059 0.0218497 0.0684618 + 0.00470725 0.0140938 0.00854933 0.0237897 0.0151996 0.0232553 0.017495 0.0911152 0.0232476 0.0163114 0.0188385 0.0444373 + 0.0205235 0.0118283 0.103166 0.0617741 0.00951375 0.0279203 0.0163794 -0.0035509 0.0235256 0.0418904 0.0134975 0.025428 + 0.027295 0.0162862 0.0152381 0.031279 0.0100874 0.111645 0.0159359 0.0595307 0.0229398 0.0133707 -0.003103 0.0638001 + 0.0637972 0.0620687 0.0620723 -0.00173334 -0.000569255 -0.00174108 -0.000533648 0.0107358 0.0010891 0.0558068 0.0951042 0.00844556 + 0.0610193 0.0183911 -0.000673804 0.0047637 0.104432 0.0319709 0.00741805 0.00560178 0.0124536 0.00783893 0.0196216 0.00639733 + 0.0170568 0.0135958 0.023267 0.0295794 0.0197147 0.0261579 0.0170361 0.0919753 0.116397 0.0692797 0.000186678 0.0128462 + 0.0345283 0.0291201 -0.011064 0.0312932 0.0233397 0.0849836 0.020491 0.0624136 0.0250469 0.00685928 0.0228623 0.0264955 + 0.0237119 0.0205231 0.0318229 0.00988335 0.0471785 0.00994104 0.0280754 0.0103699 0.109345 -0.0048009 0.0464976 0.067435 + 0.0222181 0.0233061 0.00509349 0.000308027 0.026718 0.0263421 0.0462454 0.00420914 0.0310563 0.0127367 0.00406092 0.0284986 + 0.0290903 0.0144462 0.0138288 0.0600013 0.058761 0.0490039 0.0280707 0.0293596 0.051268 0.0313779 0.00317293 0.0151256 + 0.00996763 0.0617298 0.0142338 0.00370865 0.0257578 0.0240169 0.0940598 -0.00939962 0.0127203 0.0370393 0.0160418 -0.00426203 + 0.00693755 0.0264943 0.129923 0.0265137 0.020099 0.0426651 0.000235774 0.0268135 7.85362e-05 0.0311463 0.025198 0.0134507 + 0.0191197 0.0145349 0.032581 0.00875461 0.0255035 0.0490731 0.0748991 0.107296 0.089472 0.0295293 0.0606568 0.0190178 + 0.0223779 0.0219153 0.0615364 0.00208938 0.0289603 0.0139118 0.0266473 0.0086291 0.00313465 0.0135547 0.0260299 0.0384457 + -0.00614302 0.0615717 0.0270783 0.0155834 0.0205287 0.0179705 0.0268788 0.00832183 0.0135354 0.0266598 0.0251906 -0.00611915 + 0.00255207 0.00820498 0.000878867 0.0523906 0.0194459 0.00819644 0.0260991 0.0169108 0.026673 0.0983292 0.00310859 0.0176739 + 0.0265697 0.0290387 0.031604 0.0348562 0.0270729 0.00136483 0.00152315 0.0224298 0.0263506 0.0858075 0.0750752 0.00145577 + 0.0222923 0.0122177 0.0124971 0.0199126 0.0265004 0.0270074 0.0182753 0.0243116 0.00500697 0.0578229 0.0157376 0.0268575 + 0.089717 0.0294445 0.0709955 0.0264436 0.0123225 0.0804193 0.0189322 + + + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 + + + + + 0.259351 -0.000167713 0 -0.00333217 -0.000272575 0 0.350208 -0.0247828 0 0.109834 0.0307098 0 + 0.273159 0.000947572 0 0.0643274 0.085966 0 0.254043 0.0113949 0 0.242161 0.00774643 0 + 0.0293857 -0.00682329 0 -0.015389 0.000700217 0 0.0417921 0.0641607 0 -0.000902276 -0.00270107 0 + 0.256515 0.0115685 0 -0.00425587 -0.00880676 0 0.0521547 -9.85413e-05 0 0.384699 -0.0893988 0 + 0.270124 0.00130997 0 0.241128 0.00726771 0 0.294591 -0.0036501 0 0.150224 0.0179698 0 + 0.0755602 0.0519026 0 0.233019 -0.0275244 0 0.283108 0.000123548 0 0.0394084 -6.62629e-05 0 + 0.249923 0.00736626 0 0.194362 -0.0900125 0 0.0796312 0.00564205 0 0.268911 0.00117665 0 + 0.280668 0.000172187 0 0.266128 0.00127773 0 0.284053 8.59716e-05 0 0.299445 0.122378 0 + 0.0434793 -2.17372e-05 0 0.225574 0.0483638 0 0.0474473 -0.000761724 0 0.0314386 -2.15659e-05 0 + 0.0363273 -0.000923427 0 0.160073 0.0201777 0 0.269835 0.00111209 0 0.269905 0.0865931 0 + 0.27209 0.000996645 0 -0.00151169 -0.00362461 0 0.0662028 -0.0844654 0 0.0353626 0.000423504 0 + 0.0728402 9.19283e-05 0 0.312224 -0.0301346 0 0.271564 0.00111846 0 0.287501 -3.81291e-06 0 + 0.0419627 -9.626e-06 0 0.0882814 -0.00090689 0 0.237697 0.0394258 0 0.2857 5.58386e-05 0 + -0.00185948 0.00342446 0 0.07081 0.0227487 0 0.271359 0.0481247 0 0.281894 -0.0143609 0 + 0.0177026 -0.00643339 0 0.241546 0.00644594 0 0.303835 0.125001 0 0.0588011 -0.0119195 0 + 0.275126 0.00067533 0 0.073637 -0.00015226 0 0.289303 -0.0214185 0 0.199895 -0.0951663 0 + 0.251586 0.0321661 0 0.21892 -0.0409213 0 0.287433 -0.000741736 0 0.319205 -0.154682 0 + 0.206736 0.00521754 0 0.375407 -0.00145559 0 0.0471618 -3.41341e-05 0 0.00546532 0.00194464 0 + 0.242749 0.00690404 0 0.359901 -0.0233053 0 0.282835 -0.0161402 0 0.161241 0.0191807 0 + 0.271128 0.0896614 0 0.28078 0.0198528 0 0.293535 0.123433 0 -0.00367333 -0.00865585 0 + 0.048979 -0.0646477 0 0.28476 6.49157e-05 0 0.0830178 0.000570831 0 0.30493 -0.0272563 0 + 0.0687759 7.02683e-07 0 0.0597972 0.00200192 0 0.145158 -0.0188138 0 0.14978 0.113312 0 + 0.164224 0.00058838 0 0.0904073 -0.0120172 0 0.284814 3.71254e-05 0 0.058819 0.000848361 0 + 0.275906 0.153932 0 -0.00196592 -0.00847072 0 -0.000981611 -0.00314512 0 0.370874 -0.00214319 0 + 0.200209 0.00620456 0 0.043964 -0.000159425 0 0.0301239 -0.0067758 0 0.260594 0.0111959 0 + 0.0655677 -0.0802351 0 0.044847 0.000828929 0 0.219436 0.0454183 0 0.276382 0.000456988 0 + 0.343913 0.00529466 0 0.259283 0.0112361 0 0.280197 -0.000560573 0 0.0217479 -0.00730431 0 + 0.0816011 -0.0148004 0 0.0104626 4.69894e-06 0 0.235044 -0.0257247 0 -0.0154202 0.000715045 0 + 0.0691191 7.52602e-05 0 0.0667108 0.000167747 0 0.0672328 -4.1585e-05 0 0.281512 7.91726e-05 0 + 0.378931 -0.0173705 0 0.277626 0.00055079 0 0.279507 0.000400974 0 0.0443608 0.0028942 0 + 0.279793 0.000171367 0 0.197078 0.0239681 0 0.263639 -0.00018705 0 -0.00221007 0.00438657 0 + 0.194603 0.063651 0 0.282381 0.000127538 0 0.281853 -0.0156987 0 0.124544 -0.00175685 0 + 0.210715 -0.0215586 0 0.278588 0.000410257 0 0.268666 -0.00256916 0 0.00891533 -0.00406836 0 + 0.0150276 0.039045 0 0.294964 -0.0033269 0 0.0488875 -0.0103112 0 0.170629 0.0209849 0 + 0.222167 0.0591212 0 0.201113 0.0238148 0 0.279837 0.000239373 0 0.0915695 -0.000258135 0 + 0.283833 3.67321e-05 0 0.368918 -0.0232806 0 0.271268 -0.00255048 0 0.279652 0.000333783 0 + 0.217294 0.0649102 0 0.0442893 0.00116447 0 0.259037 0.0477616 0 0.280984 0.00016708 0 + 0.252626 -0.00204423 0 0.0875192 -0.0159091 0 0.297878 0.127008 0 0.25588 -0.000141645 0 + 0.280356 7.42084e-05 0 0.00474799 -0.00196122 0 0.0499086 8.77975e-05 0 0.0623729 0.0539151 0 + 0.0173076 -0.006471 0 0.100326 0.000402356 0 0.28521 4.76997e-05 0 0.277966 0.000512776 0 + 0.2809 0.0217819 0 0.0475025 -4.70201e-05 0 0.046388 1.0181e-05 0 0.285873 0.00542265 0 + 0.154171 -0.10374 0 -0.00129812 -0.00395623 0 0.049446 7.19479e-05 0 0.136785 -0.000857985 0 + 0.049113 -9.15271e-05 0 0.346403 -0.134288 0 0.0446587 5.55092e-05 0 0.276404 0.000535927 0 + 0.276902 0.000531909 0 0.11788 -0.0194929 0 0.0852011 0.0157569 0 0.162997 -0.0297669 0 + 0.21317 0.0436797 0 0.0288454 0.00898369 0 0.124043 -0.000211002 0 0.264632 0.117335 0 + 0.0320343 3.07923e-05 0 0.288212 -0.000278445 0 -0.0154359 0.000445704 0 0.295852 -0.0397531 0 + 0.223084 0.0379391 0 0.366978 -0.0241468 0 0.131089 -0.00023258 0 0.108967 0.0305407 0 + 0.0524514 -0.000106713 0 0.0850526 -0.00178538 0 0.282354 0.000111976 0 0.134785 0.147952 0 + 0.0172687 -0.045313 0 0.314237 -0.0318162 0 0.286416 0.0831159 0 0.0113053 -0.0336644 0 + 0.279912 0.000155908 0 0.282877 0.0243329 0 0.287477 -0.000585877 0 0.198632 0.100706 0 + 0.260175 -0.0369078 0 0.00825011 0.0040282 0 0.196337 0.109333 0 0.309331 -0.0290481 0 + 0.0737677 0.0880733 0 0.104599 -0.000321614 0 0.254089 -0.00270585 0 0.24766 0.0072695 0 + 0.038167 6.46568e-05 0 0.0528164 0.00010218 0 0.274627 0.000743735 0 0.238622 0.0403164 0 + 0.123878 0.0340735 0 0.291535 -0.038644 0 0.0444421 -3.32064e-05 0 0.385289 0.0963136 0 + 0.171742 0.104814 0 0.159474 0.000348083 0 0.281861 -0.0396614 0 0.267287 -0.00250093 0 + -0.00204658 -0.00471328 0 0.0919748 0.0170937 0 0.0879063 -3.95332e-05 0 0.0825922 -0.000261744 0 + 0.219806 0.0134858 0 0.273056 0.000921541 0 0.242279 0.0320665 0 0.274932 0.000790391 0 + 0.0933767 0.0616688 0 0.0233518 0.0545166 0 0.369747 0.0453066 0 0.169561 0.113452 0 + 0.0179136 0.0121511 0 0.302811 -0.0418839 0 0.0746507 0.000153381 0 0.00388447 -0.00147363 0 + 0.267302 0.0134331 0 0.0458016 6.57098e-05 0 0.268945 -0.00347336 0 0.00180686 -0.00334106 0 + 0.261554 0.114209 0 0.03591 4.99662e-05 0 0.05846 -0.000117747 0 0.0265014 0.00974373 0 + 0.282183 0.000212547 0 0.282083 0.000203045 0 0.369631 0.0214892 0 0.0522496 0.0764858 0 + 0.277291 -0.0152553 0 0.204648 -0.1946 0 0.116332 0.0316366 0 0.335323 -0.00295033 0 + 0.0625171 0.0789264 0 0.367285 0.010829 0 0.283282 8.82019e-05 0 0.0475872 8.9712e-05 0 + 0.0468773 2.64772e-05 0 0.279932 0.000383637 0 0.281181 0.000290811 0 0.281057 0.000282111 0 + 0.280699 0.0228157 0 0.0360748 -2.92326e-05 0 0.16951 -0.0118038 0 0.383549 -0.0210993 0 + 0.0454991 8.02096e-05 0 0.287075 -0.000806103 0 0.296813 0.0477886 0 0.273756 -0.112536 0 + 0.274903 -0.117783 0 0.0501665 -0.00433861 0 0.281743 0.000127998 0 0.302382 0.00309256 0 + 0.138083 -0.0179488 0 0.0879087 -0.0530704 0 0.249043 0.00552734 0 0.283097 -0.0149762 0 + 0.277219 0.000471422 0 0.261942 0.0458892 0 0.315612 -0.0343174 0 -0.00198271 0.00502896 0 + 0.348021 0.0164655 0 0.122759 0.00277926 0 0.251989 -0.0759203 0 0.230193 -0.0259631 0 + 0.0619573 -4.30222e-05 0 0.05627 -3.15147e-05 0 0.277773 0.000464017 0 0.229183 0.0169833 0 + 0.211774 -0.0651125 0 0.0216435 0.00953941 0 0.194237 0.0264657 0 0.196297 0.010855 0 + 0.165944 0.0758598 0 0.169679 0.00136975 0 0.249782 -0.0772105 0 0.0684592 -3.64647e-05 0 + -0.00694514 -0.00348934 0 0.163898 -0.0366242 0 0.0359971 -2.69155e-05 0 0.106868 0.0308837 0 + 0.275332 0.0214245 0 0.286414 8.11044e-06 0 0.0475446 0.00136618 0 0.341796 0.0324307 0 + -0.0156056 0.000518073 0 0.035326 3.52253e-05 0 0.260067 -0.00105248 0 0.00503823 -0.00129102 0 + 0.0739293 -0.0463239 0 0.286337 0.0466775 0 0.264686 0.0635505 0 0.175568 -0.0211297 0 + 0.0392543 -6.98964e-05 0 0.383812 0.100436 0 0.294804 0.00591759 0 0.0892614 0.0536921 0 + 0.17117 -0.0289721 0 0.0187765 0.00666731 0 0.284629 -0.00140052 0 0.211104 0.00715116 0 + 0.0693996 3.56685e-05 0 0.0791912 0.0663434 0 0.236494 -0.0615753 0 0.0747503 -4.6878e-05 0 + 0.058119 5.21537e-05 0 0.285177 -0.00133764 0 0.0598289 8.00171e-05 0 0.266619 -0.00345697 0 + 0.0937209 -0.00354337 0 0.393081 -0.0744935 0 0.017945 0.00395358 0 0.0477921 0.000341269 0 + 0.0865863 0.00673434 0 0.345426 0.117848 0 0.259353 0.00226216 0 0.248355 0.0310759 0 + 0.29296 0.00778601 0 0.259578 0.00258884 0 0.142902 -0.015857 0 0.0103457 -0.00217361 0 + 0.222435 -0.0408537 0 0.013051 -0.00539094 0 0.267368 0.0173544 0 0.276298 -0.0158061 0 + 0.269983 -0.00381585 0 0.362085 -0.00440822 0 0.283608 7.48695e-05 0 0.12281 -0.000533366 0 + 0.329502 -0.0293422 0 0.246387 0.0051559 0 0.263316 0.0493646 0 0.247497 0.00522433 0 + 0.0148497 0.00382424 0 0.323235 0.00164922 0 0.0332263 1.72267e-05 0 0.0412087 -0.0087602 0 + 0.269532 -0.00377425 0 0.281158 0.000117865 0 0.0596677 -0.0679246 0 0.305427 0.0476396 0 + 0.287374 -0.000720433 0 0.267646 0.0165966 0 0.26011 -0.0399245 0 0.228137 -0.0564217 0 + 0.285993 -0.00481449 0 0.37156 0.0169407 0 0.178661 -0.0308894 0 0.265608 -0.00241565 0 + 0.254542 -0.0706105 0 0.228079 -0.0357194 0 0.169929 -0.0236865 0 0.18555 0.00652645 0 + 0.0953893 0.0284972 0 0.255269 -0.00280466 0 0.0337935 8.64375e-06 0 0.0147707 -0.00365468 0 + 0.062832 -0.00122731 0 0.0938775 0.0175517 0 0.282619 0.000104288 0 0.306046 -0.026364 0 + 0.139025 -0.0155407 0 0.0480717 -9.59391e-05 0 0.226578 -0.020793 0 0.217058 0.00843542 0 + 0.195699 0.179484 0 0.38508 0.0053475 0 0.0574134 7.67869e-05 0 0.0451827 6.90705e-06 0 + 0.113055 -0.00073607 0 0.219565 0.0466268 0 0.109294 -0.103282 0 0.281386 0.0247761 0 + 0.0418905 1.41228e-05 0 0.359587 -0.00666355 0 -0.0036864 0.00869747 0 -0.00377906 0.00746528 0 + 0.118616 0.00173749 0 0.17483 0.0224813 0 0.0417997 -0.00913195 0 0.172572 0.000373241 0 + 0.293194 -0.139521 0 0.364336 -0.0275022 0 0.224603 -0.198198 0 0.268752 -0.00388342 0 + 0.250638 0.00653065 0 0.369986 0.0152219 0 0.333611 0.0419371 0 0.278291 0.000404697 0 + 0.0494273 0.0654578 0 0.0120155 0.00342613 0 0.198702 0.00609879 0 0.212297 -0.00770809 0 + 0.237358 0.042261 0 0.11282 -0.0171566 0 0.275295 0.00115849 0 0.269356 -0.00391028 0 + 0.105086 0.0308208 0 0.04752 -0.00974086 0 0.2847 0.0469318 0 0.345082 0.0300925 0 + 0.307335 0.175161 0 0.295432 0.00964252 0 0.00956976 1.16461e-05 0 0.0576792 1.8931e-05 0 + 0.274232 0.022957 0 0.0436681 3.13475e-05 0 0.270669 -0.0420581 0 0.119317 -0.00193892 0 + 0.265215 0.0604045 0 0.278665 0.00040417 0 0.0867986 0.000294082 0 0.0988303 -0.137793 0 + 0.148812 0.0423348 0 0.164019 0.000409282 0 0.0750877 -0.00166659 0 0.262439 0.0413625 0 + 0.123741 -0.000675573 0 0.030508 0.0101424 0 0.265487 0.006113 0 0.282784 0.000125049 0 + 0.353851 -0.000297888 0 -0.00434173 0.00766686 0 0.0613128 0.0170645 0 0.0865037 -0.000288415 0 + 0.388264 -0.0846783 0 0.17144 0.170684 0 0.105088 0.00288825 0 0.00447605 -0.00245664 0 + 0.293245 0.00731651 0 0.27414 0.0821916 0 -0.0131752 0.000754351 0 0.0467376 0.0114535 0 + 0.171089 0.0198159 0 0.124373 0.151219 0 0.214647 -0.195923 0 0.225215 0.0149819 0 + 0.0799881 0.0252079 0 0.0806987 0.00156616 0 0.183591 0.0281579 0 0.245865 -0.0395376 0 + 0.280799 0.000133274 0 0.33227 0.0371408 0 0.12382 -0.00985104 0 0.28878 -0.00439777 0 + 0.273804 0.122129 0 0.272902 -0.00105381 0 0.208376 -0.0394223 0 0.286839 0.0262156 0 + 0.273263 -0.169726 0 0.0643957 8.89711e-05 0 -0.00844736 0.000254421 0 0.062248 4.06866e-05 0 + 0.122221 0.1436 0 0.277648 -0.014706 0 0.0892258 -0.000451396 0 -0.00187246 -0.0036294 0 + 0.282993 9.05967e-05 0 0.0489885 0.0324798 0 0.0216662 0.0100779 0 0.114991 0.018546 0 + -0.00194558 -0.00478585 0 0.123541 -0.0217776 0 0.349751 0.116658 0 0.254699 -0.076669 0 + 0.0438081 -0.0086112 0 0.365311 0.0420002 0 0.0426207 8.33092e-06 0 0.357264 0.0142257 0 + 0.0114656 0.00334219 0 0.360035 -0.00165999 0 0.291257 0.160926 0 0.289644 -0.125358 0 + 0.261976 -0.00808074 0 0.192651 0.174434 0 0.216422 -0.0175691 0 0.17235 -0.0256091 0 + 0.0973571 -0.00238522 0 0.264569 0.0071823 0 0.0669825 0.00142514 0 0.0280733 -0.0594572 0 + 0.123119 -0.0180635 0 0.0441592 6.78383e-05 0 0.294587 0.0037097 0 0.295718 0.00418459 0 + 0.281721 -0.0167342 0 0.180361 0.0214118 0 0.257663 0.0338895 0 0.0577174 6.21198e-05 0 + 0.12154 0.0734561 0 0.154589 0.159773 0 -0.0159315 0.000184262 0 0.19125 -0.0210901 0 + 0.250997 -0.00432614 0 0.267415 0.0852871 0 0.243556 0.00628548 0 0.212168 0.0418257 0 + 0.286116 -0.00118349 0 0.218061 0.0299872 0 0.0698553 0.0155546 0 0.191838 0.0306942 0 + 0.0118377 0.0102307 0 0.084064 -0.123098 0 0.0570205 0.0401335 0 0.240779 0.0429135 0 + 0.176885 0.00613645 0 0.165963 0.0193602 0 0.249516 0.00553009 0 0.136497 0.0991742 0 + 0.123672 -0.00750223 0 0.314739 -0.150593 0 0.257004 -0.00338675 0 0.288266 0.0744137 0 + 0.286699 -0.000487764 0 -0.0039017 0.000411925 0 0.251306 0.0094372 0 0.0877057 -0.00039846 0 + 0.253167 -0.0668399 0 0.214066 -0.0394685 0 0.264903 0.001553 0 0.264626 0.00182439 0 + 0.286399 -0.00120327 0 0.252484 -0.00446356 0 0.291333 -0.0087205 0 0.218685 -0.00434553 0 + 0.00748397 -0.000385161 0 0.0192602 1.14421e-05 0 0.28632 -0.0219127 0 0.0887332 0.00820242 0 + 0.182239 -0.0385302 0 0.329643 0.0355149 0 0.286532 -0.00109343 0 0.250613 0.00632364 0 + 0.160294 -0.00549337 0 0.333519 -0.0294353 0 0.0598423 -0.0124133 0 0.227576 0.0428308 0 + 0.048612 7.02479e-05 0 0.189926 0.0217916 0 0.251411 0.00405979 0 0.0571335 -9.78865e-06 0 + 0.129272 -0.0106584 0 0.251272 0.0037713 0 0.240676 0.00560562 0 0.364091 -0.0261442 0 + 0.211907 -0.0175618 0 0.16595 0.0076829 0 0.250769 -0.00463157 0 0.325903 0.177964 0 + 0.334089 -0.0289481 0 0.252641 -0.00490347 0 0.192453 0.0101702 0 0.250799 0.0413144 0 + 0.271852 -0.0425158 0 0.0776649 0.00210254 0 0.269075 -0.000212899 0 0.335608 -0.00992782 0 + 0.389379 -0.065451 0 0.181997 0.0205456 0 0.277062 -0.00134913 0 0.287934 -0.127633 0 + 0.0819907 0.0224423 0 0.0126289 0.00557372 0 0.247783 -0.00703434 0 0.0986718 -0.000718749 0 + 0.385662 -0.0941203 0 0.319723 -0.0357431 0 -0.0161232 0.00029433 0 0.00632245 -0.00201365 0 + 0.302616 -0.00381391 0 0.000892035 0.00264752 0 0.0516318 0.0120738 0 0.130653 0.00569222 0 + 0.0702287 -0.00179398 0 0.00999942 -0.0014185 0 0.00989659 4.92298e-07 0 0.112195 -0.000310856 0 + 0.048289 -6.3811e-05 0 0.134414 -0.123963 0 0.254901 -0.000351942 0 0.0234584 0.000289893 0 + 0.0625986 0.00142296 0 0.0670131 0.00035301 0 0.283926 0.0245351 0 0.04246 -0.00859331 0 + 0.0795654 0.0260725 0 0.234776 0.0689828 0 0.284431 9.38581e-05 0 0.258003 -0.0986271 0 + -0.00728624 -0.00306296 0 0.284669 8.19659e-05 0 0.0626444 -4.0636e-05 0 -0.010126 0.00438195 0 + 0.371991 -0.100723 0 0.0753177 6.22964e-05 0 0.173763 0.0266344 0 0.0827726 0.0168327 0 + 0.371666 0.0185761 0 -0.0102237 0.0045783 0 0.0450695 2.03902e-05 0 0.217904 -3.11443e-05 0 + -0.0014957 -0.00424968 0 0.0622776 -0.000104814 0 0.269969 -0.00248247 0 0.224371 -4.96934e-05 0 + 0.257881 -0.00619939 0 -0.00169462 -0.00375746 0 -0.0020766 -0.0055638 0 0.313044 0.0317388 0 + 0.300471 0.0457704 0 0.28285 3.93258e-05 0 0.250536 -0.000290991 0 0.369897 0.0196749 0 + 0.274918 -0.0146579 0 0.273814 -0.0254128 0 0.217374 -0.0678647 0 0.256602 0.0309759 0 + 0.0913516 -0.00110039 0 0.365859 0.0565283 0 0.389681 -0.0329931 0 0.3316 -0.0276466 0 + 0.328093 -0.0126887 0 -0.00926136 -0.00464122 0 0.198175 -0.017336 0 0.00345552 0.00646755 0 + 0.315714 0.173214 0 0.265244 -0.0373776 0 0.389341 0.0821476 0 0.287264 -0.00105694 0 + 0.225217 -0.199121 0 0.0579713 -0.00100704 0 0.266074 0.0873335 0 0.278921 0.000106003 0 + 0.356787 0.0079599 0 0.17861 0.0045678 0 0.0407503 2.01093e-05 0 0.275554 0.0736175 0 + 0.287984 -2.81893e-05 0 0.0326603 -0.0046583 0 0.0209575 -0.0114403 0 0.318687 -0.0348162 0 + 0.287572 -0.000607252 0 0.0995782 0.00118695 0 0.167487 0.0165146 0 0.27287 -0.000233514 0 + -0.00297269 -0.00882284 0 0.00452396 0.000214329 0 0.061278 -0.000125039 0 0.347429 0.170705 0 + 0.286421 -0.00101586 0 0.27571 -0.133565 0 0.0203649 -0.00518897 0 0.300801 0.0461147 0 + 0.26834 -0.00240512 0 0.0410288 0.0162612 0 0.0694621 -0.000158929 0 -0.00132197 0.00536675 0 + 0.373476 0.0972318 0 0.290145 -0.000280289 0 0.170013 -0.0267337 0 0.066731 -0.0565988 0 + 0.167327 -0.0282288 0 0.297088 -0.000226095 0 0.263274 0.0111539 0 -0.0017905 -0.00382558 0 + 0.286902 -0.000917218 0 0.191912 0.167338 0 0.0557592 -0.000106924 0 0.0499762 7.14304e-05 0 + 0.273661 0.0480797 0 0.279365 0.0980992 0 0.330682 -0.0321676 0 0.107443 0.00199061 0 + 0.289688 -0.000549276 0 0.271516 -0.0279339 0 0.054205 -0.000250948 0 0.260827 -0.00328965 0 + 0.269712 0.00089104 0 0.269184 0.00114565 0 0.251794 -0.0900761 0 0.266313 0.0812066 0 + 0.267495 -0.0337203 0 0.106065 0.0196547 0 0.0331261 -0.00803342 0 0.346952 0.0250134 0 + 0.338843 0.0801178 0 0.180478 0.170151 0 0.392529 -0.0643173 0 0.0556528 -0.000398425 0 + 0.200322 -0.179113 0 0.358964 -0.0740558 0 0.242049 -0.0184785 0 0.0554271 0.000399225 0 + 0.363356 -0.0120277 0 0.246496 0.0569783 0 0.0597675 0.00205396 0 0.165309 -0.0245225 0 + 0.0515504 0.0114185 0 0.345163 0.0318181 0 0.315601 -0.144486 0 0.386541 0.00554401 0 + 0.282145 0.0412819 0 0.255307 0.00424225 0 0.0790527 0.0146742 0 0.112581 0.0827351 0 + 0.269479 0.0440955 0 0.0901835 0.104002 0 -0.00100658 -0.00188664 0 0.287312 -1.38893e-05 0 + 0.0908986 0.0127856 0 0.0282174 -0.00149631 0 0.299041 0.000153393 0 0.156224 -0.0244113 0 + 0.26032 0.00515379 0 0.323375 -0.0299551 0 0.207719 0.0653632 0 0.104363 -0.0239788 0 + 0.136408 0.162765 0 0.285076 -0.00105728 0 0.297987 0.196616 0 0.154436 0.0031735 0 + 0.32823 -0.0253536 0 0.280912 -0.167805 0 0.272532 0.0418318 0 0.284245 4.81764e-05 0 + 0.278655 -0.00532991 0 0.0727272 0.000150541 0 0.28099 -0.000571967 0 0.324707 0.172938 0 + 0.0442766 -0.00723948 0 0.0800885 -6.2844e-05 0 0.277592 -0.00136362 0 0.296395 0.0401479 0 + 0.195314 0.0246899 0 0.0525613 -0.00876748 0 0.388189 0.0871548 0 0.288679 -0.000554653 0 + 0.286852 3.33827e-06 0 0.278253 0.000350076 0 0.343296 -0.0748611 0 0.373646 -0.0574092 0 + 0.214939 -0.0191861 0 0.0435786 4.51795e-05 0 0.00155967 -0.00117915 0 0.0132621 -5.73298e-05 0 + 0.196942 -0.0796605 0 0.146413 0.0327296 0 0.0182786 1.48741e-06 0 0.386602 -0.0792953 0 + 0.279883 -0.00557529 0 0.0769045 -0.0675464 0 0.0252207 0.00258898 0 0.159219 0.165794 0 + 0.0659888 6.57661e-06 0 0.249903 0.0037612 0 0.0777507 -0.000223678 0 -0.0121185 -0.00199063 0 + 0.145803 0.0106579 0 0.0406786 5.50944e-05 0 0.0663885 3.86962e-05 0 0.0735337 0.000196706 0 + 0.265308 0.0826472 0 0.271641 -0.0253523 0 0.348489 -0.023853 0 0.315958 -0.0273312 0 + 0.121782 -0.000520199 0 -0.000484915 0.000575697 0 0.188772 -0.0392279 0 0.321492 -0.0130543 0 + 0.225639 -0.024246 0 0.082846 -0.0128188 0 0.130007 0.00551742 0 0.339027 0.113997 0 + 0.287482 -0.000651754 0 0.238587 -0.0286042 0 0.134697 0.031061 0 0.0646093 3.04267e-05 0 + 0.0184103 4.91759e-06 0 0.239444 -0.0274145 0 0.288372 -0.000642294 0 0.287539 -0.000177805 0 + 0.27546 -0.00737517 0 0.139517 -0.00610702 0 0.256746 -0.0944264 0 0.369715 0.15183 0 + 0.278392 -0.00119281 0 0.353455 0.0613662 0 0.183703 -0.0304347 0 0.366042 -0.0266884 0 + 0.271925 0.0267083 0 0.234867 0.0266925 0 0.14349 0.00572028 0 0.196913 0.0310986 0 + -0.00132756 -0.00793744 0 0.0424906 -6.1072e-05 0 0.0613946 6.1173e-05 0 0.194665 0.0351494 0 + 0.210083 -0.024482 0 0.0908311 0.00436116 0 0.00856089 -7.57317e-07 0 0.0016764 -0.0046716 0 + 0.0258282 -0.00861753 0 0.370139 0.0188883 0 0.197804 0.0258885 0 0.0107294 0.00351185 0 + 0.288218 -0.000848186 0 0.244948 0.124591 0 0.0635937 0.000160064 0 0.150495 -0.141121 0 + 0.195505 0.0291792 0 0.27761 9.60733e-05 0 0.289797 -0.000149628 0 0.124301 -0.000379743 0 + 0.207083 -0.0346977 0 0.0870174 -0.0039002 0 0.261564 -0.000134926 0 0.251253 -0.000155127 0 + 0.193526 0.0889995 0 0.257447 0.00281381 0 0.27167 0.0127127 0 0.268108 0.0480373 0 + -0.0012086 -0.00254445 0 0.115984 0.0202095 0 0.257615 0.0025944 0 0.266735 -0.155462 0 + -0.002186 -0.00475459 0 0.339759 0.0306493 0 -0.00303289 -0.00756623 0 -0.00030668 0.00265572 0 + 0.096717 -0.0954938 0 0.0167801 -0.00261544 0 0.194418 0.0109188 0 0.0348964 0.010375 0 + 0.278198 -0.00123134 0 0.260141 -0.0943408 0 0.146586 0.0170452 0 0.372439 0.148445 0 + 0.278855 0.000344039 0 0.0576878 1.15315e-06 0 -0.00584625 -0.0032 0 -0.0124983 0.00125978 0 + 0.0471257 8.507e-05 0 -0.00525653 -0.00821165 0 0.0255687 -0.000138827 0 0.0420715 3.72903e-05 0 + 0.289428 0.0412662 0 0.254358 -0.0381173 0 0.0820913 0.108374 0 0.22714 0.0167331 0 + 0.306231 0.0298823 0 0.0421166 -1.26825e-05 0 0.32761 -0.00841892 0 0.362711 0.0117853 0 + 0.250162 0.00407011 0 0.0681161 -0.0135449 0 0.353989 -0.0374163 0 0.269063 0.0195835 0 + 0.177575 0.0689905 0 -0.00253266 -7.84486e-05 0 0.0359186 0.00482926 0 0.274619 0.0481366 0 + 0.16073 -0.0983486 0 0.0417406 -0.00707033 0 0.117246 0.0211867 0 0.248633 0.0708845 0 + 0.182167 0.0291204 0 0.181454 0.017698 0 0.270385 0.000152867 0 0.216813 0.00898058 0 + 0.260114 -0.0987037 0 0.0452971 -0.00821746 0 0.0443395 0.00370166 0 0.269016 -0.00327994 0 + -0.00257126 0.00815389 0 0.2547 -0.00893262 0 0.253904 -0.0646145 0 0.00548192 -0.00588823 0 + 0.229676 -0.0148704 0 0.359964 -0.0645317 0 0.35556 -0.0587019 0 -0.00994323 -0.00410413 0 + 0.298216 -0.000252155 0 0.0485306 6.62649e-05 0 0.0883714 -0.0138645 0 -0.00806091 0.00108456 0 + 0.1799 0.00914048 0 0.0254649 -1.69318e-05 0 0.108838 -0.000408507 0 0.187747 0.0241208 0 + 0.286015 6.1496e-06 0 0.124237 0.000462105 0 0.237859 0.0218697 0 0.392926 -0.0789351 0 + 0.0537517 -0.0106017 0 0.2889 -0.0427851 0 0.0730356 -0.0320159 0 0.272669 -0.158661 0 + 0.293268 0.163873 0 0.370947 0.012437 0 0.250709 -0.0715541 0 0.237195 -0.0597978 0 + 0.298724 0.00121751 0 0.226038 -0.0223595 0 0.23453 -0.0253035 0 0.0252181 -1.68561e-05 0 + 0.226806 -0.0753192 0 0.262491 -0.198751 0 0.190165 0.0191066 0 0.278309 -0.00215037 0 + 0.270703 -0.0036922 0 0.0289799 -0.00438659 0 0.318598 -0.0292981 0 0.0382733 -0.0594571 0 + 0.0451694 0.00582312 0 0.309765 -0.0142676 0 0.189778 -0.0487864 0 0.195198 -0.183077 0 + 0.0406864 -6.30188e-05 0 0.0706362 9.09267e-05 0 0.281959 0.0907599 0 0.279137 0.000304572 0 + 0.0513727 -8.8374e-05 0 0.259972 0.0026489 0 0.269283 -0.137726 0 0.114719 -0.000553595 0 + 0.286033 0.0170878 0 0.260243 0.00243537 0 0.272429 0.026435 0 0.00957063 -0.0296632 0 + 0.00640572 -0.00127033 0 0.171036 -0.00536201 0 0.111573 0.0306143 0 0.0475577 -8.00403e-05 0 + 0.0828199 -0.00178015 0 0.167657 0.000338007 0 0.147704 0.000436299 0 0.361203 0.0308039 0 + 0.116665 -0.0254682 0 0.270269 -0.00366593 0 0.116829 -0.000475558 0 0.159203 -0.00255268 0 + 0.0339747 2.39961e-05 0 0.252265 0.00330396 0 0.0597029 0.00893323 0 0.193817 -0.0124608 0 + 0.21823 -0.0189554 0 0.264963 0.0501627 0 0.270566 0.120796 0 0.370382 -0.053286 0 + 0.322043 0.0718423 0 0.0943777 -0.015677 0 0.0225404 -0.00596081 0 0.310395 -0.11959 0 + 0.324285 0.00333698 0 0.0237664 0.0086953 0 0.275283 -0.0141646 0 0.340833 -0.0333298 0 + 0.0518468 -0.0125719 0 0.116921 -0.0270516 0 0.00691157 0.00723883 0 0.218635 0.0306906 0 + -0.0131135 -0.00153664 0 0.0683526 0.000177142 0 0.173238 -0.157388 0 0.290543 -0.000525199 0 + 0.300941 0.0397418 0 0.149395 -0.00223657 0 0.0807479 -0.000231416 0 0.349945 0.0234964 0 + 0.172965 -0.0284036 0 0.278732 -0.00146929 0 0.0253102 -0.00799537 0 0.0680274 -0.01361 0 + 0.00354955 -0.00190092 0 0.103008 0.00924164 0 0.129137 -0.040022 0 0.0411569 -0.0113014 0 + 0.365308 0.0258735 0 0.048378 0.00359945 0 0.360899 0.0628157 0 0.159971 0.116918 0 + 0.316999 -0.0102862 0 0.0354746 0.00068254 0 0.314048 -0.0177605 0 0.042848 -0.0048573 0 + 0.31945 -0.0323045 0 0.241471 0.052938 0 0.108136 0.0010629 0 0.211356 -0.0586858 0 + 0.0678367 2.88634e-05 0 0.16464 0.00783561 0 0.0680603 0.11065 0 0.0262567 0.0129793 0 + 0.27774 -0.0023264 0 0.262352 0.0678176 0 0.0976343 -0.000630979 0 0.334282 -0.0325646 0 + 0.298634 -0.121164 0 -0.00298204 -0.00733744 0 0.310972 -0.140121 0 0.00993428 -5.23809e-06 0 + 0.0186244 0.0120422 0 0.271848 -0.00103589 0 0.288239 -0.000872409 0 0.282316 0.0248369 0 + 0.0965832 0.017631 0 0.290194 -0.0431111 0 0.259886 -0.00100173 0 -0.00265364 -0.00616357 0 + 0.20226 -0.167628 0 0.367396 0.0240976 0 -0.00385349 -0.0045076 0 0.283189 -0.000534724 0 + 0.312316 -0.0337362 0 0.292091 0.00903879 0 0.0799141 0.0616963 0 0.251066 -0.0360137 0 + 0.0910673 0.00176911 0 0.104976 -0.106418 0 0.151666 0.000504288 0 0.278919 -0.00146651 0 + 0.160789 -0.0117767 0 0.0440668 -4.29267e-05 0 0.0820392 -0.0146638 0 0.212548 6.39619e-05 0 + 0.0377004 -5.47583e-05 0 0.0985294 0.000631819 0 0.0479937 -0.0711013 0 0.097308 0.000367713 0 + 0.287371 0.0265027 0 0.209559 0.0370869 0 0.369868 0.0226855 0 0.0940884 -0.0023247 0 + 0.277717 -0.00231312 0 0.274459 -0.00225403 0 0.0317912 0.0104091 0 0.0438873 -4.90894e-05 0 + 0.275893 0.085574 0 0.273841 -0.00137338 0 0.297509 0.00251864 0 0.31949 -0.0318545 0 + 0.0191131 -9.72985e-06 0 0.00214908 0.00644228 0 0.0334997 0.00144189 0 0.253131 -0.061033 0 + 0.387545 -0.0396916 0 0.320271 0.0441885 0 0.276799 0.0004346 0 0.275888 0.00060829 0 + 0.198487 0.0350416 0 0.00475714 -0.00227678 0 0.0880657 -7.8524e-05 0 0.249463 0.017576 0 + 0.274167 -0.165265 0 -0.00265507 -0.00435206 0 0.219212 -0.0191 0 0.130277 0.0153707 0 + 0.0732535 0.00465157 0 0.252086 0.063893 0 0.26907 -0.115956 0 0.0343216 0.0634973 0 + 0.0385786 -0.00884328 0 0.271093 0.0241183 0 0.0501907 0.0103124 0 0.261033 -0.00106918 0 + 0.264476 -0.00105108 0 0.0323341 3.8486e-06 0 0.316302 -0.0328422 0 0.00320087 -0.000523346 0 + 0.255272 0.00405329 0 0.276288 -0.00218512 0 0.0388196 -4.77663e-05 0 0.279636 0.000301445 0 + 0.153792 0.115847 0 0.296649 0.190989 0 0.363523 0.00975659 0 0.327842 -0.126656 0 + 0.0435558 2.32973e-05 0 0.35911 0.0314759 0 -0.00336652 0.00817634 0 0.136348 0.01689 0 + 0.269849 0.0715215 0 0.166528 0.0523177 0 0.052479 -0.000241303 0 0.261503 -0.000324448 0 + -0.00458483 0.00873788 0 0.338834 0.0416153 0 0.252157 0.00679231 0 0.0793549 0.00167686 0 + 0.342975 0.0638385 0 0.0707756 -0.000181954 0 0.252376 0.00358028 0 0.110563 0.037184 0 + 0.265443 -0.00391176 0 0.392412 -0.0726679 0 0.322167 -0.0330355 0 0.180527 0.0203516 0 + 0.368626 0.00820209 0 0.0691971 -6.78611e-05 0 0.0465358 0.0107753 0 0.334624 -0.0311704 0 + 0.2627 -0.00155914 0 0.28356 0.0480416 0 0.277512 0.0657597 0 0.250721 -0.19649 0 + 0.223913 -0.0145085 0 0.0924054 0.000339481 0 0.117179 -0.141323 0 0.271946 0.085715 0 + 0.0406092 0.00885462 0 0.248833 0.0469651 0 0.316783 0.0468044 0 0.0185404 0.0176803 0 + 0.0359016 3.26873e-05 0 0.0425652 -3.00152e-05 0 0.332306 -0.00459737 0 0.380846 0.0728649 0 + 0.049139 0.018488 0 0.203955 -0.0285325 0 0.268294 0.108872 0 0.159561 -0.0245024 0 + 0.088767 -0.0372484 0 0.112992 -0.0168674 0 0.231505 -0.191096 0 0.246731 -0.000177603 0 + 0.382199 0.0878371 0 0.276036 0.000633277 0 0.259889 -0.00396159 0 0.342865 0.00707453 0 + 0.341528 -0.128824 0 0.274867 0.000783215 0 0.12722 -0.0307945 0 0.119113 0.0397586 0 + -0.00166515 0.00458867 0 0.130257 0.00876196 0 0.221304 -0.0225096 0 0.0342242 0.0145742 0 + 0.0410241 -3.99139e-05 0 0.146191 0.0628404 0 0.0826346 -0.00286585 0 -0.000492491 -0.00182302 0 + 0.167868 0.0696455 0 0.0199434 -0.00730949 0 0.294359 0.0274209 0 0.0416336 2.01721e-05 0 + 0.203284 -0.0174572 0 0.384134 0.0787319 0 0.116474 -0.00594081 0 -0.00159799 -0.00341554 0 + 0.0352986 2.12051e-05 0 0.218993 3.73137e-05 0 0.27075 -0.00269114 0 0.0564824 0.00236829 0 + 0.015455 0.0412129 0 0.0125312 0.01048 0 0.259557 -0.000354803 0 0.17422 0.00831239 0 + 0.125304 0.000659846 0 0.152889 0.0262853 0 0.120471 0.00141203 0 0.252012 -0.00270557 0 + 0.0390822 0.0758958 0 0.037566 -0.0107562 0 0.167721 0.00919889 0 0.0457518 -3.10784e-05 0 + 0.124658 -0.0546992 0 0.28981 -0.000520943 0 0.0625655 0.0133812 0 0.141459 0.00194763 0 + 0.0158458 0.00610002 0 -0.00304984 0.00718176 0 0.255428 -0.000298699 0 0.171386 -0.0125417 0 + 0.315952 0.000433593 0 0.0299211 -7.23562e-07 0 0.264603 -0.0402355 0 0.37671 -0.1279 0 + 0.334635 -0.0715255 0 0.206854 -0.0407894 0 0.348325 0.154226 0 0.0858223 0.000581818 0 + 0.321594 0.0317022 0 0.221411 -0.0789761 0 0.280282 0.000213087 0 0.274666 -0.00227619 0 + 0.287309 -0.000510179 0 0.279301 0.000351787 0 0.0474342 0.0130105 0 0.0703741 -0.000143306 0 + 0.288249 -0.000482016 0 0.270404 -0.00265683 0 0.393064 -0.0571738 0 0.251321 -0.0435751 0 + 0.354333 0.146008 0 0.144723 0.0257267 0 0.340656 -0.128766 0 0.129208 0.00076933 0 + 0.0159831 -0.00539941 0 0.25095 -0.00385954 0 0.000910772 0.00454363 0 0.308636 0.0366153 0 + 0.249085 -0.0683049 0 0.170274 0.0191204 0 0.0904546 -4.24786e-05 0 0.266243 0.0314379 0 + 0.0363893 2.8886e-05 0 0.288544 -0.0241596 0 0.0360124 -4.59934e-06 0 0.33477 -0.0373234 0 + 0.347901 0.15939 0 0.176234 0.00524705 0 0.0304546 -2.17801e-05 0 0.258125 -0.00346232 0 + 0.229497 0.0307249 0 0.15614 0.00304414 0 0.361681 -0.0271107 0 0.355611 -0.114919 0 + 0.0664787 -6.74729e-05 0 0.0931379 0.000231469 0 0.0681203 -0.000113505 0 0.255804 -0.062472 0 + 0.252127 -0.000163777 0 0.241229 0.200895 0 0.261348 0.0173547 0 0.0758546 -2.95091e-05 0 + 0.265279 -0.0394053 0 0.0342205 1.28044e-05 0 0.0569006 6.86841e-05 0 0.0340066 7.83496e-06 0 + 0.356695 -0.021034 0 0.280332 -0.000524048 0 0.0165686 -0.00850782 0 0.0624912 -0.012109 0 + 0.256309 -0.00206902 0 0.0204317 -1.36187e-05 0 0.0784353 -0.00189005 0 0.146952 0.103615 0 + 0.109714 0.00927966 0 0.195948 -0.172636 0 0.269546 -0.00332072 0 0.00859419 0.0031426 0 + 0.250106 0.0637845 0 0.0255557 -0.00599517 0 0.133219 0.0151851 0 -0.00526169 0.0083587 0 + 0.252476 -0.00405031 0 -0.00955638 0.002712 0 0.172373 -0.0698511 0 0.275712 0.199435 0 + 0.120791 -0.0232217 0 0.376781 -0.0974696 0 0.254478 -0.00201731 0 0.0340919 3.09947e-06 0 + 0.19867 0.0193309 0 0.0653699 7.40106e-05 0 0.264023 0.0423923 0 0.264709 -0.000764288 0 + 0.163197 0.0357344 0 0.123469 0.000181328 0 0.227281 0.0510473 0 0.269606 -0.00106984 0 + 0.169009 -0.00959152 0 0.183823 0.000275099 0 0.27103 0.0243153 0 0.1079 -0.00441825 0 + 0.210253 0.179282 0 0.32931 0.167652 0 0.255611 0.00298267 0 0.0596852 -0.000476272 0 + 0.266521 -0.00155525 0 0.269228 -0.0618059 0 0.0903479 -0.0128687 0 0.281599 -0.0146135 0 + 0.00306277 -0.00149111 0 0.131073 -0.0173902 0 0.263632 -0.0864545 0 0.267161 -0.00103681 0 + 0.381076 -0.0789008 0 0.0783304 0.000234214 0 0.322728 -0.00923908 0 0.0615237 -0.00280972 0 + 0.240702 0.0845652 0 0.10283 0.113556 0 0.256201 -0.0796488 0 0.296426 -0.0239586 0 + 0.110482 0.00308798 0 0.0658721 9.1372e-05 0 0.379802 -0.125648 0 0.262301 -0.00372654 0 + 0.324915 0.0431611 0 0.30748 0.0370285 0 0.366357 0.0606866 0 0.0948608 0.0965079 0 + 0.261795 0.0163529 0 0.0110123 -0.0017261 0 0.16353 0.00718439 0 0.00585303 0.00823485 0 + 0.331308 0.17874 0 0.190501 0.0181506 0 0.0258505 0.01334 0 0.112813 0.029231 0 + 0.28024 6.29943e-05 0 0.0480856 0.000223828 0 0.142204 -0.0325528 0 0.0756658 0.00021297 0 + 0.0357517 -0.0104562 0 0.312285 -0.16435 0 0.276461 -0.00179179 0 0.160075 0.00729057 0 + 0.00254924 0.00181034 0 0.223577 -0.0540465 0 0.245234 -0.00271297 0 0.0177134 0.0120795 0 + 0.261357 -0.0268594 0 0.247468 0.0587589 0 0.339175 -0.0292596 0 0.146301 -0.029107 0 + 0.0538 0.00091628 0 0.138226 -0.0140524 0 0.028008 0.00348237 0 0.0890632 0.107469 0 + 0.276135 -0.00180485 0 0.073965 0.0585927 0 0.00642307 -0.00255377 0 0.103399 0.0185472 0 + 0.0124134 -0.0348744 0 0.188176 0.0217671 0 0.000506808 -0.00729454 0 0.26757 -0.00267985 0 + -0.00551608 0.00790406 0 0.141526 0.143655 0 0.0735664 -0.0388062 0 0.290329 0.158416 0 + 0.185784 -0.149325 0 0.0350335 -1.34424e-05 0 0.201958 -0.0541652 0 0.177356 0.0404233 0 + 0.371018 0.021785 0 0.204807 0.0405402 0 0.348421 -0.0666502 0 0.0249871 -0.00838472 0 + 0.0541338 6.14324e-05 0 0.163124 -0.0243733 0 0.0815307 0.000133068 0 0.295464 0.0194966 0 + 0.0694309 -0.000126702 0 0.272517 -0.00231316 0 0.23631 0.017946 0 0.261142 0.00283812 0 + 0.265557 0.0772649 0 0.263127 -0.00376229 0 0.0886806 0.000214893 0 0.264269 0.0761995 0 + 0.281734 -0.125712 0 0.053653 -0.000215395 0 0.350635 0.0651597 0 0.296777 -0.0219863 0 + 0.0726573 -0.0119113 0 0.249992 0.123434 0 0.0426603 0.00650161 0 0.25288 0.0149434 0 + 0.267256 -0.00264908 0 0.368722 0.0241498 0 0.330308 -0.0346858 0 0.0635926 1.79558e-05 0 + 0.273504 -0.00265403 0 0.156595 -0.0483791 0 0.185877 0.00505942 0 0.0219085 -0.0062409 0 + 0.298982 0.00134392 0 0.0485496 -0.007619 0 0.126024 0.149117 0 0.304426 0.190122 0 + 0.260002 -0.0830439 0 0.259841 0.0176503 0 0.103598 -0.00320318 0 0.286851 -0.000620273 0 + 0.286916 -0.000533092 0 0.0797935 -0.014617 0 0.035692 -3.13803e-05 0 -0.00342736 0.00816278 0 + 0.374203 0.0924514 0 0.180325 0.034126 0 0.2945 -0.117255 0 0.286575 -0.00119202 0 + 0.287293 -0.00109787 0 0.287235 -0.00106434 0 0.281745 0.0175932 0 0.161462 0.00858143 0 + 0.260525 0.00418143 0 0.256665 -0.00201167 0 0.140479 -0.00950617 0 0.0436185 6.48285e-05 0 + 0.108826 0.000678048 0 0.00458319 -0.0152627 0 0.309942 0.0449543 0 0.0792031 0.000171843 0 + 0.287453 -0.00106793 0 0.0631616 0.000105403 0 0.240886 0.0339266 0 0.310153 -0.00664289 0 + 0.208235 0.0386854 0 0.0376122 4.89809e-05 0 0.276269 -0.0133108 0 0.0344678 -9.12073e-06 0 + 0.29251 -0.000288606 0 0.124144 0.0232751 0 0.198773 0.0184225 0 0.281303 -0.0902532 0 + 0.266379 0.047772 0 0.27892 0.000262207 0 0.359248 -0.0247915 0 0.260756 -0.00205251 0 + 0.0760201 0.00117993 0 0.283281 0.0297538 0 0.319835 -0.00761394 0 0.18168 0.0084909 0 + 0.203707 0.0288309 0 0.248994 0.0134508 0 0.277439 0.200408 0 0.256719 0.0025546 0 + 0.223167 -0.0414697 0 0.383516 0.129748 0 0.029488 -0.00920633 0 0.393501 -0.0616461 0 + 0.269221 -0.000429391 0 0.109325 0.00273955 0 0.268031 -0.000416544 0 0.283543 -0.000515823 0 + 0.29793 0.00265965 0 0.348072 -0.0378672 0 0.26452 -0.00412792 0 0.239192 0.016987 0 + 0.197652 0.00691734 0 0.0112005 -0.00393617 0 0.279681 -0.0152659 0 0.319379 -0.0313204 0 + 0.204048 -0.0397785 0 0.378609 -0.00106002 0 0.116153 -0.0164105 0 0.246585 -0.00607572 0 + 0.29587 -0.000363375 0 0.389161 -0.0742396 0 0.175847 0.0371478 0 0.277567 -0.000141498 0 + 0.319888 -0.0693841 0 0.286842 0.0257234 0 0.0419202 -2.70439e-05 0 0.296406 -0.000277783 0 + 0.279059 0.000440204 0 -0.00310566 0.00725775 0 0.270816 -0.0255 0 0.277317 0.000525669 0 + 0.272484 0.0308712 0 0.295646 -0.000366544 0 0.266168 -0.00102183 0 0.0946472 -0.000298764 0 + 0.275714 -0.000737911 0 0.0306171 -0.012082 0 0.0362904 -0.0140783 0 0.220536 -0.0161549 0 + 0.29636 -0.000284136 0 0.0197356 9.11382e-06 0 0.0197811 8.34325e-06 0 0.278345 -0.00214515 0 + 0.265647 -0.148312 0 0.0116788 -0.00707605 0 0.325616 -0.0119278 0 0.0884332 -9.8819e-05 0 + 0.134446 -0.00700875 0 0.0607007 8.28735e-05 0 0.00928807 0.00245273 0 0.272639 -0.000991671 0 + 0.0950531 0.000234825 0 0.0129181 0.00290771 0 0.00867737 -0.00443454 0 0.175527 -0.147045 0 + -0.00965279 0.00366415 0 0.245781 0.152267 0 0.0667277 0.000128029 0 -0.0120332 -0.000650984 0 + 0.044467 0.0107879 0 0.247411 -0.0357115 0 0.0693834 0.000185741 0 0.0285928 0.0107878 0 + 0.109383 -0.0056197 0 0.25977 -0.0513431 0 0.086602 -0.0153321 0 0.27064 -0.0554431 0 + 0.26924 0.0341047 0 0.00543473 -0.00140421 0 0.189669 0.0417034 0 0.29639 -0.000211684 0 + 0.118461 0.0285331 0 0.348132 0.167028 0 0.248185 -0.043487 0 0.0347107 1.38405e-05 0 + 0.142346 0.00409003 0 0.0365006 -4.295e-05 0 0.310015 0.124886 0 0.297167 -0.000227466 0 + 0.190015 0.177488 0 0.0350529 -0.00372448 0 0.155289 -0.035546 0 -0.011281 -0.000420078 0 + 0.0584508 0.000103353 0 0.255678 0.00326249 0 0.321665 -0.0336186 0 0.0757908 -0.115711 0 + 0.0583334 2.53405e-05 0 0.00762511 -0.0218394 0 0.273532 0.0284359 0 0.280253 -0.00132634 0 + 0.23021 0.199736 0 0.0549527 -4.06006e-05 0 0.203062 -0.000217608 0 0.279513 -0.000519559 0 + 0.345158 0.0399746 0 0.30422 0.187277 0 0.154143 0.0319286 0 0.265479 -0.00153214 0 + 0.241713 -0.0634345 0 0.159461 0.0082589 0 0.0801065 -0.000227406 0 0.0426677 1.06864e-05 0 + 0.366965 -0.0866065 0 0.265172 -0.134091 0 0.0785573 -0.00183195 0 0.149902 0.00162464 0 + 0.193544 -0.0554445 0 0.0459321 -8.17341e-05 0 0.0607926 -0.00274697 0 0.0589446 0.000122946 0 + -0.00249164 -0.00610386 0 0.236544 0.0330817 0 0.124557 -0.0142335 0 0.30509 -0.149409 0 + 0.252297 0.0346741 0 0.310622 0.0329059 0 0.0455983 -0.0685408 0 0.130197 0.16055 0 + 0.205753 -0.0191766 0 0.24111 -0.0640843 0 0.27647 -0.146138 0 0.186044 0.0315501 0 + 0.324703 -0.0400532 0 0.0716257 -0.000489518 0 0.238668 -0.000194401 0 0.138671 0.017549 0 + 0.243041 0.0793926 0 0.20408 -0.0594017 0 0.0666682 0.000152099 0 -0.00434242 0.0070313 0 + 0.084881 -0.0110074 0 0.268218 0.114996 0 0.174148 0.0109209 0 0.179863 0.0261359 0 + 0.266491 -0.00419824 0 0.387105 -0.0698937 0 0.236701 -0.00016975 0 -0.00168403 -0.00400585 0 + 0.0760425 0.00477565 0 0.167464 -0.0242364 0 0.00950511 0.00411785 0 0.301973 0.0350627 0 + 0.0483569 8.43321e-05 0 0.0729541 -0.000269225 0 0.346433 -0.0382523 0 0.330117 -0.0330586 0 + 0.263781 0.0110973 0 0.00256055 0.00443147 0 0.133016 -0.0282261 0 0.00903232 0.00438165 0 + 0.242462 -0.00380309 0 0.32296 0.0462364 0 0.104775 0.000802698 0 0.0937935 0.0285535 0 + 0.317971 -0.0141301 0 0.181429 -0.0327341 0 0.211689 0.0301012 0 0.291874 0.196777 0 + 0.2487 -0.0085523 0 0.345223 0.088405 0 0.323609 -0.0365001 0 0.336323 0.0896199 0 + 0.0667552 -0.0013448 0 -0.00697266 0.0069566 0 -0.000290422 0.00476399 0 0.124237 0.000647671 0 + 0.0400059 -0.00263649 0 -0.00238385 0.00890412 0 0.297588 -0.0670593 0 0.377007 -0.083458 0 + 0.289492 0.0341101 0 0.263589 0.017816 0 0.229045 -0.0160788 0 0.204141 0.0308028 0 + -0.00155742 0.00436666 0 0.316092 -0.0640647 0 0.268304 -0.00259996 0 0.132565 0.00372829 0 + 0.0134648 0.00581527 0 0.265501 0.0226905 0 0.212175 0.0279735 0 0.380919 0.0923097 0 + 0.127429 -0.00863316 0 0.197097 -0.0110957 0 0.29961 0.112039 0 0.0327925 0.0325325 0 + 0.351872 -0.133733 0 0.178017 0.132294 0 0.18074 0.0336119 0 0.32569 -0.126971 0 + 0.0962412 -0.0160132 0 0.25576 -0.0777722 0 0.28296 -0.0144361 0 0.397064 0.0626263 0 + 0.10527 -0.00451661 0 0.0187798 0.0117749 0 0.0716121 0.00815773 0 0.368932 -0.0145416 0 + 0.291836 0.00947054 0 0.338332 0.157669 0 0.21881 -0.0930866 0 0.188857 0.0116271 0 + 0.360455 -0.0567682 0 0.373098 -0.112733 0 0.327278 -0.0276144 0 0.317279 0.0116313 0 + 0.32591 0.132265 0 0.281225 0.000229282 0 0.0509386 -8.03518e-05 0 -0.002742 -0.00664831 0 + 0.0551546 -0.0127205 0 0.279085 0.000272387 0 0.102887 -0.125083 0 0.0228828 0.0541741 0 + 0.287641 -0.00050379 0 0.0720767 0.00019514 0 0.167784 -0.0269168 0 0.0884904 0.000289542 0 + -0.00468773 -0.00132471 0 0.271927 -0.00181928 0 0.283522 0.000100022 0 0.276139 -0.0128431 0 + 0.0372586 -0.0105012 0 0.254619 0.0179399 0 0.0351564 1.22844e-05 0 0.103248 -0.0140725 0 + 0.0799333 0.00376417 0 0.176582 0.0327762 0 0.148125 -0.0339693 0 0.207257 0.0194901 0 + 0.362999 -0.0240101 0 0.321418 -0.12879 0 0.0235168 0.00247752 0 0.363096 0.125904 0 + 0.279579 0.000227282 0 0.0331197 -0.00505606 0 0.378886 -0.00248266 0 0.0894658 -0.00500373 0 + 0.276299 0.027964 0 0.294079 -0.000432754 0 0.0211472 -0.00644957 0 0.182381 0.0168642 0 + -0.0142527 0.000863478 0 0.109227 -0.00255799 0 0.230246 -0.0240307 0 0.258806 0.00219262 0 + 0.144325 0.0160195 0 0.208038 0.0351844 0 0.049458 -9.48271e-05 0 0.278326 -0.0107954 0 + 0.254009 -0.0902428 0 0.00163266 -4.87072e-05 0 0.07488 -0.11701 0 0.272815 0.0779287 0 + 0.366541 0.129811 0 0.0503495 -0.000946213 0 0.280674 -0.0163581 0 0.0535126 -0.000805444 0 + 0.302189 -0.156071 0 0.274681 -0.00182601 0 0.0539965 -8.60751e-05 0 0.0677234 9.3918e-05 0 + 0.268971 -0.0015245 0 0.00623295 -0.00533488 0 0.251175 -0.00233491 0 0.229287 0.0593352 0 + 0.305166 0.012615 0 0.267991 -0.0406022 0 0.220249 -0.0103657 0 0.149999 -0.0078326 0 + 0.269148 0.000925174 0 0.24576 0.0332184 0 0.270681 0.0350029 0 0.396162 0.0667804 0 + 0.276455 -0.0141364 0 0.0642936 -0.011362 0 0.0864849 0.00177033 0 0.105557 -0.0164715 0 + 0.247291 -0.00867774 0 0.0424435 0.0166422 0 0.146599 0.000591821 0 0.316683 -0.035317 0 + 0.0368279 0.011351 0 0.122678 0.0309613 0 0.272327 0.038172 0 0.269622 0.000787376 0 + 0.0516182 -0.0109881 0 0.159702 0.0127352 0 0.274005 0.0294058 0 0.270454 -0.0280398 0 + 0.0405986 4.1189e-05 0 0.0102544 -0.00453489 0 0.185998 -0.00377277 0 0.376776 -0.117652 0 + 0.32262 0.013843 0 0.309611 0.185468 0 0.158265 -0.0189999 0 0.0122222 0.0052296 0 + 0.363876 -0.0441971 0 0.225477 -0.0447059 0 0.287807 -0.000962843 0 0.361522 0.0112023 0 + 0.0712234 0.00176977 0 0.0866292 -0.000376841 0 0.0432991 -0.00591043 0 0.358159 -0.0789831 0 + 0.165446 -0.0135895 0 0.0503812 0.0912896 0 0.0189571 0.00741827 0 0.0704356 0.00265706 0 + 0.185303 0.0358004 0 0.261602 0.00264528 0 -0.00311124 -0.00403435 0 -0.00248915 -0.00637684 0 + 0.256385 -0.0646523 0 0.337655 0.0382793 0 0.0887752 0.0173065 0 0.31336 -0.130572 0 + 0.174055 0.00834185 0 0.0169085 4.91551e-06 0 0.0108302 -1.10465e-05 0 0.380628 0.13024 0 + 0.239099 -0.0120353 0 -0.00294747 -0.00613516 0 0.130053 -0.00640385 0 0.237669 -0.0273158 0 + 0.275739 -0.00052464 0 0.268894 0.0310603 0 0.269571 -0.0870677 0 -0.00338504 0.00909011 0 + 0.256599 0.0027911 0 0.218504 -0.026094 0 0.293871 -0.128365 0 0.218321 0.00344708 0 + 0.393435 -0.0486792 0 0.316384 0.039045 0 0.017153 1.03415e-06 0 0.0171528 3.32479e-06 0 + -0.0146394 0.00104883 0 0.3273 0.152529 0 0.0317212 -2.14627e-05 0 0.38836 -0.0437956 0 + 0.0346816 0.00593184 0 0.279552 0.000262664 0 0.270273 -0.144402 0 0.0789367 0.115233 0 + 0.299176 0.0380782 0 0.274161 0.000212238 0 -0.00321007 0.00757439 0 0.027334 0.0535397 0 + 0.181156 -0.000405493 0 0.172798 -0.0259966 0 0.0526956 0.0116214 0 0.163352 -0.0256855 0 + 0.0478736 0.000592405 0 0.0937083 0.0044375 0 0.216463 0.0207054 0 0.0719167 -0.000224218 0 + 0.273165 -0.00263011 0 0.147738 -0.0162662 0 0.322046 0.162895 0 -0.00179469 0.00825822 0 + 0.0629179 -0.00107247 0 -0.00316503 -0.00753499 0 0.251252 -0.0858194 0 0.176466 -0.00335917 0 + 0.288718 -0.154256 0 0.27494 -0.000142709 0 0.33305 -0.0585321 0 0.216174 0.0461132 0 + 0.293209 -0.182671 0 0.261407 0.00271869 0 0.0627665 -6.73032e-05 0 0.253811 -0.00910742 0 + 0.0871665 -0.0442357 0 0.00943561 -0.00112386 0 0.21007 -0.0223483 0 0.315037 -0.00357495 0 + 0.270533 0.0420286 0 0.0543154 0.00748895 0 0.196523 0.0344121 0 0.343972 0.098719 0 + 0.15576 -0.113348 0 0.352461 -0.028399 0 0.121626 -0.002146 0 0.0398349 2.5353e-05 0 + 0.278397 -0.00242357 0 0.014798 -0.00421542 0 0.23342 0.114481 0 0.0226552 0.00012423 0 + 0.106762 0.000744519 0 0.046684 0.0121449 0 0.0397943 -0.0785506 0 0.260956 -0.00101483 0 + 0.259086 0.0460488 0 0.27488 -0.0428776 0 0.257545 -0.0359699 0 0.0430871 0.0185915 0 + 0.342897 -0.111518 0 0.275499 0.118256 0 0.0463727 0.0193291 0 0.146999 -0.0335303 0 + 0.236894 -0.0571156 0 0.0518083 0.0183734 0 0.269723 -0.00357425 0 0.106142 -0.0162399 0 + -0.0145497 0.000465432 0 0.376508 0.0149398 0 0.288406 0.0155952 0 0.325979 0.162044 0 + 0.209167 0.000172898 0 0.316765 0.0403841 0 0.330231 -0.0308188 0 0.0179764 0.0410818 0 + 0.2853 1.94467e-05 0 0.391758 -0.0359888 0 0.312772 0.0141477 0 0.192435 -0.143446 0 + 0.0727731 0.00166907 0 0.17932 0.162614 0 0.0650293 1.93664e-05 0 0.101734 -0.0061811 0 + 0.297952 -0.0059759 0 0.265478 0.0561813 0 0.258228 -0.00871973 0 0.28541 -0.000265509 0 + 0.295796 -0.00252738 0 -0.00190555 0.00426155 0 0.38392 -0.084826 0 0.000663852 0.00700356 0 + 0.0347978 -0.00339637 0 0.0770824 0.121027 0 -0.00178288 -0.00373927 0 0.286076 1.76211e-05 0 + 0.0760619 0.0135162 0 0.0378073 0.00443577 0 0.291222 0.00101789 0 0.0402573 5.82394e-05 0 + 0.284 8.41538e-05 0 0.00868583 0.00415139 0 0.215787 -0.0244459 0 0.231116 0.0474789 0 + 0.369283 0.0212962 0 0.0606404 0.0203332 0 0.392881 -0.0509149 0 0.286089 -0.0465338 0 + 0.265548 -0.00145476 0 0.186866 -0.000175165 0 0.289261 -0.000934731 0 -0.00240596 0.0018177 0 + 0.322698 -0.0326576 0 0.298026 0.152104 0 0.221741 0.0369121 0 0.282561 -0.00127318 0 + 0.0967472 -0.0159679 0 0.0157106 0.00614027 0 0.25552 -0.0812812 0 0.28478 -0.0013365 0 + 0.0184764 -3.28456e-06 0 0.00498181 0.00141125 0 0.267552 0.0229566 0 0.264114 -0.00199938 0 + 0.206573 -0.0379917 0 0.301579 -0.0257153 0 0.0933352 -0.00274003 0 0.257032 0.00983161 0 + 0.297849 0.0207487 0 0.0789235 -0.0143676 0 0.260198 -0.0254154 0 0.0243251 -0.050903 0 + 0.0628608 -0.010782 0 0.135939 0.148296 0 -0.00378547 0.00627735 0 0.271523 -0.00217822 0 + 0.272247 0.0894493 0 0.247952 0.0790261 0 0.118523 0.000598825 0 0.127822 -0.000736651 0 + 0.353819 0.151808 0 0.109502 -0.0167439 0 -0.00485696 0.000156033 0 0.385802 0.0302562 0 + 0.0590689 -6.47014e-05 0 0.0690874 -0.0778423 0 0.270925 -0.0120801 0 0.193113 -0.0108889 0 + 0.183126 0.0612179 0 0.0472975 -8.09889e-05 0 0.124889 0.0242053 0 0.164392 0.014506 0 + 0.357269 0.0148187 0 0.139436 0.01629 0 0.018866 1.61572e-06 0 0.256504 -0.0782874 0 + 0.202718 -0.0207983 0 0.128188 -0.0166506 0 0.117825 -2.47383e-05 0 0.137983 -0.0160292 0 + 0.262591 -0.00196334 0 0.354923 0.019058 0 0.237257 0.051554 0 0.245782 0.0592 0 + 0.371802 -0.0602615 0 0.0587838 -0.0198481 0 0.287001 0.198923 0 0.285439 -0.0354191 0 + 0.023151 -0.00283037 0 0.335149 -0.0362647 0 0.0249005 -0.0127122 0 0.00367501 -0.00471943 0 + -0.00256811 -0.00603757 0 0.226378 -0.0567981 0 0.245172 0.115584 0 0.202484 0.0200855 0 + 0.0735512 -0.00164345 0 0.280431 0.000191533 0 0.0428223 1.69937e-05 0 0.196282 0.0350927 0 + 0.0690236 0.000172365 0 0.365214 -0.00939439 0 0.27634 0.0951526 0 0.138977 -0.00232995 0 + 0.0650729 -0.000162985 0 0.313718 0.16556 0 0.382014 -0.119586 0 0.0312849 3.59918e-05 0 + 0.31789 -0.116454 0 0.313224 -0.0347376 0 0.151279 -0.0837077 0 0.268243 0.0180454 0 + 0.202701 -0.0404616 0 0.0979489 -0.000364166 0 -0.0105807 -0.00109053 0 0.223835 -0.0542031 0 + 0.130942 0.0246942 0 0.180027 -0.000169366 0 0.267593 -0.00344791 0 0.0123887 0.000809926 0 + 0.25992 0.0103597 0 0.00132763 0.00466232 0 0.0795876 0.000245332 0 0.0971953 -0.0063917 0 + 0.0656378 -0.0133095 0 0.000257338 0.000422869 0 0.293945 -0.000275854 0 0.233897 -0.00393336 0 + 0.255825 0.062592 0 0.14772 0.0011951 0 0.200964 -0.0379192 0 0.268887 -0.000768577 0 + 0.34023 -0.0398625 0 0.282391 -0.00350695 0 0.257285 -0.0624641 0 0.268962 0.00582441 0 + -0.0049753 0.00697163 0 0.239334 0.00845331 0 0.260359 0.0475532 0 0.243279 -0.00351772 0 + 0.240073 -0.0170864 0 0.225752 -0.0109142 0 0.28981 -0.0126397 0 0.242251 0.0172296 0 + 0.234411 -0.0322575 0 0.0785395 -0.0258045 0 0.240334 0.148661 0 0.0943671 -0.000355396 0 + 0.346538 0.0170158 0 0.0904402 0.0175263 0 0.109224 -3.02703e-05 0 0.361584 0.0264154 0 + 0.268064 0.0015721 0 0.24111 0.00683934 0 0.212027 0.0129553 0 0.140959 -0.0789702 0 + 0.368664 0.00877429 0 0.259193 -0.0567492 0 0.268664 0.00149066 0 -0.00323141 -0.00179559 0 + 0.000694796 -0.000448791 0 0.288274 -0.000517827 0 0.278839 -0.000734053 0 0.274387 -0.0849808 0 + -0.00480824 -0.00858079 0 0.0479842 -0.0641109 0 0.367194 -0.0175624 0 0.289392 0.0107239 0 + 0.186859 -0.033849 0 -0.00636314 0.00665085 0 0.261444 0.00211743 0 0.310887 -0.0284748 0 + 0.119204 0.000587054 0 0.244247 -0.00351292 0 0.268758 -0.0276318 0 0.215264 0.181427 0 + 0.368067 0.09854 0 0.0438036 -2.36738e-05 0 0.0012924 -0.00486564 0 0.261441 0.0477287 0 + 0.349464 -0.116318 0 0.0446992 7.88705e-05 0 0.212336 0.13134 0 -0.0040097 0.0089149 0 + 0.153858 -0.0213187 0 0.0466591 0.000467285 0 0.264732 0.0677296 0 0.37495 -0.091687 0 + 0.228359 -0.0682727 0 0.010633 -1.29945e-06 0 0.2785 0.0946411 0 0.269189 -0.00220636 0 + 0.134889 -0.155593 0 0.06117 -0.000102879 0 0.112037 -0.000444892 0 0.150462 0.00320466 0 + 0.0841059 0.0147711 0 0.0738655 0.00403298 0 0.263217 0.102491 0 0.235718 0.0776853 0 + 0.0410758 0.000633083 0 0.0576114 -0.0108072 0 0.247394 -0.037547 0 0.284397 -0.000518664 0 + 0.261344 -0.0222678 0 0.307474 0.045597 0 0.0681634 0.0140221 0 0.298323 -0.194217 0 + 0.216641 0.0451986 0 -0.0109588 0.0036531 0 0.347428 0.00405206 0 0.316412 0.102377 0 + 0.0471059 -0.00349115 0 0.369718 0.145935 0 0.0852311 0.0978207 0 0.256364 -0.00182158 0 + 0.0638125 0.0592966 0 0.296016 -0.0442548 0 0.0338813 0.00909134 0 0.158677 -0.0278644 0 + 0.267015 0.0141395 0 0.259129 -0.0298183 0 0.27671 -0.0132581 0 0.0208665 0.0109848 0 + 0.139834 -4.94365e-05 0 0.155504 0.163654 0 -0.0121604 0.00299868 0 0.105684 -0.0032408 0 + 0.0533004 0.0138492 0 0.273415 -0.0182677 0 -0.00500443 0.0068817 0 0.369258 0.0251482 0 + 0.0290617 -0.00925049 0 0.260189 -0.00185001 0 -0.00622608 0.000267768 0 0.0961251 -0.0023973 0 + 0.0120769 -0.00021762 0 0.241152 -0.0608621 0 0.333693 -0.0180167 0 0.0666717 -0.0140625 0 + 0.161025 0.0331353 0 0.284662 6.21341e-05 0 0.233241 0.053168 0 0.223158 0.0497479 0 + 0.157885 -0.0124487 0 0.10038 -0.0161458 0 0.158769 -0.0878654 0 0.295902 0.196957 0 + 0.0770402 -0.0133287 0 0.117462 -0.0705404 0 0.0382253 0.00367684 0 0.242986 -0.0266993 0 + 0.30318 -0.00147589 0 -0.00319021 -0.00797989 0 0.311603 -0.115144 0 0.0219647 -0.000123286 0 + 0.2525 -0.00204902 0 0.263683 -0.150926 0 0.258627 0.00245793 0 -0.00916002 0.00231828 0 + 0.108983 -0.148003 0 0.284689 0.0919756 0 0.285538 0.197412 0 0.243746 0.0132332 0 + 0.349111 0.142361 0 0.0333498 -0.0705161 0 0.336467 0.107675 0 0.265143 -0.0838177 0 + 0.287171 -0.000861111 0 0.057422 -1.58981e-05 0 0.0713555 0.024177 0 0.0201066 -0.00666144 0 + 0.296884 0.0559277 0 0.345167 -0.0385409 0 0.00529392 -0.000644701 0 0.23237 0.0655972 0 + 0.104226 -0.140131 0 0.0916623 0.130926 0 0.278421 -0.0195363 0 0.287235 0.00506256 0 + 0.274731 -0.000515394 0 0.280245 0.00022349 0 0.134258 -0.0529759 0 0.284538 -0.00121249 0 + 0.266526 -0.200113 0 0.22242 0.00120336 0 0.111408 0.000505839 0 0.282956 0.0623154 0 + 0.341713 -0.0114292 0 0.313602 -0.0323829 0 0.241654 0.199054 0 0.324052 -0.165504 0 + 0.00637382 0.00103069 0 0.336643 0.000770908 0 0.0810572 0.000180668 0 0.358505 0.0531881 0 + -0.00325513 -0.000287748 0 0.25734 -0.00384504 0 0.0936684 0.000775757 0 0.240894 -0.190492 0 + 0.290093 0.0108836 0 0.183511 0.0407622 0 9.2901e-05 -0.00396056 0 0.192077 0.0394662 0 + 0.305387 0.181214 0 0.378145 -0.099753 0 0.264836 0.0544485 0 0.27065 -0.0408408 0 + 0.144354 0.00662054 0 0.30476 0.0112066 0 0.205496 0.0980581 0 0.0627044 6.33259e-05 0 + 0.368331 -0.089513 0 0.274985 0.0877834 0 0.264222 -0.000998669 0 0.268047 -0.00150467 0 + 0.105347 -0.0303958 0 0.050718 -0.00704132 0 0.0906008 0.00535565 0 0.0772822 -0.0125077 0 + 0.361135 -0.11855 0 0.191876 0.000229813 0 0.088133 -0.00929812 0 0.277956 -0.0132153 0 + -0.000977375 -0.0059785 0 -0.000996973 -0.00423953 0 0.00191722 4.01399e-05 0 0.0715297 -0.000198336 0 + 0.288341 -0.000604185 0 0.288421 -0.000513115 0 0.0439317 0.0848026 0 0.205618 -0.0129507 0 + 0.318334 -0.160012 0 0.046315 -8.48283e-05 0 0.00854855 0.00846019 0 0.223724 -0.0640597 0 + 0.0628099 -0.000157789 0 0.166623 0.0160648 0 0.00692776 0.00265251 0 0.150219 -0.0314496 0 + 0.262564 -0.00919127 0 0.211815 -0.168993 0 0.267967 -0.00142457 0 0.362426 0.0142797 0 + 0.309802 -0.188458 0 0.292249 -0.000838075 0 0.0940941 -2.22224e-05 0 0.0644608 0.0132636 0 + 0.0282536 -0.00207249 0 0.300807 -0.00838193 0 0.0900821 0.0024894 0 0.00229287 0.00613399 0 + 0.391065 0.0316318 0 0.258522 -0.0410388 0 0.277931 0.000529865 0 0.262041 0.00255406 0 + 0.323185 -0.0307734 0 0.337326 -0.0642011 0 0.303762 0.116539 0 0.311498 0.0453584 0 + 0.29844 -0.0177104 0 0.267526 -0.00356829 0 -0.00335367 -0.00861487 0 0.214062 -0.0313863 0 + 0.281091 0.000158917 0 0.157933 0.0224906 0 0.268599 0.0192012 0 0.333597 -0.0481773 0 + 0.00666804 -0.0219838 0 -0.00273872 0.00809248 0 0.268087 0.0146499 0 0.136902 -0.0356371 0 + 0.255347 0.0463643 0 0.0388198 0.00732078 0 0.395376 0.0405362 0 0.122535 -0.128992 0 + 0.275748 0.0292899 0 0.294979 0.0366917 0 0.36726 0.0129789 0 0.0563096 -6.43865e-05 0 + 0.00408359 -0.000225803 0 0.266348 0.10314 0 0.235944 0.0552579 0 0.0444358 0.0102522 0 + 0.21634 0.0452046 0 0.0952066 -0.0165802 0 0.281361 0.000110409 0 0.146844 -0.0118021 0 + 0.198158 -0.0126709 0 0.0933603 -0.0159599 0 0.0732793 -0.117449 0 0.255252 -0.00409067 0 + 0.00234645 0.00160886 0 0.00168646 -0.00653624 0 0.126536 -0.0491373 0 0.284947 0.0101131 0 + 0.0368892 -0.00693508 0 0.372919 -0.105748 0 0.179825 -0.156686 0 0.260709 -0.200755 0 + 0.085506 -1.26006e-05 0 0.269738 0.087751 0 0.347861 -0.155207 0 -0.000851348 -0.00168228 0 + -0.00362557 -0.00819158 0 0.351186 -0.0549487 0 0.158501 0.0216967 0 0.055935 -0.0112427 0 + 0.0859732 -0.123146 0 0.155254 -0.00299018 0 0.184985 0.0405759 0 0.267546 0.0251255 0 + 0.300712 0.183832 0 0.348083 0.0394054 0 0.282886 0.08765 0 0.0729978 -0.0161455 0 + 0.272365 0.0124146 0 0.218503 -0.0417194 0 -0.000675962 0.000266174 0 0.0343564 3.16605e-05 0 + 0.137746 3.25473e-05 0 0.107727 -0.0186192 0 -0.00842915 0.00201114 0 0.216446 0.0224305 0 + 0.0500519 0.0181592 0 0.263664 -0.0102658 0 0.271333 -0.00149161 0 -0.00280215 0.00132514 0 + 0.136861 -0.00336386 0 0.247114 -0.00432572 0 0.309732 -0.110479 0 0.260968 0.0284119 0 + 0.105114 -0.0389706 0 -0.0104255 0.00317394 0 0.228404 -0.00782145 0 0.290039 0.00326933 0 + 0.193775 0.0336323 0 0.118436 -0.0045979 0 0.147342 -0.0162615 0 0.279348 0.0307322 0 + 0.0573059 -6.03103e-05 0 -0.0110812 -0.00283832 0 0.289442 -0.000899141 0 0.134688 -0.00220505 0 + 0.0422595 -2.73731e-05 0 0.227516 -0.056609 0 0.270402 -0.00358505 0 0.216296 -0.0380692 0 + 0.370394 0.0308268 0 0.0290676 1.12771e-05 0 0.204015 0.0219028 0 0.125946 -0.0905773 0 + 0.281473 0.0237652 0 -0.00738863 0.00385441 0 0.0292969 0.0100817 0 0.074611 -0.119675 0 + 0.0893303 0.00396983 0 0.265097 0.00199426 0 0.127154 -0.0188287 0 0.0656581 0.0525317 0 + 0.0398641 5.36448e-05 0 0.296716 0.169725 0 0.201718 -0.0315306 0 0.207512 0.186873 0 + 0.0608287 -0.00875799 0 0.271348 -0.00141062 0 0.0529909 0.00798479 0 0.094683 0.00260744 0 + 0.359103 -0.0177823 0 0.168014 -0.0224679 0 0.0480592 0.000497543 0 0.24579 0.00551038 0 + 0.248123 -0.00431498 0 0.288562 -0.000754175 0 0.0676863 0.0127541 0 0.288637 -0.000485823 0 + 0.314658 -0.118177 0 0.302859 -0.121677 0 -0.000593465 -0.00194769 0 0.0425402 -0.000451702 0 + 0.209527 0.0428971 0 0.240885 -0.00489961 0 0.0199787 -2.31963e-06 0 0.0465338 -0.0542456 0 + 0.270468 -0.000511977 0 0.269337 -0.000501788 0 0.0367552 -3.70067e-05 0 0.0315982 -0.00814385 0 + 0.222541 0.0192601 0 0.394399 0.0471929 0 0.0157533 8.03023e-06 0 -0.00367528 -0.00678017 0 + 0.0350931 0.0186414 0 0.224544 0.00654969 0 0.0101462 0.0083777 0 0.16846 -0.0879465 0 + 0.150545 -0.0272457 0 0.243455 -0.0350962 0 -0.00743247 -0.00322726 0 0.21621 -0.0756485 0 + -0.0020694 -0.00536171 0 0.314927 -0.125572 0 0.0489252 7.08244e-05 0 0.271628 -0.000980588 0 + 0.0188375 0.00731812 0 -0.00139894 -0.00260577 0 0.278309 0.00374295 0 0.287367 9.70044e-06 0 + 0.273862 -0.00155634 0 0.322557 0.0280923 0 0.298141 -0.000578585 0 0.369652 -0.0709478 0 + 0.200582 0.0221445 0 0.278323 0.000489385 0 0.375326 0.0117824 0 0.104192 -0.0286376 0 + 0.262927 0.00244885 0 0.12839 -0.00298223 0 0.304769 -0.0135144 0 0.293441 -0.0246433 0 + 0.329644 0.0318022 0 0.342195 -0.12192 0 0.333021 0.110553 0 0.0096492 0.00399018 0 + 0.335185 0.039059 0 0.313242 0.0350098 0 0.318589 -0.0305407 0 0.25152 0.00529622 0 + 0.264845 -0.199503 0 0.247494 0.0597379 0 0.232617 -0.0545097 0 0.28636 -0.00629514 0 + 0.349984 0.0341018 0 0.0690699 0.000144222 0 0.0415015 -2.33876e-05 0 0.188847 0.0226579 0 + 0.0354068 -3.84038e-05 0 0.317755 -0.111195 0 0.253345 0.00553829 0 0.374942 0.126189 0 + 0.0546915 6.66853e-05 0 0.0387515 0.00844673 0 0.116183 -0.00397373 0 0.0697065 -0.00227337 0 + 0.26537 0.0730538 0 0.327386 -0.133827 0 0.343554 -0.154641 0 0.257834 -0.000162868 0 + 0.365226 -0.0913605 0 0.273512 0.00069625 0 0.00793491 -0.00817251 0 0.0965737 -0.000310795 0 + 0.312263 -0.161584 0 0.113666 -0.0185086 0 0.115235 -0.0303432 0 0.080873 -0.000305007 0 + 0.119777 -0.153183 0 0.267457 -0.110598 0 0.197591 -0.141649 0 0.200667 0.0437919 0 + 0.350363 0.0198339 0 0.359199 0.0320108 0 0.27827 0.027596 0 0.00239183 0.00119757 0 + 0.0382584 -2.08319e-05 0 0.142603 -0.0198394 0 0.345764 -0.00139301 0 0.0803732 -0.0653685 0 + 0.26341 0.0725049 0 0.0861523 -0.000677949 0 0.27199 -0.11883 0 0.331505 0.0302562 0 + 0.278365 -0.0137343 0 0.117218 0.000179184 0 0.0377505 -0.000171808 0 0.312391 0.111823 0 + 0.145697 -0.0105731 0 -0.00393914 -0.00447707 0 -0.00436655 0.0087526 0 0.0730403 0.045591 0 + 0.0759636 0.000213072 0 0.273133 0.000930056 0 0.252219 -0.00246378 0 0.262229 0.0963297 0 + 0.270563 -0.0113949 0 0.0879713 0.00683087 0 -0.00104723 0.00326331 0 0.261228 -0.0426422 0 + 0.383866 -0.117118 0 0.178087 0.0287701 0 0.0331609 -4.49306e-05 0 0.150297 -0.0037797 0 + 0.0140288 -0.00918982 0 0.273592 0.000862068 0 0.129324 0.030367 0 0.173895 -0.115195 0 + 0.221382 0.0132996 0 0.165454 0.0236192 0 0.214813 0.0124693 0 0.315397 0.0363616 0 + 0.0664052 -0.0202062 0 0.141028 -0.0746848 0 0.041227 0.00849142 0 -0.00113435 0.0032329 0 + 0.0305238 0.0658717 0 0.0999925 -0.0167436 0 0.24887 0.00701538 0 0.275129 0.043064 0 + 0.215715 0.0258694 0 0.0303236 0.000624244 0 0.251599 -0.00794212 0 0.0605537 -7.98184e-05 0 + 0.28096 0.0289598 0 0.0332664 -7.75567e-06 0 0.0351593 0.00553066 0 0.188103 0.0275224 0 + 0.180522 -0.0602074 0 0.280597 0.0228092 0 0.0790373 -0.000230904 0 -0.00578888 -0.00689065 0 + 0.139281 0.0882752 0 0.125808 0.046965 0 0.192088 0.0299614 0 0.310582 0.0343467 0 + 0.0139742 -0.0241531 0 0.264608 0.00148174 0 0.0599253 -0.00915914 0 0.00917311 -2.20958e-06 0 + 0.264581 -0.000494426 0 0.245667 0.00573219 0 0.338169 0.0315816 0 0.272682 0.00101475 0 + 0.328963 0.103758 0 0.0370108 -0.00535845 0 0.269063 -0.00461019 0 0.341207 0.00799919 0 + 0.118907 -0.0267877 0 0.23534 -0.117437 0 0.0789877 0.000303054 0 0.234271 -0.0135698 0 + 0.104377 0.0184762 0 0.172086 -0.011893 0 -0.00434734 -0.0039724 0 0.159654 -0.0206895 0 + 0.108311 0.00866252 0 0.0504733 0.00866781 0 -0.00517989 -0.00789818 0 0.282007 8.44199e-05 0 + 0.335827 0.0110677 0 0.0532367 0.00512497 0 0.385538 0.0786722 0 0.179047 0.16716 0 + 0.138718 -0.0141386 0 0.350911 0.169982 0 0.00223744 -0.000473512 0 0.234457 -0.0335805 0 + -0.00624587 -0.00744778 0 0.0553605 -0.0101602 0 0.250774 0.197322 0 0.10663 0.104078 0 + 0.282425 7.34709e-05 0 0.0912752 -0.000100858 0 0.25652 -0.0412878 0 0.0410112 0.0004087 0 + 0.247577 -0.00277816 0 -0.0104166 0.00340108 0 0.044577 -4.34289e-05 0 0.0695042 -0.0216778 0 + 0.0219375 0.0483518 0 0.01065 9.03889e-06 0 0.339645 0.164333 0 0.236344 -0.00841564 0 + 0.0214467 -0.000302075 0 0.271445 0.0192474 0 0.280998 0.000188864 0 0.0345044 0.00611908 0 + 0.0173792 0.0016491 0 0.0738322 -0.00126376 0 0.146542 -0.00415426 0 0.256624 -0.000457084 0 + 0.0692192 -0.0130872 0 0.209573 -0.0130419 0 0.333347 -0.0338394 0 0.0481648 0.0757271 0 + 0.275333 -0.0222486 0 0.0876955 -0.131896 0 0.253874 0.0191786 0 0.141872 0.0399263 0 + 0.0521992 -0.000196339 0 0.203218 -0.0109489 0 0.238398 -0.0587455 0 0.232548 -0.197458 0 + 0.277898 -0.000590282 0 0.285796 2.27961e-05 0 0.199457 -0.0142498 0 0.238136 -0.00412848 0 + 0.0643919 -0.0100525 0 0.274181 -0.0029258 0 0.0624784 -0.000151318 0 0.0281278 0.00603374 0 + 0.196561 -0.000207426 0 0.222769 -0.0207327 0 0.0232865 -0.021309 0 0.285291 -0.0059044 0 + 0.270966 -0.00977908 0 0.256933 -0.0581476 0 0.142578 0.0149074 0 0.286022 -0.00114148 0 + 0.266694 0.00131216 0 0.386973 0.0149614 0 0.209104 0.101899 0 0.102919 -0.000428931 0 + 0.154992 0.0148693 0 0.0833813 0.0674059 0 0.0125661 -0.00293478 0 0.276121 -0.0169436 0 + 0.0664468 -3.28365e-05 0 0.282619 -0.0151341 0 0.269101 -0.000999985 0 0.0731366 -0.00018916 0 + 0.385605 0.00277556 0 0.34165 -0.0348929 0 0.283697 0.0258639 0 0.255509 -0.0726526 0 + 0.117755 -0.0186594 0 0.215747 -0.0455198 0 0.212148 -0.0176331 0 0.257841 0.0141614 0 + 0.277557 -0.0297068 0 0.223544 -0.0458262 0 0.1693 0.0389264 0 0.0658581 0.000165111 0 + 0.146484 -0.0325798 0 0.261153 0.002309 0 0.248606 0.0421498 0 0.236737 -0.00480584 0 + 0.098715 -0.00508117 0 0.348281 -0.00925901 0 0.319928 -0.038364 0 0.339938 -0.0361052 0 + 0.0148002 -0.00850001 0 0.377207 -0.0827244 0 0.358658 0.0325018 0 0.00651547 -0.0032127 0 + 0.165431 -0.118537 0 0.280187 0.000154351 0 0.0469096 0.0825924 0 0.287445 -0.000468291 0 + 0.288059 -0.000660835 0 -0.0126816 -7.80115e-05 0 0.0423914 6.44647e-05 0 0.346665 -0.0503768 0 + 0.0958518 0.000798674 0 -0.00571843 -0.00793642 0 0.311935 -0.166535 0 0.325955 0.00021272 0 + 0.120701 -0.0629699 0 0.271341 -0.00915369 0 0.373838 0.0559439 0 0.358605 -0.128213 0 + 0.33813 0.00317733 0 0.294575 -0.187039 0 0.0721499 0.113243 0 0.328849 -0.0266833 0 + 0.215177 0.0374838 0 0.291444 -0.000654665 0 0.00458644 -0.00584536 0 -0.000343054 0.00214585 0 + 0.0105238 -0.0300006 0 0.331835 -0.034286 0 0.359694 -0.0299673 0 0.144691 -0.0147987 0 + 0.225158 0.0271589 0 0.329903 0.034679 0 0.273794 -0.0157695 0 0.234576 0.0114132 0 + 0.26855 -0.00160433 0 0.301523 -0.0261676 0 -0.00188335 -0.00513986 0 0.181596 -0.0265037 0 + 0.255505 -0.0782856 0 0.254716 -0.00208621 0 0.0589581 0.020479 0 0.178554 -0.00656174 0 + 0.151774 0.03379 0 0.28718 0.00248142 0 0.292969 -0.000458397 0 0.0330191 -0.0685582 0 + 0.0548595 0.095106 0 0.283428 -0.0170005 0 0.206298 -0.0353347 0 0.29541 0.110636 0 + 0.390593 -0.0396893 0 0.224976 0.00975091 0 0.130345 -0.107198 0 0.0199226 0.0112394 0 + 0.221987 0.197802 0 0.357354 0.000561779 0 0.160291 0.0380811 0 0.204123 -0.0114278 0 + 0.0515161 -0.0875547 0 -0.0120347 0.00307097 0 -0.00423967 -0.00785008 0 0.236794 -0.00218743 0 + 0.198169 -0.0111299 0 0.188589 -0.00359514 0 -0.00158752 -0.00280181 0 0.0555724 0.098755 0 + -0.00302605 0.00825557 0 0.341825 -0.0536582 0 0.17127 0.034419 0 0.287105 -0.00775953 0 + 0.240603 0.00857087 0 0.289521 0.0425207 0 0.288888 0.0398369 0 -0.00486499 -0.000681434 0 + 0.234556 -0.0562837 0 0.250796 -0.000439611 0 0.0493605 -9.16316e-05 0 0.0385708 -0.0315314 0 + 0.243753 -0.200798 0 0.134825 0.0126563 0 0.289359 0.0661743 0 -0.00112527 0.00785648 0 + 0.104307 -0.00247474 0 -0.00341765 0.00322784 0 0.0227487 0.000123752 0 0.272762 0.084098 0 + -0.00954065 0.00216035 0 0.331679 0.0315583 0 0.133446 0.137797 0 0.31891 0.0820916 0 + 0.255884 -0.0443051 0 0.290923 -8.87834e-05 0 0.0586112 -0.000153782 0 0.173325 -0.0183697 0 + 0.260364 0.0683374 0 0.270408 -0.0218399 0 0.0507845 0.00440969 0 0.228988 0.0263116 0 + 0.062166 0.000157392 0 0.0218349 0.00777549 0 0.352844 0.00480733 0 0.272191 -0.0140653 0 + 0.0326411 0.00303834 0 0.0824531 0.000729444 0 0.241219 -0.000386905 0 0.067416 0.0386404 0 + -0.0147657 0.00050103 0 0.343803 0.162271 0 0.170292 0.000894548 0 0.0777912 -0.120248 0 + 0.295045 -0.000431415 0 0.328134 -0.0333432 0 0.287636 -1.69323e-05 0 0.388176 -0.0341867 0 + 0.0829654 0.0126148 0 0.0473652 -0.000153844 0 0.254488 -0.0517753 0 0.0965993 -0.126893 0 + 0.362152 0.0286455 0 0.12134 -0.00465731 0 0.236982 0.19867 0 0.164022 0.0354967 0 + 0.0829299 -0.109742 0 0.0595731 0.000144302 0 0.173087 0.00972498 0 0.0441004 0.0023263 0 + 0.153368 0.15377 0 0.338675 -0.0345138 0 0.172018 -0.00042407 0 0.0850992 -0.00190956 0 + 0.0866204 0.128067 0 0.0197156 2.03137e-05 0 0.191029 0.14621 0 0.380778 -0.0956737 0 + 0.246696 -0.0573969 0 0.163792 0.165351 0 0.152874 -0.0549664 0 0.308674 -0.0124245 0 + 0.0287744 2.53404e-05 0 0.277075 0.000182932 0 0.274949 0.000198455 0 0.367115 0.00730372 0 + 0.00112535 -0.00416563 0 0.0875278 0.0134572 0 0.309746 0.0226076 0 0.251137 0.0160117 0 + 0.297598 0.00172636 0 0.088581 0.000152851 0 0.272733 -0.0136195 0 0.243009 -0.196986 0 + 0.369815 -0.0766318 0 0.220065 -0.0296191 0 -0.0107175 -0.00135274 0 0.064097 0.000438279 0 + 0.141012 -0.0101501 0 0.0598666 -8.24609e-05 0 0.017601 -0.0356542 0 0.267923 -0.00339826 0 + 0.0574195 -0.0563079 0 0.329166 -0.0237494 0 0.0497324 -7.30433e-05 0 0.253163 -0.00090996 0 + 0.374856 -0.00099527 0 0.214767 0.0105896 0 0.0296859 -1.14039e-05 0 0.372047 0.129797 0 + 0.0270873 -0.0359571 0 0.113478 -0.142176 0 -0.00361652 0.00873254 0 0.0132684 0.0104384 0 + 0.119048 0.00270487 0 0.220175 0.0373306 0 0.0829551 -0.00473618 0 0.373826 0.052155 0 + 0.119031 0.0266134 0 0.244308 0.0130199 0 0.216713 0.187266 0 0.247149 0.0415945 0 + 0.154824 0.146997 0 0.294725 -0.00239504 0 0.0974821 -6.73502e-05 0 0.140221 0.00556537 0 + 0.329063 0.00434978 0 0.136061 -0.0171628 0 0.367657 -0.0185795 0 0.0446231 -0.00153799 0 + 0.0605298 0.00206618 0 0.296499 -0.19317 0 0.0319079 9.73089e-05 0 0.0891387 0.000827982 0 + 0.0794785 0.00178566 0 0.199552 -0.0176465 0 0.10779 0.145186 0 0.379372 -0.105548 0 + 0.11043 -0.088529 0 0.27035 -0.00180642 0 0.00840095 0.00163181 0 0.038658 0.00678323 0 + 0.312289 -0.0766225 0 0.0630429 0.0180587 0 0.309014 0.113004 0 0.283459 -0.0104216 0 + 0.121316 0.119898 0 0.267044 -0.000980858 0 0.277534 0.0250917 0 0.262123 -0.115106 0 + 0.213504 -0.0463496 0 0.0646317 -0.106274 0 0.23825 0.0276503 0 0.28337 -0.122961 0 + 0.365618 -0.0189572 0 0.268765 -0.00601414 0 0.0832549 0.103119 0 0.0559121 -0.0415211 0 + 0.339855 0.0371944 0 0.09338 0.0862573 0 0.296134 -0.132837 0 0.251296 0.0468931 0 + 0.130135 -0.0273632 0 0.258423 -0.0577912 0 0.27401 -0.00181911 0 0.159937 0.0357431 0 + 0.122243 -0.000399533 0 0.141046 -0.0606478 0 0.141959 -0.0673316 0 0.196518 -0.0815733 0 + 0.018229 -7.93457e-06 0 0.173403 -0.142255 0 0.133576 -0.020227 0 0.0579093 -0.0202621 0 + 0.0854094 0.000267885 0 0.169095 -0.0836904 0 0.350284 -0.0495516 0 0.0478192 0.00898942 0 + 0.145794 0.10099 0 0.026603 -0.00845266 0 0.298349 -0.0150265 0 0.00939042 -0.000102452 0 + 0.28216 -0.000713573 0 0.352096 -0.0273218 0 0.0577032 -0.00943842 0 0.135037 0.021244 0 + 0.285172 0.0481909 0 0.276025 0.0006941 0 0.00358115 -0.0069122 0 0.0316064 -2.61179e-05 0 + 0.211704 -0.022645 0 0.182199 0.177291 0 0.15774 -0.126702 0 0.0592669 0.00607891 0 + 0.283122 0.000127426 0 0.0469465 -0.0119921 0 0.20011 0.0328312 0 0.250323 0.201444 0 + 0.279206 0.128039 0 0.0379765 -0.0100497 0 0.243556 -0.102332 0 0.12492 -0.15462 0 + 0.355027 -0.0120483 0 0.281573 -0.121759 0 0.12527 -0.126881 0 0.33851 -0.00920783 0 + -0.00421876 0.00556139 0 0.036884 -0.00561391 0 0.235604 0.046346 0 0.050563 0.00891311 0 + 0.308114 0.136616 0 0.124669 0.0398046 0 0.042918 -0.0830982 0 0.0323788 3.40165e-05 0 + -0.00180423 -0.00623045 0 0.286251 0.0884319 0 0.206425 0.0275267 0 0.073393 0.0151104 0 + 0.239943 0.00892742 0 0.26729 -0.0033548 0 0.256666 -0.0733038 0 0.252832 -0.0415826 0 + -0.0105503 -0.00302832 0 0.23427 -0.000362634 0 0.305575 0.102333 0 0.204877 -0.00694387 0 + 0.103128 -0.111355 0 0.0113438 -0.00455834 0 0.041445 -2.77158e-05 0 0.109572 0.113734 0 + 0.079499 0.00918276 0 0.247373 0.10622 0 0.209918 -0.0804267 0 0.315914 0.0642036 0 + 0.267861 -0.0441729 0 0.200879 -0.0762875 0 0.0481118 6.83924e-05 0 0.337206 0.174825 0 + 0.256642 0.0427304 0 0.283449 -0.00152276 0 0.0142135 -0.00222017 0 0.135375 -0.143728 0 + 0.278175 -0.123261 0 0.301574 0.157715 0 0.262715 -0.0436768 0 0.0910577 0.000306658 0 + 0.00603179 0.00390588 0 0.0418901 -0.0769859 0 0.0246993 -0.0567029 0 0.230375 0.0314071 0 + 0.0902989 -0.133561 0 0.230444 0.0449687 0 0.184358 0.121141 0 0.017424 -0.0049993 0 + 0.178132 -0.0636227 0 0.0771148 -0.000219181 0 0.0532377 0.0132192 0 0.361868 -0.0291941 0 + 0.364187 0.0266845 0 0.159402 -0.0456028 0 -0.0026046 0.00258252 0 0.0737323 -0.000191038 0 + 0.27574 -0.0355566 0 0.17793 -0.00389776 0 0.0462805 0.0100324 0 0.075637 0.0482972 0 + 0.169191 0.0604939 0 0.393389 -0.0591623 0 0.168911 0.0866951 0 0.130214 0.0688179 0 + 0.229389 -0.0519585 0 0.268338 -0.00134454 0 -0.00553677 0.000800276 0 0.0635434 -0.105993 0 + 0.0219806 -0.00731015 0 0.260548 0.0441978 0 0.17448 0.0135597 0 0.141277 -0.033909 0 + 0.234202 0.00619965 0 0.0828503 0.0776582 0 0.282645 -0.0175481 0 0.102812 -0.0152938 0 + 0.368989 0.0878216 0 0.0600396 -0.0124413 0 0.230833 0.0178374 0 0.233319 0.194821 0 + 0.222365 0.170903 0 0.00105368 0.00332656 0 0.278933 0.0244705 0 0.0514227 -0.00697954 0 + 0.344957 -0.00121995 0 0.0381789 0.000556636 0 -0.00204643 -0.00264386 0 0.361145 -0.10634 0 + 0.0333975 -1.75996e-05 0 0.0758032 -0.00144583 0 0.131565 -4.69022e-05 0 0.297819 -0.168405 0 + 0.278136 -0.0112212 0 0.334466 0.129983 0 0.114512 -0.0174421 0 0.0433779 -1.30506e-05 0 + 0.00234824 -0.0057732 0 0.328779 0.156529 0 0.282114 -0.000868372 0 0.371267 0.000565913 0 + 0.372976 -0.00540524 0 0.261961 0.0259989 0 0.261122 0.068221 0 0.25233 -0.0601354 0 + 0.210192 0.0830886 0 0.299992 0.0398156 0 0.258982 -0.0889744 0 0.0277823 -0.00805899 0 + 0.311781 -0.137006 0 0.267255 0.0406556 0 0.0445369 -6.81982e-05 0 -0.00119531 0.00608834 0 + 0.20799 -0.0115766 0 0.265529 0.00191821 0 0.308995 -0.170279 0 0.291361 0.125966 0 + 0.277858 -0.0123577 0 0.125722 0.00317486 0 0.267186 0.00126815 0 0.133076 -0.0149191 0 + 0.284527 -0.000689111 0 0.300115 -0.120977 0 0.268964 -0.00451389 0 0.0637344 6.81652e-05 0 + 0.152312 0.0425796 0 0.0521908 -0.0958892 0 0.274911 0.0492437 0 0.109586 0.00227953 0 + 0.284448 -0.0491631 0 0.249051 0.201212 0 0.0116376 -0.00298016 0 0.0715422 -0.101702 0 + 0.159126 0.00216184 0 0.269125 0.0233302 0 0.386263 0.124697 0 0.2579 -0.0207038 0 + 0.111219 -0.00043005 0 0.193748 -0.0944017 0 0.0127846 -0.027739 0 0.250917 0.0282632 0 + 0.269479 0.00607965 0 0.277189 -0.0118817 0 0.0609491 -0.0923599 0 0.0500757 -0.000510836 0 + 0.2136 0.0294074 0 -0.000708747 -0.00532207 0 0.0527213 -0.0959675 0 0.182739 -0.162777 0 + 0.382997 0.0339193 0 0.20087 0.0371227 0 -0.00237908 -0.005581 0 0.294962 -0.000437273 0 + 0.293787 -0.0443545 0 0.265918 0.0811767 0 0.280712 0.00013905 0 0.364861 -0.00303917 0 + 0.263257 0.0419771 0 0.167055 -0.0577534 0 0.143887 0.113584 0 -0.00381745 -0.00724837 0 + 0.242374 0.0595464 0 0.0712915 -0.0104575 0 0.0474101 0.00162429 0 0.368575 -0.00507859 0 + 0.137936 0.0152676 0 0.213744 0.0299894 0 0.0337342 0.00957211 0 0.177012 -0.00817154 0 + 0.224091 -0.0394711 0 0.000572525 0.00648047 0 0.0630989 -0.102825 0 0.253766 0.0393065 0 + 0.045506 -0.0148977 0 0.0436371 0.000433769 0 0.253863 -0.0038809 0 0.206093 -0.0119467 0 + 0.356504 0.00525752 0 0.322277 -0.145907 0 0.212724 0.159906 0 0.323454 -0.0912945 0 + 0.340388 -0.017464 0 0.0440514 -6.30939e-05 0 0.121318 0.1048 0 0.165487 0.0386243 0 + 0.107137 0.00396979 0 -0.00354205 0.00913944 0 0.277365 -0.19923 0 0.0758578 0.000721926 0 + 0.19879 -0.160138 0 0.28574 -0.0443309 0 0.157947 0.128429 0 0.0389284 -0.000346033 0 + 0.0674108 0.00776511 0 0.174998 -0.0189834 0 0.0777312 -0.0158133 0 0.0609723 9.87826e-05 0 + 0.33223 0.167567 0 0.190939 0.0209817 0 0.0884999 0.00463494 0 0.0811075 -0.00237374 0 + 0.00640699 0.00630526 0 0.208199 -0.0208544 0 0.249016 0.0273062 0 0.12737 0.0844911 0 + 0.122701 -0.0120423 0 0.178028 0.0307151 0 0.356564 0.0102172 0 0.208815 -0.0417571 0 + 0.149331 -0.0302434 0 0.0344258 -0.00905994 0 0.080426 -0.124581 0 0.232093 0.193774 0 + 0.158027 0.0278817 0 0.240896 0.0501908 0 0.207482 0.018626 0 0.119414 -0.0255984 0 + 0.129336 -0.0196979 0 0.387014 -0.0905052 0 0.206992 -0.0102034 0 0.218138 -0.0208549 0 + 0.158228 0.0201387 0 0.277841 4.96065e-05 0 0.27566 0.0136007 0 0.0709347 -0.000374282 0 + 0.244578 0.0169139 0 0.202514 0.03966 0 0.315683 -0.176115 0 0.34226 -0.105686 0 + 0.206131 0.0127095 0 0.171211 -0.1399 0 0.0279551 -0.00851045 0 0.0739167 0.000195942 0 + -7.82443e-05 -0.0034115 0 0.307409 -0.0387548 0 0.387791 -0.0283723 0 -0.000707886 0.00106996 0 + 0.149198 0.00750177 0 0.253562 -0.0419197 0 -0.000702904 -0.00246025 0 0.291147 -0.000740253 0 + 0.00797681 0.00610735 0 0.069951 -0.0320934 0 0.337418 -0.038746 0 0.268659 -0.00474014 0 + 0.287738 -0.192755 0 0.187233 0.0450896 0 0.234235 -0.0303578 0 0.193005 0.0121145 0 + 0.249628 -0.200907 0 0.27318 -0.00135867 0 0.26949 -0.00136657 0 0.352156 0.0326856 0 + 0.341631 0.108951 0 0.0473983 -0.011456 0 0.166112 -0.0309749 0 0.295283 -0.00106281 0 + 0.215669 0.019486 0 0.0392935 -4.73036e-05 0 0.0208798 -0.0272643 0 0.287532 -0.000912085 0 + 0.0539925 0.0171308 0 0.244291 0.00670257 0 0.147584 0.017885 0 0.327248 -0.0339708 0 + 0.22803 -0.0548723 0 0.106039 -0.0170025 0 0.0838842 0.00711685 0 0.0303379 3.18506e-05 0 + 0.295957 0.0481233 0 0.295241 0.00161065 0 0.296818 0.00378808 0 0.0767063 0.0109218 0 + 0.247551 -0.0112623 0 0.274141 -0.00292761 0 0.0636985 0.00013256 0 0.136272 0.0178919 0 + 0.299138 -0.0626167 0 0.168619 0.106651 0 0.0622179 0.0993914 0 -0.00279479 0.00415973 0 + 0.135378 -0.000832077 0 0.0539735 4.03677e-05 0 0.274225 -0.0179129 0 0.291048 0.00191097 0 + 0.0407384 -0.000707029 0 0.239052 -0.0332261 0 0.126874 -0.00811958 0 0.31646 -0.107843 0 + 0.140402 0.0291892 0 0.184378 -0.00826771 0 0.0314844 -1.83492e-05 0 0.28877 0.0487716 0 + -0.0109594 -0.000327189 0 0.290026 -0.000848153 0 0.302693 0.00457714 0 0.161114 0.0284101 0 + 0.0870225 -0.015129 0 0.260063 0.200744 0 0.212836 0.0189031 0 0.296691 0.00312038 0 + 0.0363682 -0.0101202 0 0.131414 -0.000437321 0 0.264309 0.0239174 0 0.24983 -0.011135 0 + 0.115259 -0.0155273 0 0.33894 0.119538 0 0.283118 5.62875e-05 0 0.0182402 -0.000238778 0 + 0.331894 0.141805 0 0.0592316 -0.0134703 0 0.22959 0.0709146 0 0.338124 -0.0562124 0 + 0.052163 -0.0234189 0 0.0459169 -2.2043e-05 0 0.0260788 0.000228406 0 0.182665 0.0778743 0 + 0.309781 -0.0813454 0 0.291064 -0.0204179 0 0.271324 -0.0032708 0 0.268907 -0.00144416 0 + 0.00797158 0.00358042 0 0.24748 0.0778891 0 0.100922 -0.016245 0 0.175272 -0.106284 0 + 0.220515 0.0266636 0 0.226157 -0.186581 0 0.347305 -0.0208654 0 0.125698 -0.00296211 0 + 0.204194 0.132942 0 0.0364971 -0.000739191 0 0.337855 0.133186 0 -0.00242686 0.0061066 0 + 0.300691 0.0496906 0 0.218726 -0.0441886 0 0.264706 0.0703791 0 0.381798 0.00232995 0 + 0.0723959 0.0159062 0 0.0317225 -5.33476e-05 0 0.300576 -0.0125194 0 0.214011 0.0447618 0 + 0.358236 -0.00347675 0 0.261029 -0.000961535 0 0.0161861 -0.00619473 0 0.326101 -0.0194875 0 + 0.25688 0.0271784 0 0.0503526 0.000309123 0 0.269636 0.00272854 0 0.338559 0.0177594 0 + 0.160014 -0.00657926 0 -0.0021387 0.00345886 0 0.284525 -0.00133194 0 0.283719 4.38613e-05 0 + 0.136746 0.0012449 0 0.350739 -0.00654954 0 -0.003 -0.00786136 0 0.106021 0.081683 0 + 0.0996702 -0.0154611 0 0.0530789 4.69368e-05 0 0.169208 -0.152761 0 0.338878 0.161711 0 + 0.0359527 0.0109883 0 0.266067 -0.000968445 0 0.0879151 -0.00109822 0 0.293366 -0.0225171 0 + 0.14794 0.0358028 0 0.0727936 0.117067 0 0.139193 -0.0043137 0 0.0308569 -0.00028477 0 + 0.248235 -0.199497 0 0.0485375 -0.0323872 0 0.104499 -0.145403 0 0.0125287 -0.00954233 0 + 0.0207691 -0.00591414 0 0.264755 0.143636 0 0.0711285 -0.0133946 0 0.188303 0.133778 0 + 0.301769 -0.0260076 0 0.0322333 -0.0228013 0 0.0402694 1.81672e-05 0 0.362952 0.0246489 0 + 0.0487382 0.000344723 0 0.259979 0.00279319 0 0.271106 0.0219025 0 0.0353996 4.73113e-06 0 + 0.178301 0.0862992 0 0.242658 -0.0469239 0 0.0935236 0.0174618 0 0.321636 -0.0625774 0 + 0.092448 0.0017494 0 0.392251 -0.0559077 0 0.330871 0.122492 0 0.0288017 -0.000684558 0 + 0.201858 0.0418656 0 0.134177 0.00121756 0 -0.00484627 -0.00355943 0 0.0389497 5.14213e-05 0 + 0.236223 -0.00241853 0 0.0856086 0.00186939 0 0.126541 0.0257994 0 0.276679 -0.014346 0 + 0.305121 -0.0982639 0 0.194064 0.0797638 0 -0.00307598 0.00757193 0 0.214614 -0.0349036 0 + 0.118099 0.0509766 0 0.372787 0.0162072 0 0.364211 0.146044 0 0.0377332 0.00051355 0 + 0.230992 0.0538847 0 0.147862 -0.0108627 0 0.0531293 0.0125451 0 0.0819069 -0.00131827 0 + 0.331779 0.00837243 0 0.291219 -0.000610067 0 0.274658 0.0255364 0 0.24212 0.0281857 0 + 0.286778 -2.65773e-07 0 0.275157 -0.0133832 0 0.0473295 0.000219238 0 -0.00231932 0.00528056 0 + 0.250234 0.010242 0 0.362927 0.15153 0 -0.00349386 0.00412069 0 0.378764 -0.0670082 0 + 0.270948 -0.0372928 0 0.104829 -0.00741036 0 0.0379297 0.000684699 0 -0.000340194 -0.00291723 0 + 0.274931 0.0409152 0 0.0242687 0.0085785 0 0.146132 -0.014783 0 0.269707 -0.00408656 0 + 0.19533 0.186969 0 0.0455774 -7.33443e-05 0 0.0444679 0.000528347 0 0.0685844 -0.00367394 0 + 0.299581 0.115233 0 0.26 -0.00433571 0 0.337666 0.00506652 0 0.359876 -0.100384 0 + 0.137255 -0.00490124 0 0.345945 0.0368544 0 0.190897 0.0106816 0 0.124129 -0.0187756 0 + 0.0286382 -0.00149725 0 0.0571663 -8.15771e-05 0 0.00636325 0.00108002 0 0.285581 5.6253e-05 0 + 0.248255 0.0387391 0 0.047624 -0.0121824 0 0.0461638 0.0113613 0 -0.00313631 -0.00873854 0 + -0.00349505 -0.00818123 0 0.0132185 0.00290608 0 0.342726 -0.122928 0 0.33031 -0.00175953 0 + 0.047243 -5.72246e-05 0 0.0522238 0.0179158 0 0.0971276 0.000415933 0 0.13671 -0.0189779 0 + 0.321246 -0.0167251 0 0.224664 -0.109464 0 0.151391 -0.0227499 0 0.136756 -0.02016 0 + -0.00426698 0.0048006 0 0.0220993 0.00504281 0 0.143345 -0.02 0 0.0159204 0.0028338 0 + 0.258846 -0.19843 0 0.257887 -0.00092106 0 0.0682078 0.00161093 0 0.244916 -0.0419102 0 + 0.0323187 0.000701881 0 0.136456 0.134701 0 0.341086 -0.149189 0 0.0161922 -0.00578072 0 + 0.276797 -0.00207023 0 0.000823188 0.00132108 0 0.119029 0.0331424 0 0.279894 -0.197877 0 + 0.0962614 0.13786 0 0.23559 0.0437301 0 0.0943952 0.00690555 0 0.0676136 0.00985512 0 + 0.324897 0.181999 0 0.282837 -0.00141821 0 0.254983 0.0262771 0 0.201989 -0.146227 0 + 0.0801843 -0.0955232 0 0.304774 -0.0270616 0 0.00781982 0.000181219 0 0.269656 -0.00260661 0 + 0.0691141 0.000148071 0 0.143899 0.018224 0 0.264463 -0.0423433 0 0.0082272 -0.00832788 0 + 0.346094 -0.0674386 0 0.310185 0.0400132 0 0.271569 -0.00330153 0 0.282852 -0.0533445 0 + 0.0658403 0.0152255 0 0.214082 0.193312 0 0.21925 0.0516883 0 0.0747516 -0.000215086 0 + 0.182501 -0.121175 0 0.0866272 0.0169357 0 0.216245 -0.186173 0 0.0192964 -0.000407049 0 + 0.00421168 -0.00404204 0 -0.00269293 -0.00646886 0 0.0258955 0.00559585 0 0.137343 0.00505881 0 + 0.255057 -0.033866 0 0.337026 0.151004 0 0.343574 -0.0325946 0 0.182375 -0.0209496 0 + 0.0164527 0.00341696 0 0.0435008 -0.000295213 0 0.332738 0.173532 0 0.117398 0.153717 0 + 0.335329 0.167338 0 0.241635 0.191265 0 0.392712 -0.0410222 0 0.000668666 -0.00488462 0 + 0.0533251 0.0136555 0 0.00885305 0.00147309 0 -0.0018588 -0.00447345 0 0.328946 0.120775 0 + 0.00141656 0.00238594 0 0.0199376 0.0400582 0 0.157319 -0.0211052 0 0.308423 -0.00698543 0 + 0.0283686 -0.00852293 0 0.369176 -0.0385324 0 0.00355959 0.000120559 0 0.189803 0.184834 0 + 0.319671 0.161141 0 0.0331617 0.00744609 0 0.387229 -0.101417 0 0.337996 0.139214 0 + 0.162976 -0.0109837 0 0.239185 -0.112674 0 0.34536 0.000696601 0 -0.00223498 -0.00585964 0 + 0.368843 0.150422 0 0.00156864 0.00524461 0 0.00300957 0.00643503 0 0.221339 -0.00562699 0 + 0.277942 -0.0141393 0 -0.00186337 0.00618504 0 0.242875 -0.0171826 0 0.00218588 3.35179e-05 0 + 0.348277 -0.104544 0 0.0943938 -0.0145699 0 -0.00319148 0.00898491 0 0.0403508 1.04019e-05 0 + 0.00524268 0.00201012 0 -0.0101226 0.00180688 0 0.206314 -0.0932296 0 0.0987294 0.0231836 0 + 0.384407 -0.0790726 0 0.273658 -0.0135562 0 0.265533 -0.101591 0 0.33189 0.128399 0 + 0.190846 -0.134783 0 0.0859726 -0.0136719 0 0.0486941 -0.000139601 0 0.0414435 2.48722e-05 0 + 0.322743 0.111996 0 0.0183614 0.00714045 0 0.359594 0.143586 0 0.304641 -0.0269551 0 + 0.0279191 0.00444292 0 0.113936 0.000524876 0 0.280252 -0.0153226 0 0.257245 -0.080994 0 + 0.307631 0.092757 0 0.143572 -0.00510362 0 0.286534 0.113467 0 0.229197 -0.0310669 0 + 0.103577 0.00194753 0 0.289295 -0.000491696 0 0.286073 -0.000504671 0 0.0764842 0.00614137 0 + 0.00049598 0.000293109 0 0.290377 -7.16733e-05 0 0.0431221 -0.000357551 0 0.0525588 -0.00837359 0 + -0.0147768 -0.000389946 0 -0.00223019 -0.00876053 0 0.0924431 0.000333031 0 0.278193 0.0556993 0 + 0.032599 0.0104065 0 0.046676 -0.00205798 0 -0.00973693 -0.00301314 0 0.131415 -0.000450237 0 + 0.0574457 2.45964e-05 0 0.267985 -0.00253509 0 0.377834 0.0215083 0 0.00319752 0.00369762 0 + 0.228763 -0.0193088 0 0.110219 -0.00879136 0 0.260285 0.0179533 0 0.336731 -0.112039 0 + 0.0763567 0.0124819 0 0.0140638 0.00542229 0 0.035967 -0.038795 0 0.0677795 -0.00703919 0 + 0.313261 -0.0233392 0 0.0361241 0.000399656 0 0.287102 -0.00708531 0 0.0681323 0.0149401 0 + 0.329795 -0.0369147 0 0.378659 -0.00858301 0 0.283139 -0.0112766 0 0.0966634 0.0213904 0 + 0.289176 0.0124803 0 0.196928 0.0187464 0 -0.0032289 -0.00788651 0 0.33197 -0.112839 0 + 0.0387493 -4.97374e-05 0 0.215964 0.0439483 0 0.276942 -0.00210435 0 0.148722 0.0605608 0 + 0.19971 -0.00729368 0 0.37925 -0.0882176 0 0.042026 0.0821879 0 0.259607 0.198187 0 + 0.0982405 -0.132017 0 0.0640415 -0.0724742 0 0.22514 -0.175762 0 0.0471399 0.0127026 0 + 0.174444 -0.0307997 0 0.283503 -0.0134002 0 0.0538875 0.00365553 0 0.215427 -0.10871 0 + 0.282755 -0.114985 0 0.099982 -0.0884597 0 0.140728 -0.166078 0 0.017488 0.00184082 0 + 0.340405 -0.0367966 0 0.276799 -0.00355446 0 0.0786761 -0.00865249 0 0.0143684 0.00243692 0 + 0.324292 -0.0178098 0 0.165439 -0.0133761 0 0.284138 0.0596811 0 0.18917 -0.157899 0 + 0.225766 -0.0897869 0 0.335296 0.156912 0 0.281326 0.112716 0 0.357358 -0.00161276 0 + 0.228895 -0.049918 0 0.159353 -0.00766789 0 0.198002 0.0161491 0 0.237305 -0.0427004 0 + 0.273802 -0.197584 0 0.238525 0.0541082 0 0.00950376 -0.00244381 0 -0.012438 0.000198068 0 + 0.382552 -0.109275 0 0.0194733 -0.00519723 0 -0.005876 -0.00736877 0 0.267246 0.0225953 0 + 6.55935e-05 0.0060673 0 0.187684 0.0243454 0 0.0276545 2.66207e-06 0 0.372953 -0.0556287 0 + 0.00705081 -0.00336663 0 0.147229 -0.00670912 0 0.0657143 0.000129689 0 0.057337 9.77605e-05 0 + 0.2593 -0.0542326 0 0.110143 -0.148474 0 0.250001 0.101389 0 0.172215 -0.00177829 0 + 0.297989 0.137725 0 0.334713 -0.106892 0 0.260822 -0.0500145 0 0.26 -0.000948139 0 + 0.116243 0.0185136 0 0.267751 0.127654 0 0.348371 -0.001953 0 0.231192 -0.0787651 0 + 0.0376816 0.00811691 0 0.273964 0.000613695 0 -0.00306277 -0.00695788 0 0.235449 -0.0483336 0 + 0.272209 0.000962797 0 0.0910183 0.117855 0 0.231883 -0.0408281 0 0.248847 0.00264214 0 + 0.149195 0.0225367 0 0.082605 -0.0134573 0 0.307235 0.193801 0 0.167987 -0.0401702 0 + 0.290595 -0.00344445 0 0.205805 -0.0302591 0 0.26926 0.00070966 0 -0.00485456 0.00822768 0 + 0.270126 0.117669 0 0.109172 0.018087 0 0.33995 -0.0310083 0 0.191323 -0.10347 0 + 0.26903 -0.00350287 0 -0.000262833 -0.00809027 0 0.150395 -0.00386604 0 0.276039 -0.0217931 0 + 0.279541 0.0258316 0 0.100014 0.00272989 0 0.253908 -0.0289492 0 0.327427 -0.159476 0 + 0.0927458 -0.0153675 0 0.301141 0.0478681 0 0.351377 -0.0660406 0 0.356113 -0.00224624 0 + 0.385856 -0.0964968 0 0.0881639 -0.0101688 0 0.0119752 -0.00470998 0 0.083695 0.0770255 0 + 0.282027 -0.00644294 0 0.275245 -0.00187751 0 0.250474 -0.00195808 0 0.138599 -0.0150846 0 + 0.250713 0.0238678 0 0.177965 0.150336 0 0.251546 -0.00188637 0 0.324542 0.117745 0 + 0.316099 0.166078 0 0.00295365 0.00309121 0 0.276747 -0.154481 0 0.0318673 6.76554e-06 0 + 0.288611 -0.000772787 0 0.301958 -0.0251575 0 0.336881 -0.0460135 0 0.311733 -0.0122365 0 + 0.152228 -0.0224494 0 -0.00260925 0.00625073 0 0.260466 0.00139625 0 0.304373 0.0322036 0 + 0.263831 0.0022696 0 0.133131 -0.00431397 0 0.0739534 0.000181318 0 -0.00657345 0.00472064 0 + 0.257728 -0.0865335 0 0.324945 0.177047 0 0.154061 -0.15824 0 0.140585 -0.156049 0 + 0.204904 0.0279501 0 -0.00258768 -0.00750206 0 0.2571 -0.0655713 0 0.127608 -0.0126743 0 + 0.28198 0.0271044 0 -0.00599283 0.00546388 0 0.142117 -0.0197934 0 0.246495 -0.0160848 0 + 0.339297 0.0208171 0 0.192424 -0.00948225 0 0.219571 0.0250762 0 0.323198 0.144131 0 + 0.356175 -0.0340841 0 0.0397474 -0.00044263 0 0.250119 0.193135 0 0.371433 0.00713874 0 + 0.25558 0.0497114 0 0.366478 0.00463473 0 0.169884 0.0215067 0 0.25645 -0.0704085 0 + 0.349544 0.0444544 0 0.173626 0.0347515 0 0.242076 0.100366 0 0.0291167 -0.000251505 0 + 0.28698 0.0495436 0 0.216309 -0.0527794 0 0.0251202 -0.0407884 0 -0.00137747 -0.000397299 0 + 0.37632 0.00793944 0 0.0838085 0.000990434 0 0.248786 -0.0316879 0 0.190457 0.00336324 0 + 0.124468 -0.159479 0 0.366014 -0.00591275 0 0.160804 0.141027 0 0.227454 0.0339871 0 + 0.0167182 -0.000216508 0 0.164861 0.00875049 0 0.252871 -0.025949 0 0.219123 -0.00242217 0 + 0.268891 -0.00432968 0 0.0757719 -0.108516 0 -0.00156596 0.00681042 0 0.311623 0.0281761 0 + 0.0811767 0.0165184 0 0.306871 -0.0928152 0 0.288486 -0.00090424 0 0.303872 -0.117403 0 + 0.140292 -0.0871757 0 0.262989 -0.00675811 0 0.271341 0.107646 0 0.269475 0.0323822 0 + -0.00245839 -0.0083356 0 -0.00716822 -0.00659189 0 0.230767 -0.00924172 0 0.212995 0.191605 0 + 0.258076 0.118176 0 -0.0103682 -0.00342494 0 0.383196 0.0195684 0 0.00030018 0.00658339 0 + 0.000494981 -0.00324999 0 0.296617 0.0209289 0 0.242767 -0.0067589 0 0.0466753 0.010105 0 + 0.00803292 0.00069023 0 0.180135 -0.0199229 0 0.295298 0.115308 0 0.0183575 -8.32232e-06 0 + 0.0183316 -8.45148e-06 0 0.343335 -0.0147348 0 0.33683 -0.117718 0 0.140837 -0.00296288 0 + 0.0029917 -0.00675326 0 0.266664 0.0806056 0 0.220381 0.0107953 0 0.298632 0.146283 0 + 0.258119 -0.029476 0 0.0650128 0.107832 0 0.0785615 -0.00048034 0 0.362017 0.00667726 0 + 0.274145 -0.00134955 0 0.00971038 9.04198e-06 0 0.0505239 0.0910758 0 0.24949 -0.0306426 0 + 0.282543 -0.00141125 0 0.162174 -0.0342292 0 0.348905 0.136269 0 0.286657 -0.0207551 0 + 0.0472948 0.00197266 0 0.255357 -0.192285 0 0.0854065 -0.00157247 0 0.325795 0.0299372 0 + 0.212128 -0.0139279 0 0.282859 0.0413834 0 0.258974 -0.0437415 0 0.203992 -0.0773273 0 + 0.283714 0.0542603 0 -0.00476819 0.00873504 0 0.0803151 0.0158016 0 0.144527 0.129172 0 + -0.00300409 -0.00520961 0 0.170801 0.0198998 0 0.0227477 0.00023378 0 0.066589 -0.0416394 0 + 0.221215 -0.00262311 0 0.378641 -0.0725513 0 0.27347 0.0358601 0 0.00194832 -0.00493098 0 + -0.00179492 -0.00182006 0 0.274621 -0.0191451 0 0.363108 -0.0453535 0 -0.0118973 0.00236625 0 + 0.162844 -0.0669112 0 0.332194 0.0263912 0 0.0404349 -8.06767e-06 0 0.115481 0.00128688 0 + 0.012807 7.29038e-05 0 0.0551519 5.0621e-05 0 0.0416433 4.2095e-05 0 0.335994 -0.0118227 0 + 0.18005 0.0214374 0 0.303468 0.0433621 0 0.311676 0.0275273 0 0.313838 0.0247794 0 + 0.252792 -0.0282393 0 0.00617387 -0.00373911 0 0.182137 -0.13008 0 0.133213 0.000954974 0 + 0.0258648 0.00245022 0 -0.0039285 0.00908519 0 0.285477 0.0921235 0 0.0610705 0.00563814 0 + 0.00812522 0.00498345 0 0.337201 -0.0159087 0 0.307201 0.0437308 0 0.0194198 -0.000314867 0 + -0.00148095 -0.00411738 0 0.0518362 0.0108114 0 -0.000338248 0.00404694 0 0.0453902 -0.000438581 0 + 0.0973501 -0.00250021 0 0.176495 -0.022671 0 0.261271 0.010474 0 0.248452 -0.0223902 0 + 0.252073 0.00436529 0 0.301264 -0.0334706 0 0.391538 0.0727378 0 0.278442 0.0473334 0 + -0.000607521 -0.00277757 0 0.235402 0.0112457 0 0.258799 0.038783 0 0.279407 0.114607 0 + 0.00214998 -0.00264386 0 0.243373 -0.0411895 0 0.279734 0.0240097 0 0.121411 0.0294197 0 + 0.358583 0.0903036 0 0.329554 0.000171665 0 0.352633 -0.0970507 0 0.244244 -0.0307364 0 + 0.125865 -0.00388639 0 0.268548 0.0416324 0 0.231864 0.197569 0 0.17867 0.0408853 0 + 0.325251 -0.17596 0 0.144916 -0.00600126 0 -0.00169904 0.00860376 0 0.00714091 0.00406958 0 + 0.000252062 0.00183872 0 0.06196 0.00430916 0 0.133063 0.0187539 0 0.0340994 -0.00250026 0 + 0.345442 -0.0241442 0 0.281348 -0.000573552 0 0.277186 -0.00058796 0 0.245793 -0.0536366 0 + 0.385747 -0.111244 0 0.155622 0.0211846 0 0.284993 0.116501 0 0.267351 -0.0357552 0 + 0.27555 -0.0103391 0 -0.00353569 -0.00882838 0 0.235988 0.0954671 0 0.290091 0.00858257 0 + 0.163723 -0.0124047 0 0.330527 -0.006649 0 0.214069 -0.00370126 0 0.167185 -0.0969267 0 + 0.144765 -0.141923 0 0.206689 0.0206928 0 -0.00279869 -0.00314944 0 -0.00225296 0.00463874 0 + 0.155041 0.0513407 0 0.17383 0.119379 0 0.359115 0.0300647 0 0.0622685 0.0127806 0 + 0.215043 0.0186096 0 0.275502 0.195189 0 0.323664 -0.106869 0 -0.00225319 -0.00141683 0 + 0.185673 -0.169933 0 0.229685 -0.0344918 0 0.268196 -0.0114306 0 0.209531 -0.0160212 0 + 0.21718 -0.0980929 0 0.0534912 0.0138467 0 0.00313609 -0.00340211 0 0.309439 0.0448908 0 + 0.0446015 0.0154479 0 0.225985 0.0114969 0 0.256532 -0.0276716 0 0.254751 -0.0166194 0 + 0.324785 0.105277 0 0.0522906 -0.0917246 0 0.021365 -0.0108489 0 0.397473 0.0527328 0 + 0.275738 -0.0232483 0 0.206469 -0.0472901 0 -0.000637137 0.0016441 0 0.0509802 -0.0916559 0 + 0.256674 -0.000904721 0 0.215072 0.123409 0 0.363472 -0.0485411 0 0.246939 -0.0175366 0 + 0.253364 0.0971213 0 0.314781 -0.184606 0 0.0111295 -0.00467571 0 0.268292 -0.00413851 0 + 0.265979 0.0469316 0 0.0388622 0.075509 0 0.256273 -0.0644166 0 0.305127 -0.0086391 0 + 0.00767417 -0.0048432 0 0.0238902 0.00301599 0 0.253367 0.0910212 0 0.394229 0.0361217 0 + 0.19672 0.0725331 0 0.195706 0.0471545 0 0.336545 0.0281809 0 0.224966 -0.0848092 0 + 0.275234 0.0178816 0 0.346971 -0.0986645 0 0.080663 -0.0118721 0 0.366605 0.0225226 0 + 0.225251 -0.0301795 0 -0.0033447 -0.00269786 0 0.372451 0.143775 0 0.0200363 0.000566106 0 + 0.147303 0.0343229 0 0.0129273 0.00557643 0 -0.00258541 -0.00533326 0 0.264185 0.00169167 0 + 0.116856 -0.0129689 0 0.294185 -0.000489633 0 0.367523 0.00812316 0 0.067574 -0.0129465 0 + 0.240482 -0.0467348 0 -0.011479 0.00193608 0 0.220519 0.0114225 0 0.374371 0.00882329 0 + 0.0630574 0.0192652 0 0.0610781 0.000124199 0 0.237143 -0.0688506 0 0.350169 0.0530503 0 + 0.0348685 -3.0067e-05 0 0.29114 0.112922 0 0.154658 -0.0168798 0 0.251807 -0.0749833 0 + -0.00284531 -0.00738809 0 0.0971485 0.00364131 0 0.140447 -0.0165169 0 0.182214 0.00726953 0 + 0.317374 -0.00174519 0 0.0284223 -1.83829e-05 0 0.281781 0.0251789 0 0.218718 0.00393613 0 + 0.274949 -0.0234683 0 0.363409 -0.0922372 0 0.172461 -0.0142496 0 0.266245 -0.00579205 0 + 0.00518537 -0.000358658 0 0.0998535 -0.00313194 0 0.0917491 0.000128146 0 0.205957 -0.0120145 0 + 0.389588 0.0276156 0 0.358938 -0.0258597 0 0.378741 0.138984 0 0.261391 0.0404585 0 + 0.334267 -0.147875 0 0.366349 -0.000143617 0 0.0221647 -0.00758642 0 0.00995994 -0.00280804 0 + 0.062154 -0.00268248 0 -0.0038731 -0.00816718 0 0.139146 0.167479 0 0.0228791 0.00842074 0 + 0.271752 0.0428875 0 0.154598 0.16989 0 0.230902 0.0468458 0 0.164508 0.173331 0 + 0.310601 0.0475069 0 0.165242 -0.0179165 0 0.322474 0.0296644 0 0.257184 -0.0255795 0 + 0.195794 -0.015565 0 0.221978 0.0145227 0 0.258113 0.008215 0 0.17958 -0.0343889 0 + 0.043661 -0.00632783 0 0.249615 0.0447628 0 0.143618 -0.0219009 0 0.349756 0.0241083 0 + 0.396778 0.0446687 0 0.144039 -0.171071 0 0.0904376 0.00147621 0 0.0456918 0.00746041 0 + -0.00362677 0.00942336 0 0.146422 -0.0146507 0 0.259816 0.00604325 0 0.348136 -0.0270394 0 + 0.13951 0.0146766 0 0.359957 0.137345 0 0.0315694 0.0679946 0 0.0121578 -0.00185935 0 + 0.162362 0.0172331 0 0.292325 -0.196187 0 0.205334 -0.0683855 0 0.106629 -0.018916 0 + 0.249749 -0.0172253 0 0.00988013 1.20723e-06 0 0.279238 -0.0181942 0 0.0381973 0.0113241 0 + 0.180089 0.0519657 0 0.272494 0.00797202 0 -0.00861946 -0.00114657 0 0.00981707 -0.00355845 0 + 0.082874 0.116217 0 0.28799 -0.195247 0 0.205101 -0.0187317 0 0.129568 -0.161959 0 + 0.270897 -0.0417263 0 0.26332 -0.000481887 0 0.356218 0.00772372 0 0.39254 -0.0432777 0 + -0.00489942 9.72712e-05 0 0.190927 0.0109488 0 0.249527 -0.0652717 0 0.0570835 0.0778021 0 + 0.121946 -0.000621113 0 0.230889 0.0150131 0 0.148717 0.0187702 0 0.282109 5.19144e-05 0 + 0.223089 -0.0514924 0 0.00764656 0.00128799 0 0.173431 -0.0332766 0 0.227042 -0.0447129 0 + 0.0756656 0.0196541 0 -0.0134895 0.00127976 0 0.3797 0.0793386 0 0.186523 -0.0230106 0 + 0.0729372 -0.107974 0 -0.00284218 -0.00688101 0 0.032303 3.97992e-05 0 -0.0126468 0.0019582 0 + -0.00375432 -0.00863201 0 -0.00294934 -0.0084093 0 0.106344 0.0207622 0 0.20455 -0.154216 0 + 0.0926403 -0.13432 0 0.383848 -0.000160144 0 0.350623 -0.091308 0 0.310825 0.118427 0 + 0.0661978 -0.000172213 0 0.240335 -0.000194983 0 -0.00159384 -0.00863214 0 0.377807 0.083728 0 + 0.381208 -0.0132735 0 0.301039 0.0297325 0 0.147833 0.0372379 0 0.281952 0.117881 0 + -0.0150046 -0.000476408 0 0.386888 0.0738505 0 0.043387 -0.0480299 0 0.19023 0.0338588 0 + 0.397812 0.049363 0 0.0757216 -0.014506 0 0.00012809 0.0030914 0 0.253088 0.00731662 0 + 0.161993 0.176829 0 0.0259995 0.00775974 0 0.0826034 -0.0244778 0 -0.00292911 -0.00896592 0 + 0.0253289 0.0053351 0 0.346851 0.0221187 0 0.330274 0.031162 0 0.015262 -0.00874095 0 + 0.290523 -7.51995e-05 0 0.289446 -5.02313e-05 0 0.36094 0.0283281 0 0.22792 0.0485683 0 + -0.002302 -0.00690512 0 0.147866 -0.0217012 0 0.344092 -0.0272278 0 0.16213 0.0358334 0 + 0.169727 0.00945522 0 0.25564 0.0370219 0 0.246617 -0.0955943 0 0.144163 0.0188573 0 + 0.277782 0.021622 0 0.14013 0.0191263 0 0.288865 0.000855899 0 0.109112 -0.017182 0 + 0.222908 -0.10208 0 0.217652 -0.0399809 0 0.221032 0.00261406 0 0.205255 0.0301483 0 + 0.166653 -0.019884 0 0.0261607 0.008611 0 0.384529 0.0230774 0 0.188288 -0.0390741 0 + 0.129374 0.115601 0 0.302158 0.0188067 0 0.0793654 -0.0155654 0 0.0709548 0.0243261 0 + 0.20092 0.0438736 0 0.0239444 -0.000515173 0 -0.00406105 -0.00650271 0 0.0412456 -0.054351 0 + 0.265241 0.0234321 0 0.316154 0.0376288 0 0.269264 -0.0307628 0 -0.00432861 0.00911764 0 + 0.229311 0.0448602 0 0.330599 0.0212851 0 0.0129841 -0.00485181 0 0.257545 0.0236866 0 + 0.365992 -0.083855 0 0.0174231 0.00612429 0 0.391967 0.0424014 0 0.364316 0.0226594 0 + 0.291481 -0.0281535 0 0.0154365 0.0053678 0 0.0971218 -0.0114975 0 0.352803 0.0360041 0 + 0.263357 0.0753289 0 0.258568 0.0093138 0 0.185749 -0.0537062 0 0.181333 0.14492 0 + 0.270847 -0.0291891 0 0.35013 0.0110385 0 0.131179 -0.0149598 0 0.170692 -0.0139857 0 + 0.237317 0.188648 0 0.277893 0.0182138 0 0.208388 0.0273133 0 0.108689 0.00251541 0 + 0.230522 -0.0854771 0 0.265471 -0.0204114 0 0.18031 0.014154 0 0.197909 -0.00557509 0 + 0.318644 0.0688675 0 0.058132 0.00641914 0 0.106115 0.00152813 0 0.227932 -0.153545 0 + 0.35857 -0.0412623 0 0.271711 0.107683 0 0.159069 -0.169446 0 -0.00232005 0.00587695 0 + 0.195008 -0.156272 0 0.261921 0.0108472 0 0.322492 0.0248216 0 0.0745307 0.000187534 0 + 0.284917 -0.011303 0 -0.00889021 0.00375263 0 0.00333513 0.00206649 0 0.267547 -0.0314947 0 + 0.000229483 0.000723922 0 0.317249 0.01641 0 -0.00197357 0.00657144 0 0.297134 -0.00699629 0 + 0.0867874 0.000781072 0 -0.00449563 -0.00395102 0 -0.00466543 -0.00681017 0 0.243723 -0.0163567 0 + 0.184558 -0.0106545 0 0.322001 0.0388517 0 0.0867487 -0.00408293 0 0.258211 -0.0123231 0 + 0.284117 -0.00902709 0 0.280091 -0.0618541 0 -0.0118815 -0.000888684 0 0.262321 -0.00685501 0 + -0.00663004 -0.00631562 0 0.287888 -0.005005 0 0.135764 -0.0310215 0 0.306647 -0.191858 0 + 0.164279 -0.0227794 0 0.0246311 0.0057071 0 0.305126 0.0335613 0 0.311317 0.0305679 0 + 0.0815776 0.12433 0 0.244359 0.00606319 0 0.300867 -0.0265924 0 0.0886427 0.00158028 0 + 0.358784 0.0172995 0 0.319485 0.0573899 0 0.316717 0.0263996 0 0.00465566 -0.00604328 0 + 0.332223 0.0654028 0 0.323525 -0.182929 0 0.264477 0.00201445 0 -0.00505122 0.00458913 0 + 0.222266 0.0390556 0 0.230225 0.00315382 0 0.0302319 -0.0115186 0 0.273669 0.0889946 0 + 0.356936 0.0336079 0 0.224591 -0.00742678 0 0.258976 0.0892682 0 0.294258 -0.00199757 0 + -0.0133217 -0.000880147 0 0.246323 0.0255669 0 0.154783 -0.0313784 0 0.297454 -0.0013281 0 + 0.340164 0.0262424 0 0.329739 0.0450635 0 0.353301 -0.127665 0 0.147282 0.00391847 0 + 0.30187 0.0232406 0 0.0883245 0.0171391 0 0.378562 -0.0736799 0 0.26125 0.107411 0 + 0.371064 -0.00574185 0 -0.00423712 0.00301119 0 0.292609 -0.024111 0 0.385594 0.0116928 0 + 0.22062 -0.00384941 0 0.0810997 -0.103407 0 0.379094 0.0250121 0 0.25584 0.00850329 0 + 0.337022 -0.0335256 0 0.260502 -0.0214294 0 0.27702 0.19832 0 0.261132 0.0170107 0 + 0.361148 0.0207996 0 0.235377 0.0414582 0 0.034847 -0.0100863 0 0.279125 -0.0139593 0 + 0.000877481 -0.00764258 0 -0.00725642 -0.0016869 0 0.243265 -0.0671768 0 0.0251229 -0.0123811 0 + 0.261657 0.0404579 0 0.320407 0.0282367 0 0.269076 0.0417392 0 0.235843 -0.0752018 0 + -0.00828701 -0.00550806 0 0.340228 -0.0333184 0 0.355332 -0.108439 0 0.285274 -0.0115898 0 + 0.24676 -0.0216139 0 -0.00354925 -0.00853211 0 0.0427564 -0.000637292 0 0.361909 -0.0380342 0 + 0.325084 -0.0103629 0 0.000624142 -0.00650416 0 0.21448 -0.00201116 0 0.123315 -0.106143 0 + 0.169491 0.0180482 0 0.0245159 0.000529602 0 0.361723 0.0867754 0 0.229857 -0.18133 0 + -0.0074018 -0.00619483 0 0.241104 -0.046876 0 0.0930175 -0.0152524 0 0.00231655 0.00296223 0 + 0.183423 -0.00955447 0 -0.00306014 -0.00755578 0 0.267024 -0.035451 0 0.35999 0.0245279 0 + 0.25859 -0.0561614 0 0.260698 -0.0490679 0 0.263602 -0.0421031 0 0.251756 -0.0324642 0 + 0.207381 0.0337964 0 0.24164 0.0584222 0 0.111624 0.100627 0 0.0389371 7.90353e-06 0 + 0.363085 0.159419 0 0.262365 -0.00203636 0 0.115557 0.100439 0 0.35044 0.0132567 0 + 0.180145 -0.0256025 0 0.048539 0.00202629 0 -0.00269011 0.00627657 0 0.292491 -0.00377032 0 + 0.255916 0.0600151 0 0.262161 -0.0127579 0 0.288691 -0.000987286 0 0.225993 0.0360283 0 + 0.101693 -0.00162534 0 0.292437 0.0384775 0 0.235696 -0.0588673 0 0.0338779 -2.11689e-06 0 + 0.3656 0.156961 0 0.205502 0.0300923 0 0.301317 0.0447173 0 0.275836 0.0244279 0 + 0.106531 -0.028868 0 0.194962 0.157476 0 -0.0130081 0.00119323 0 0.368711 0.016345 0 + 0.082452 -0.00116059 0 0.0926186 0.00126137 0 0.263813 0.0475482 0 0.0670522 0.0114119 0 + 0.259521 0.000754736 0 -0.00536078 -0.000197882 0 0.28485 -0.0335524 0 0.230652 -0.117308 0 + 0.328922 -0.0730263 0 0.343545 0.143814 0 0.237589 -0.0508899 0 0.0914013 -0.0173275 0 + 0.384571 0.0173732 0 0.124526 0.129408 0 0.245888 -0.0615317 0 0.12316 -0.0203828 0 + 0.348543 0.00446256 0 0.154179 -0.0134331 0 0.356685 0.0440767 0 0.0214096 -0.0076573 0 + 0.272327 0.0361906 0 0.235746 -0.0404149 0 0.0820405 0.00025539 0 0.0366381 0.0134354 0 + 0.269595 0.0193886 0 0.159041 -0.0137403 0 0.21976 -0.0416088 0 0.348392 0.00646913 0 + 0.0862047 0.021852 0 0.273154 3.13612e-05 0 0.263989 0.0779185 0 0.260679 0.064569 0 + 0.294656 -0.00018153 0 0.166778 -0.0408965 0 0.325687 0.0334884 0 0.0229701 0.000209903 0 + 0.254391 -0.0764647 0 0.13994 -0.0122486 0 0.269854 -0.0835682 0 0.297886 -0.0272183 0 + 0.010147 -0.00014079 0 0.103612 0.0836013 0 0.387311 -0.0614188 0 0.270025 -0.00654782 0 + 0.0262785 0.000219327 0 0.249228 0.0717274 0 0.148224 0.125873 0 0.347649 -0.1102 0 + 0.0858554 -0.000229124 0 0.0526834 0.00024811 0 0.192735 0.0621416 0 0.240042 0.180477 0 + 0.358781 0.0263443 0 0.263599 0.0684964 0 0.261187 0.0212681 0 0.237823 0.00431724 0 + 0.354409 0.00263607 0 0.252439 0.0527981 0 0.35222 0.0350113 0 0.21588 -0.0496617 0 + 0.177182 -0.0412363 0 0.221198 0.18037 0 0.291449 -0.00541727 0 0.259273 -0.00929018 0 + 0.0826994 0.0261024 0 0.385457 0.00575123 0 0.220622 0.0352213 0 0.0269649 -0.000201226 0 + 0.301458 0.0319513 0 -0.00395338 -0.00744937 0 0.279076 -0.0158291 0 0.265539 0.0385426 0 + 0.321818 -0.0969218 0 0.200979 0.0332588 0 0.248046 -0.0303604 0 0.350122 0.0381833 0 + 0.34744 0.0992314 0 0.116984 -0.0858807 0 0.251433 0.015779 0 0.294813 -0.000458306 0 + 0.0355498 0.00787329 0 0.244568 -0.0580053 0 0.265808 0.0376751 0 0.391552 -0.0478036 0 + 0.261116 -0.000908184 0 0.0229644 0.00610954 0 0.198073 -0.0359613 0 0.273619 -0.0412762 0 + 0.134365 0.0777936 0 -0.00541168 0.00809049 0 0.0205051 0.000210556 0 0.0689815 -0.0863867 0 + 0.260713 -0.00967694 0 0.331945 0.0246717 0 0.34458 0.0407181 0 0.267299 -0.00181516 0 + 0.162637 -0.0485245 0 0.252743 -0.0805522 0 0.234235 -0.0595194 0 0.345605 0.0139987 0 + 0.175544 -0.0572494 0 0.345166 0.0405126 0 0.0937671 0.065545 0 0.146838 -0.0217104 0 + 0.265144 0.00193339 0 0.163504 0.078655 0 0.338842 -0.0957437 0 0.290387 0.116672 0 + 0.229316 0.0163453 0 0.258829 0.03619 0 0.249934 -0.0728279 0 0.0154056 0.00233775 0 + 0.0300858 1.73477e-05 0 0.0689064 -0.0743238 0 -0.0141475 -0.000452763 0 0.0304297 -0.0063279 0 + 0.0159521 0.00958278 0 0.147419 -0.105691 0 -0.00368013 0.00866925 0 0.185506 0.036672 0 + 0.059183 0.102759 0 0.227493 -0.198427 0 0.342804 0.0381924 0 0.348805 -0.122529 0 + 0.276186 0.00604437 0 0.269272 -0.027311 0 0.0148023 -0.00352446 0 0.135582 -0.0122234 0 + 0.258019 -0.000470923 0 0.0579806 -0.00260356 0 0.0335302 0.0153433 0 0.224365 -0.0536235 0 + 0.153188 -0.0155158 0 0.254588 -0.0782041 0 0.381056 -0.00564494 0 0.341423 0.034712 0 + 0.356959 0.0169651 0 0.355907 0.160169 0 0.219793 0.0145577 0 0.0942036 -0.00212125 0 + -0.00190158 0.00721993 0 0.266177 -0.00972616 0 0.143469 0.000521693 0 0.290696 -0.0029796 0 + 0.221642 0.0163593 0 0.203495 0.0388117 0 0.220666 -0.0866072 0 0.0924481 9.21071e-05 0 + 0.0478248 0.0103071 0 0.0277743 0.0456035 0 0.240956 0.00604105 0 0.216298 0.174706 0 + 0.254916 0.0269417 0 0.38766 -0.0207299 0 0.241995 -0.0504889 0 0.289313 -5.10338e-05 0 + 0.0343505 -1.79865e-05 0 0.377213 -0.0108692 0 0.0987523 -0.0194758 0 0.292459 0.00292909 0 + 0.248159 -0.052604 0 0.270076 -0.00972632 0 0.0271003 0.00753914 0 0.273114 0.0347897 0 + 0.182119 0.0364883 0 0.189773 0.0298707 0 0.274226 -0.00155596 0 0.224429 0.185465 0 + 0.327088 0.0399568 0 0.236553 -0.0438264 0 0.246599 -0.193986 0 0.018265 0.00539383 0 + 0.319049 -0.00653698 0 0.269646 0.0299812 0 0.0678467 0.0134947 0 0.0218529 -7.9973e-05 0 + 0.224983 -0.0335307 0 0.228749 -0.0393279 0 0.0899289 0.000308189 0 0.337568 -0.16021 0 + 0.241197 0.185663 0 -0.00194897 -0.00847034 0 0.19096 -0.0364593 0 -0.00364463 -0.00759793 0 + 0.352549 0.0260508 0 0.0994573 -0.00176864 0 0.248929 0.0398385 0 0.0476695 0.0130886 0 + 0.15437 -0.0269445 0 0.267396 -0.0280001 0 0.287114 0.0361384 0 0.220389 -0.0355056 0 + 0.0253319 0.000189593 0 0.212876 0.195979 0 0.15469 0.0216133 0 0.263084 -0.00112445 0 + 0.111053 0.0189354 0 0.256518 0.0378441 0 0.267204 -0.0318971 0 0.260796 -0.00200567 0 + 0.257243 -0.0635122 0 0.257403 -0.0336925 0 0.298955 0.163879 0 0.293833 -0.000468563 0 + 0.32492 0.0419583 0 0.332933 0.0284777 0 0.296388 -0.0256078 0 -0.0119994 -0.00146361 0 + 0.29914 -0.000126747 0 0.17649 -0.0731775 0 0.258202 0.00915527 0 0.17621 0.00226264 0 + 0.0699595 -0.000144671 0 0.278916 0.011093 0 0.0712188 -0.022812 0 0.117531 -0.00321798 0 + 0.0482644 0.000847978 0 0.391587 -0.0338439 0 0.259371 0.0257249 0 0.045567 6.10881e-05 0 + 0.249038 0.0459195 0 0.291112 -0.000702781 0 0.3096 0.0363321 0 0.197769 0.0432627 0 + 0.276861 0.000295433 0 0.194724 -0.00522463 0 0.278276 -2.4012e-05 0 0.284506 -0.0131075 0 + -0.00138227 -0.00714609 0 -0.0024323 -0.0069444 0 -0.00257119 0.0047719 0 0.238858 0.13713 0 + 0.256773 -0.0708382 0 0.19154 0.0776813 0 0.332611 -0.0508872 0 0.257247 -0.0780685 0 + 0.194911 0.0296269 0 0.142009 0.0270141 0 0.33045 0.0387479 0 0.0972298 -0.139255 0 + 0.394173 0.0615992 0 0.0850751 -0.00356943 0 0.270314 -0.00402856 0 0.0226029 0.0313389 0 + 0.00112114 -0.00159373 0 0.255202 -0.0232769 0 0.323965 -0.00202804 0 0.354418 0.0344093 0 + 0.0661846 0.0149578 0 0.248122 -0.0351856 0 0.0347524 -3.97497e-05 0 0.1071 0.0895853 0 + 0.285721 -0.0401839 0 0.252878 -0.0761811 0 0.268656 -0.0102591 0 0.268702 0.0376674 0 + -0.0051932 0.00406891 0 0.319063 -0.0427708 0 0.325379 0.0375955 0 0.267118 0.0200841 0 + 0.296964 -0.0404928 0 0.317236 -0.0572678 0 0.104937 -0.0361173 0 0.265161 0.059043 0 + -0.0125187 0.000742737 0 0.258646 0.0697385 0 0.0863383 0.0466178 0 0.284019 0.0371058 0 + 0.054759 0.0166908 0 0.272507 0.0375435 0 0.258276 0.0496709 0 0.00502771 -0.00284291 0 + 0.180898 0.0236244 0 0.299625 0.109802 0 0.0519661 2.18586e-05 0 0.0792332 -0.0138641 0 + 0.27782 -0.00104909 0 0.230522 -0.0374997 0 0.0484271 0.019919 0 0.325097 -0.0115252 0 + 0.205452 0.0294699 0 0.268885 -0.00396672 0 0.175033 0.0163528 0 0.345959 -0.0431413 0 + 0.30074 -0.0262234 0 0.225946 0.00569262 0 0.258746 -0.0850122 0 0.287592 -0.00914049 0 + 0.266212 0.080326 0 0.050379 -0.0187383 0 0.136995 -0.00233048 0 0.286618 0.0155114 0 + 0.319594 0.0363482 0 0.130107 0.0327755 0 0.358005 -0.0286469 0 0.291038 -0.00155774 0 + 0.153284 -0.0232353 0 0.288264 0.0270796 0 0.141835 -0.000512795 0 0.314718 -0.0186039 0 + 0.256975 -0.016266 0 0.151323 -0.0579492 0 0.00138752 -0.00721727 0 0.283434 -0.0210634 0 + 0.225963 0.0507711 0 0.38265 -0.00312194 0 0.198426 0.0376079 0 0.288578 -0.000989827 0 + 0.29811 0.00110447 0 0.294258 0.0296933 0 0.0396846 -0.00990945 0 0.0883996 -0.0234639 0 + 0.27983 0.00572822 0 0.386084 -0.107525 0 0.28102 0.0152512 0 0.189303 0.0307967 0 + 0.00852914 -0.000240993 0 0.0572645 6.71225e-05 0 0.311568 -0.0435648 0 0.223783 -0.0532306 0 + -0.00251162 0.00756091 0 0.0701616 -0.01443 0 0.227793 0.198218 0 -0.00225836 -0.00791166 0 + 0.329919 -0.0170085 0 -0.00572081 0.0059911 0 0.158244 -0.0189741 0 0.0813116 6.74926e-05 0 + 0.285728 0.0148313 0 0.0868572 0.0208551 0 0.292579 0.0480407 0 0.246552 -0.0702712 0 + 0.0799343 -0.0242384 0 0.299532 6.117e-05 0 0.285343 0.00225986 0 0.0391969 -0.000807758 0 + 0.35497 0.0355228 0 0.331848 0.145619 0 -0.00125076 0.00361941 0 0.237414 -0.05433 0 + 0.322131 -0.0429173 0 0.208465 0.0343725 0 0.0400532 0.00651242 0 0.0353077 -0.00090029 0 + 0.177209 0.0265403 0 0.277721 -0.0440263 0 0.385797 0.0207405 0 0.129781 -0.00615832 0 + 0.357169 0.105226 0 0.101434 -0.137888 0 0.350895 -0.0475748 0 0.265462 -0.00108061 0 + 0.206215 -0.028178 0 0.0392835 0.00827809 0 0.234933 -0.0881981 0 0.235438 -0.00140937 0 + 0.254784 -0.00505171 0 0.13384 0.0160813 0 0.106944 -0.0148562 0 0.355913 0.0226881 0 + 0.0501562 0.000183745 0 0.278119 0.002587 0 0.366222 -0.02046 0 0.275693 -0.062903 0 + 0.310679 -0.0208693 0 0.386953 0.00898321 0 0.369272 -0.113464 0 0.220062 -0.0131435 0 + 0.270542 0.0379807 0 0.199082 0.0379647 0 0.259232 0.0949749 0 0.0339174 -0.0147685 0 + 0.328483 -0.0205607 0 0.2287 0.00932282 0 0.0324323 -0.000676796 0 0.211275 0.14814 0 + 0.264098 0.0727282 0 0.280082 -0.0134923 0 0.263708 -0.00706996 0 0.0211214 -0.0103286 0 + 0.229204 -0.110154 0 0.0392042 -0.0162087 0 0.351071 0.00980974 0 0.236774 0.0377663 0 + 0.333708 -0.00537305 0 0.245327 -0.00314694 0 0.179761 -0.0882203 0 0.0823697 -6.84588e-05 0 + 0.0594499 -6.83645e-05 0 0.193452 0.0485261 0 0.343163 0.0406216 0 -0.00262966 0.00614505 0 + 0.272515 0.000312991 0 0.32979 -0.107027 0 0.327963 -0.0812558 0 0.324283 0.0270759 0 + 0.237348 -0.062544 0 0.111494 0.0244152 0 0.289646 -0.0316545 0 0.0289865 -0.0118036 0 + 0.267351 0.00168301 0 -0.00255849 0.00901465 0 0.00784391 -0.00761374 0 0.221996 0.0151678 0 + -0.00423308 -0.0053248 0 0.306024 -0.0181885 0 0.318155 -0.0242985 0 0.089711 0.0284105 0 + 0.35234 0.0369161 0 0.0300516 -0.000655694 0 0.225913 0.0459249 0 0.33848 -0.0163677 0 + 0.191502 0.0249137 0 0.163516 0.0948418 0 0.132113 -0.0090637 0 0.36525 -0.0980146 0 + 0.0584728 0.00302111 0 0.0694146 -0.00460963 0 0.130105 -0.0301758 0 0.047012 0.000381163 0 + 0.24852 0.00300428 0 0.0104469 -0.0033121 0 0.19145 -0.0285587 0 0.307754 0.0733317 0 + -0.0128893 0.002247 0 0.00356258 -0.00646072 0 0.247721 -0.0488642 0 0.253676 0.00750304 0 + 0.201284 0.0249719 0 0.0406115 0.000456901 0 0.302554 0.0341647 0 -0.0109898 -0.00194954 0 + 0.230462 0.0206025 0 0.264167 0.0784309 0 -0.0012235 0.000241392 0 0.288652 -0.00894648 0 + 0.264096 0.0785827 0 0.336412 0.0243767 0 0.26362 -0.00970038 0 0.343729 0.0109276 0 + 0.0898193 0.0283196 0 0.302194 -0.0252452 0 0.121971 0.00417789 0 0.185976 -0.00380405 0 + 0.242123 -0.0647534 0 0.0037137 -0.00629927 0 0.11344 0.0188296 0 0.3368 0.0430737 0 + 0.227729 -0.194421 0 0.266993 -0.01368 0 0.257981 -0.00384877 0 0.354463 0.115428 0 + 0.0671932 0.0137449 0 -0.00376427 -0.00573639 0 0.0473642 0.000134456 0 0.196352 -0.033225 0 + 0.039354 0.000727107 0 0.0388105 0.000160407 0 0.309936 0.06656 0 0.114623 -0.152707 0 + 0.277916 0.023345 0 0.316033 0.107379 0 0.254965 -0.0296552 0 0.0190183 0.0181997 0 + 0.341591 0.00974527 0 0.0466967 3.66779e-05 0 0.249509 0.0104682 0 0.348289 0.0387147 0 + 0.233648 -0.0652321 0 0.352397 0.012877 0 0.14518 0.0345638 0 0.26409 0.0774187 0 + 0.199386 -0.169042 0 0.261254 -0.194834 0 0.319513 0.0465631 0 0.186444 -0.0193138 0 + 0.0665914 0.0144637 0 0.29561 -0.000197978 0 0.212576 -0.0474036 0 0.260928 -0.00435808 0 + 0.277492 -0.0133149 0 0.335288 0.100195 0 0.258504 0.0541732 0 0.217024 0.0378793 0 + 0.184593 0.00271051 0 0.324659 0.15099 0 0.255568 -0.00751682 0 0.158388 0.0261841 0 + 0.346711 0.030743 0 0.0325251 0.000581536 0 0.175029 0.0291641 0 0.0435614 -0.00180073 0 + 0.260746 0.0528059 0 0.00121271 -0.00166475 0 0.221037 0.0126157 0 0.0790243 0.000431474 0 + 0.0878183 -0.0578063 0 0.220679 0.0253928 0 0.074653 0.000204814 0 0.286483 -0.000540124 0 + 0.149171 -0.00654879 0 0.0819863 -0.000948187 0 0.0961524 0.0109751 0 0.277207 -0.00123423 0 + 0.212461 -0.040431 0 0.232571 0.0546574 0 0.0302248 0.00973719 0 0.00777588 0.000613275 0 + 0.109938 0.00224809 0 0.337904 -0.0343981 0 0.260105 -0.120741 0 0.292006 -0.0230631 0 + 0.265033 0.0739295 0 0.0161867 0.00427604 0 0.35097 0.0963716 0 0.273045 -0.0120208 0 + 0.350684 0.0881203 0 0.251065 -0.00493592 0 0.0930922 -0.0171258 0 -0.0152725 1.82481e-05 0 + 0.340475 0.105254 0 0.280757 -0.0158636 0 0.371132 0.0833987 0 0.343026 0.132094 0 + 0.381288 -0.115967 0 0.357082 0.0377729 0 0.248777 0.0490605 0 0.296397 0.0299268 0 + 0.322773 0.0448323 0 -0.0036084 0.00296356 0 -5.53545e-06 -0.0022675 0 0.193649 -0.014506 0 + 0.172102 -0.0373811 0 0.0438299 -0.000195103 0 0.265694 -0.00340746 0 0.26408 -0.00263549 0 + 0.272991 0.0814216 0 0.110685 -0.000317167 0 -0.00348232 0.0010385 0 0.240689 0.0418886 0 + 0.262998 -0.000882543 0 0.102334 0.0306538 0 0.214674 0.0112347 0 0.0813695 0.0271901 0 + 0.0686522 0.0145716 0 0.124805 0.134472 0 0.194848 0.00326837 0 0.0559891 -0.0130402 0 + 0.247943 -0.0398802 0 0.243116 -0.136107 0 0.345354 -0.0315831 0 0.060375 0.00215765 0 + 0.23748 -0.0468575 0 -0.00243639 0.000966838 0 0.206864 -0.0392104 0 0.00494409 -0.00324409 0 + 0.234164 0.0285703 0 0.159388 0.0845326 0 0.283097 -0.197923 0 0.138768 -0.0185237 0 + -0.00806987 -0.00238924 0 0.323005 0.027947 0 0.0314969 0.0102867 0 0.184264 -0.102993 0 + 0.353165 0.0219231 0 0.209157 0.136192 0 0.136552 -0.0307491 0 0.24664 0.0354943 0 + 0.265033 0.0792528 0 0.176299 0.0275563 0 0.315824 -0.0672679 0 0.0439217 -0.000339168 0 + 0.0646386 0.018389 0 0.260185 0.0251558 0 0.289911 -5.9256e-05 0 0.288775 -3.73319e-05 0 + -0.00460085 0.0075453 0 0.0942863 -0.024175 0 0.259547 0.0675396 0 0.0848197 0.000188022 0 + 0.259752 -0.0039081 0 0.0862307 0.0164274 0 0.161718 -0.0242833 0 0.190846 0.0238168 0 + 0.271165 0.0437597 0 0.187122 0.0375954 0 0.261285 -0.0915589 0 0.0368131 0.000351523 0 + 0.359048 0.00483131 0 0.0601014 4.57577e-05 0 0.237417 0.0442992 0 0.000637138 -0.0012667 0 + 0.326322 0.0162543 0 0.340407 0.0299649 0 0.0844281 -0.117301 0 0.0297492 0.00335824 0 + 0.306676 0.0410775 0 0.252507 0.0560369 0 0.109161 -0.0035275 0 0.105504 -0.000291761 0 + 0.256396 0.0633283 0 0.30665 0.0337989 0 0.240254 -0.0196603 0 0.156695 0.028343 0 + -0.00769715 -0.000394868 0 0.306925 0.047625 0 0.252508 0.0358787 0 0.319544 -0.152159 0 + 0.000124252 0.00525001 0 0.178878 -0.0129183 0 0.150245 0.0368699 0 0.347189 -0.0334541 0 + 0.351403 0.125938 0 0.0614382 0.0129734 0 0.267125 0.0218568 0 0.229825 -0.0342864 0 + 0.0442048 -0.0112228 0 0.174613 0.0282961 0 0.0360165 0.0612941 0 0.216011 -0.175551 0 + 0.126135 -0.0202796 0 0.219754 -0.154653 0 0.221423 -0.037802 0 0.316381 0.155192 0 + 0.272348 -0.066586 0 0.205516 0.0045597 0 0.0294156 0.000309225 0 0.275272 0.037959 0 + 0.179505 0.0368293 0 0.374492 0.0134569 0 0.0718678 0.00035308 0 0.191451 -0.0059294 0 + 0.389478 -0.100077 0 0.270674 -0.00374592 0 0.247463 0.0174556 0 0.259364 0.0119859 0 + 0.245443 0.0116153 0 0.266288 0.0812311 0 0.347304 -0.0581075 0 0.189967 -0.0224715 0 + 0.313612 0.0438793 0 0.198142 0.0291135 0 0.325987 0.0606515 0 0.0281524 0.000260958 0 + 0.166893 0.0051608 0 0.348232 -0.036342 0 0.352771 -0.0148541 0 0.0461139 0.000287667 0 + 0.347335 -0.0115153 0 0.0393202 -0.00741316 0 0.0983073 -0.0140755 0 0.282417 -0.0939338 0 + 0.0664106 -0.000153148 0 0.321924 0.0506174 0 0.21414 0.108292 0 0.279655 0.0213619 0 + 0.259257 -0.00275583 0 0.260454 0.070946 0 0.0029041 0.00542654 0 0.355534 0.0345433 0 + 0.0681972 0.00938453 0 0.0853669 -0.108574 0 -0.0144976 0.00104804 0 0.254276 0.00671528 0 + 0.327328 0.111159 0 0.175249 0.00143725 0 0.348384 -0.0357728 0 0.190151 -0.00208476 0 + 0.283143 0.0166994 0 0.264688 -0.0972643 0 0.34699 0.0019026 0 0.265879 0.0362703 0 + 0.347339 -0.0342941 0 0.115733 0.00388166 0 0.0515245 0.0107354 0 0.267278 -0.0018197 0 + 0.264838 -0.00884778 0 0.238273 0.0107051 0 0.0981041 0.0236186 0 0.0944711 -0.0266364 0 + 0.314369 -0.0303118 0 0.099436 0.00889908 0 -0.00395829 0.00942969 0 0.0283147 -0.00148202 0 + 0.258154 0.0605663 0 0.00584908 0.00524955 0 0.264062 0.00132351 0 0.259583 0.00143598 0 + 0.114144 -0.000389256 0 0.161396 0.155415 0 0.324005 -0.111983 0 0.160428 -0.0161909 0 + 0.0736532 -0.000205654 0 0.0727397 0.000492226 0 0.291776 0.0424894 0 0.239045 -0.0293696 0 + 0.347249 0.0397735 0 0.205468 0.0194883 0 0.357749 0.0013036 0 0.259974 0.0728128 0 + 0.394167 -0.0564181 0 0.0656182 0.0152942 0 0.0194943 -2.30569e-05 0 -0.00203516 -0.000617933 0 + 0.00724892 0.00889571 0 0.0958175 -0.0056852 0 0.289958 0.0114632 0 0.356976 -0.00601401 0 + 0.265815 0.0409337 0 0.0995029 0.0223035 0 0.311814 -0.00216519 0 0.0377168 -0.00037124 0 + 0.232804 -0.0435757 0 0.302893 -0.0540961 0 0.352269 -0.00187032 0 0.372566 -0.0157482 0 + 0.296976 -0.000317171 0 0.0276117 -4.31219e-05 0 0.0406909 4.44815e-05 0 0.390291 -0.090134 0 + 0.251399 0.0244156 0 0.277332 0.0478832 0 0.256834 -0.00607484 0 0.128537 -0.142319 0 + 0.359305 -0.00962005 0 0.160342 0.039108 0 0.268967 -0.102092 0 0.267475 0.0880674 0 + 0.200721 0.0201958 0 0.0190973 1.09668e-05 0 0.362543 -0.0169529 0 0.268591 -0.00990614 0 + 0.248469 -0.0270412 0 0.299107 0.000316567 0 0.0238415 -0.000161171 0 0.216607 -0.0379447 0 + 0.347825 0.136633 0 0.288443 -0.000692198 0 0.0286865 6.54998e-05 0 0.261241 0.0471956 0 + 0.355976 -0.0892902 0 0.203275 -0.0100052 0 0.0345659 -0.00915869 0 0.147005 -0.0162918 0 + -0.000921068 -0.00806072 0 0.276071 0.0268077 0 0.27844 0.0357148 0 0.0192136 1.33496e-05 0 + 0.307311 0.0688747 0 0.241781 -0.0418792 0 0.347702 0.037807 0 -0.00258599 -0.00114165 0 + 0.263029 0.0206424 0 0.193281 0.158013 0 0.255332 0.00668237 0 0.293397 0.000712296 0 + 0.0221382 -0.000307264 0 0.356036 -0.00579921 0 0.0347213 -0.00318523 0 -0.0147581 -0.000426708 0 + 0.239298 -0.0361977 0 0.361435 -0.00752295 0 0.332545 0.0514062 0 0.00183208 -0.00706712 0 + 0.27223 -0.00721202 0 0.276751 -0.00821448 0 -0.0011102 0.00330127 0 0.348033 0.0565608 0 + 0.303447 0.0387345 0 0.103427 0.00638851 0 0.274188 -0.00104047 0 0.02516 4.98246e-06 0 + 0.281932 0.00102116 0 0.0204254 -0.000351361 0 0.282315 0.0184238 0 0.00805385 -0.00282336 0 + 0.221139 -0.041811 0 -0.0156661 0.00031278 0 0.271466 -0.0305462 0 0.355737 0.0239662 0 + 0.155178 0.074948 0 0.269101 -0.00697488 0 0.294939 0.0391988 0 0.257775 0.0392991 0 + 0.106767 0.0183953 0 0.250091 0.0244128 0 0.00559018 -0.00394836 0 0.256874 -0.0892378 0 + 0.340041 0.042168 0 -0.00306031 -0.00178283 0 -0.00422358 -0.00305333 0 0.287023 0.10667 0 + 0.0410894 -0.0142954 0 0.235317 0.00292501 0 0.211016 -0.0376243 0 0.00375445 -0.00260412 0 + 0.366767 -7.07293e-05 0 0.199877 -0.0282547 0 0.247024 0.0440543 0 0.0202021 -0.0105605 0 + 0.0266754 -0.00059507 0 0.177932 0.0241075 0 0.0517048 -0.00018178 0 0.345684 0.0398109 0 + 0.279848 0.0218916 0 0.239738 0.0370614 0 0.275422 0.000744729 0 0.273376 0.000906797 0 + 0.125071 0.0261145 0 0.00609848 -0.000544736 0 0.253537 -0.00555779 0 0.161091 0.0433804 0 + 0.266699 -0.0172914 0 0.168948 -0.016264 0 0.148127 0.0269906 0 0.139417 0.00840107 0 + 0.354324 -0.124318 0 0.285723 -0.0252942 0 0.253729 -0.00114576 0 0.0252207 0.000154332 0 + 0.0161405 -0.000258352 0 0.264906 0.00111608 0 0.233956 0.104464 0 0.0180543 0.000647743 0 + 0.0366386 -6.31201e-05 0 0.356487 0.0330444 0 0.264242 -0.0211441 0 -0.00287567 0.00486882 0 + 0.310171 -0.0402899 0 0.298649 -0.0195484 0 0.168402 0.0671488 0 0.138448 0.0254034 0 + 0.353953 0.000542432 0 0.122664 -0.0168798 0 -0.0149293 0.000831525 0 0.127725 -0.0287639 0 + -0.000134569 -0.00113515 0 0.279108 0.0262335 0 0.274127 -0.10616 0 0.237628 0.0129395 0 + 0.269433 0.0470545 0 0.184873 0.0279872 0 0.122384 -0.0161122 0 0.215112 -0.0166306 0 + 0.146288 0.0183958 0 0.141719 0.0275167 0 0.0215703 0.000128155 0 0.111465 0.0249487 0 + 0.113483 0.147839 0 0.169517 0.0211516 0 0.043238 -0.00545255 0 0.237391 -0.11796 0 + -0.00499848 0.00622765 0 0.177745 0.0250552 0 0.056965 -0.0108616 0 0.0527768 0.00982677 0 + 0.360568 0.0302597 0 0.176543 0.0251775 0 0.353654 -0.0351518 0 0.0533407 0.000328791 0 + 0.30737 0.0207931 0 0.302575 -0.0436634 0 0.228298 -0.00111896 0 0.0234239 0.000156439 0 + 0.0147757 -0.000287144 0 0.241993 0.00136227 0 0.257495 0.0160121 0 0.0241743 7.28852e-05 0 + 0.176701 0.0408974 0 0.362357 0.0145189 0 0.018623 0.000198464 0 0.0550832 -0.0176674 0 + 0.253606 0.0480627 0 0.240598 -0.000160516 0 0.0614795 -0.0135863 0 0.343036 0.0489954 0 + 0.320496 0.0341609 0 0.287309 0.0207918 0 0.0241733 3.30946e-05 0 0.261991 0.0645842 0 + 0.296845 -0.000258576 0 0.0438116 -0.000407006 0 0.276545 -0.0208878 0 0.389135 -0.0796074 0 + 0.340547 0.096746 0 0.123737 -0.0142188 0 0.0173603 0.000193478 0 0.0230303 -4.48852e-05 0 + 0.278317 0.00013263 0 0.26858 -0.0379539 0 -0.0150325 -0.000345802 0 0.274191 0.0325726 0 + 0.0995039 -0.00178143 0 0.256082 -0.0344249 0 0.0631466 3.33715e-06 0 0.332592 -0.0366457 0 + 0.287836 -0.02708 0 0.166011 0.0228703 0 0.255931 0.00671797 0 0.0896364 -0.0131068 0 + 0.277104 0.0324104 0 0.267218 0.0369729 0 0.164896 0.0241633 0 0.253746 -0.0152727 0 + 0.267674 0.019395 0 0.0760376 -0.000215971 0 0.340728 0.0423964 0 0.248103 0.0271281 0 + 0.374877 0.00633755 0 0.0928081 -0.126572 0 0.249822 0.0397011 0 0.217323 0.00859833 0 + 0.287943 -0.0776251 0 0.282982 -0.0197074 0 0.0211311 0.000168791 0 0.267248 0.195136 0 + 0.187822 0.0267135 0 0.299139 0.0294704 0 0.0250983 0.000528858 0 0.101536 0.0305692 0 + 0.253003 0.016232 0 0.280116 0.0481091 0 0.239162 -0.0364287 0 0.223331 0.191003 0 + 0.18344 -0.010383 0 -0.0124577 0.00179215 0 0.204963 0.192115 0 0.228875 0.00739946 0 + 0.00409547 -0.00606944 0 0.127805 0.0328883 0 0.0170563 0.000319638 0 0.0225768 -4.70658e-05 0 + 0.375177 -0.123901 0 0.245198 -0.0683938 0 0.21873 -0.0318925 0 0.368941 0.142671 0 + 0.294088 -0.194822 0 0.0656786 0.0237343 0 0.233383 0.0440635 0 0.0920087 -0.00203643 0 + 0.304785 0.00473113 0 0.354739 0.0335912 0 0.082729 -0.00755869 0 0.180907 0.0170382 0 + 0.0451585 -0.000479534 0 0.117182 -0.0111152 0 0.246116 0.00654597 0 0.141599 -0.019661 0 + 0.2796 0.0332714 0 0.129157 0.0350004 0 0.267817 -0.00158503 0 0.201761 0.0410818 0 + 0.181581 0.0199132 0 0.0694076 -0.0183722 0 0.357031 -0.0325375 0 0.279818 -0.109093 0 + 0.0382054 0.000243875 0 0.173882 -0.0164576 0 0.217706 0.0287354 0 0.0742869 -0.00371345 0 + 0.227865 -0.0551482 0 0.164408 0.0245382 0 0.370565 -0.0808837 0 0.301216 0.0240649 0 + 0.211484 -0.189985 0 0.0446437 -0.00396873 0 0.234344 -0.0114248 0 0.0155193 -0.00189494 0 + 0.0129354 0.000184875 0 0.0222361 -0.000143126 0 0.257979 0.00845063 0 0.29291 0.0474245 0 + 0.251261 -0.0737882 0 0.0188852 8.98423e-05 0 0.240511 -0.056523 0 0.277889 0.0391081 0 + 0.300691 -0.0439638 0 0.0202115 1.59348e-05 0 0.0194801 9.13156e-06 0 0.368013 0.0202863 0 + 0.251454 -0.0155784 0 0.198486 -0.00835341 0 0.283218 0.107357 0 0.170765 0.0491614 0 + 0.240104 -0.0367267 0 0.342735 0.0358408 0 0.057077 -0.0166037 0 -0.00773907 0.00323144 0 + 0.187986 0.0139874 0 0.266698 0.0472321 0 0.0678752 -0.00015636 0 -0.000624827 -0.00766176 0 + 0.245651 -0.010452 0 0.19315 -0.0888391 0 -0.00238179 0.00914019 0 0.256219 0.0872059 0 + 0.269329 0.0212314 0 0.298416 0.0662109 0 0.256082 0.00658051 0 0.0924069 -0.00905512 0 + 0.134128 -0.0330141 0 0.108546 0.00340631 0 0.240455 -0.0545218 0 0.197739 0.00779317 0 + 0.216999 -0.0492863 0 0.0327887 -0.000321344 0 0.151708 0.00126867 0 0.0248462 -0.000161296 0 + 0.177899 -0.0339562 0 0.221962 0.0100348 0 0.214112 -0.113756 0 0.232057 0.0125456 0 + 0.0856248 0.0013859 0 0.308529 -0.0372029 0 0.262902 0.00241064 0 0.021356 -0.000146218 0 + 0.0266914 -0.00697331 0 0.249162 0.0142515 0 0.289728 -0.0421214 0 -0.00885449 0.00250141 0 + 0.198802 0.0116956 0 0.231979 0.0117715 0 0.0622747 0.0145276 0 0.266771 0.079085 0 + 0.047418 0.000808574 0 0.354307 0.134072 0 0.205432 -0.00244362 0 0.236713 -0.0604148 0 + 0.0866053 -0.0219671 0 -0.00822076 0.00448595 0 -0.00553713 0.00237994 0 0.181065 0.183093 0 + 0.245003 -0.00685066 0 0.224198 -0.0393012 0 0.0182209 0.000145703 0 0.0126232 -0.00683533 0 + 0.310787 -0.18111 0 0.0593523 -0.00544418 0 0.068139 -0.000105083 0 0.317529 0.10102 0 + 0.3718 0.00433178 0 0.386092 -0.0685948 0 0.105947 -0.0254649 0 0.280116 -0.0179322 0 + 0.0692958 0.00021473 0 0.00727897 0.00181857 0 0.326589 -0.0159127 0 0.343043 0.150202 0 + -0.00388275 0.00327354 0 0.250957 0.00709989 0 0.234637 -0.0170067 0 0.236465 0.0184032 0 + 0.0340335 -0.000314671 0 0.288116 0.0482453 0 0.00269066 0.0069098 0 0.22705 -0.0462218 0 + 0.0536192 -0.0123848 0 0.363364 -0.0204647 0 0.249812 0.0386566 0 0.00262588 0.0075188 0 + 0.0227628 -0.000479784 0 0.0198661 -6.62678e-05 0 0.352729 -0.0356132 0 -0.00526843 0.0013019 0 + 0.146583 -0.167432 0 0.266377 -0.0102651 0 0.244418 0.0459893 0 0.396972 0.0503655 0 + 0.268918 0.00146536 0 0.162425 0.0177201 0 0.0787766 0.0074972 0 0.38215 0.0133391 0 + 0.352464 0.045716 0 0.290756 0.026056 0 0.100485 -0.00641723 0 0.0449334 -0.0133741 0 + 0.0935741 0.0127021 0 0.0190913 -0.000136939 0 0.264428 -0.0177822 0 0.195477 0.0424101 0 + 0.148408 -0.02094 0 -0.00161467 -0.00448319 0 -0.0135186 -0.000702792 0 0.00233832 0.00418589 0 + 0.0452911 -0.0149339 0 0.285216 -0.0232438 0 0.090973 0.133689 0 0.279005 0.000453042 0 + 0.30456 0.0344907 0 0.247345 -0.145553 0 0.33588 -0.0408445 0 0.253878 0.0299647 0 + 0.0780439 0.000553884 0 0.0481975 0.0129899 0 0.0542129 -0.0162574 0 0.385395 -0.0163625 0 + 0.276156 0.0824263 0 0.390593 -0.0292822 0 0.21649 -0.0131486 0 0.226164 0.0271164 0 + 0.233589 0.0366469 0 0.214142 0.029419 0 0.258697 0.00890961 0 0.381963 -0.0698714 0 + 0.0242267 -0.000130111 0 0.328362 0.0577263 0 0.149732 -0.173376 0 0.351054 0.037578 0 + 0.126636 -0.0286831 0 0.220673 0.0101425 0 0.290761 -0.00060382 0 0.0646996 -0.0928194 0 + 0.198485 0.0119389 0 0.186771 0.00275463 0 0.122754 -0.0313875 0 0.252661 0.0101464 0 + 0.377842 -0.00890031 0 0.164059 0.0159546 0 0.0152001 9.67843e-05 0 0.334593 0.039762 0 + 0.119096 -0.0121686 0 0.26702 -0.0659307 0 0.101362 -0.0104411 0 0.258272 0.0208995 0 + 0.0599715 -0.0184191 0 0.259061 0.0424215 0 0.0169396 -7.20719e-05 0 0.0627045 0.0139134 0 + 0.219803 -0.0349014 0 0.0701726 -0.0198606 0 0.236823 0.0122096 0 0.279484 0.000407539 0 + 0.377023 -0.0135408 0 0.0855811 0.0223207 0 0.148184 0.0126943 0 0.123575 0.0209132 0 + 0.0488875 -0.00180492 0 0.28742 0.0244361 0 0.157833 0.0189776 0 0.0680444 -0.0110954 0 + 0.237916 -0.0167914 0 0.307811 -0.0275576 0 0.287744 0.0122672 0 0.183476 0.00238914 0 + 0.279168 0.106838 0 -0.00626149 -0.00350508 0 0.0717527 -0.0212523 0 0.266915 -0.000881425 0 + 0.0357101 0.000877985 0 0.359714 0.0955358 0 0.253224 0.0213904 0 0.0360027 -5.10183e-05 0 + 0.272403 -0.0263385 0 0.1112 0.149593 0 0.246542 0.0675687 0 0.301414 0.0240949 0 + 0.152054 0.0156513 0 0.386309 -0.108875 0 0.364951 -0.0152552 0 0.102621 -0.0193543 0 + 0.253964 -0.000134657 0 0.233748 0.0351878 0 0.239283 0.05294 0 0.217911 0.0219025 0 + 0.332983 -0.0389364 0 0.0421118 -2.57326e-05 0 0.260671 0.00264357 0 0.251621 -0.0213763 0 + 0.164363 0.0961498 0 0.262078 0.0328069 0 0.173875 0.0172497 0 0.0135051 0.00987807 0 + 0.268302 -0.0071096 0 0.376528 0.139407 0 0.312526 -0.00475391 0 0.0292303 -0.0027551 0 + 0.0713367 -0.00266266 0 0.193064 -0.0203521 0 0.353862 -0.0304801 0 0.132436 0.163705 0 + 0.0566918 -0.00590719 0 0.321716 0.0532608 0 0.0156538 -0.000112135 0 0.00434725 0.00788038 0 + 0.245127 0.042446 0 0.230048 -0.00340706 0 0.0264441 0.000217495 0 0.00987784 -0.00392251 0 + 0.302961 0.107843 0 0.175728 0.0156996 0 0.191519 -0.0392206 0 0.266189 0.0247131 0 + 0.356111 -0.0267283 0 0.0148629 -0.00509814 0 0.208298 -0.0407207 0 0.0539368 -0.0146053 0 + 0.213482 0.00679852 0 0.224862 0.0127542 0 0.297191 0.029851 0 0.0203873 -0.00475503 0 + 0.380985 -0.0576509 0 0.311901 -0.0408305 0 0.0392487 -2.72781e-05 0 0.157827 0.00599204 0 + 0.337758 0.0431705 0 0.239338 0.0276075 0 0.0152074 -9.23565e-05 0 0.226798 -0.00678966 0 + 0.371102 -0.0192998 0 0.242812 -0.0514146 0 0.125727 -0.0112291 0 0.36003 -0.0271606 0 + 0.102496 0.0184041 0 0.0522907 0.0102726 0 0.0309919 -0.000292719 0 0.0762367 -0.00150865 0 + 0.0418822 -5.3765e-07 0 0.316099 0.0411703 0 0.0371499 0.0087826 0 0.121804 0.021073 0 + 0.17813 -0.0247402 0 0.0581733 0.000136044 0 0.239652 0.0351397 0 0.375543 -0.0147872 0 + 0.278449 0.0213458 0 0.330295 0.0395552 0 0.343527 -0.0337257 0 0.224042 0.0224701 0 + 0.00983302 0.00532295 0 0.322507 -0.0554822 0 0.282229 0.0372929 0 0.363822 -0.0114373 0 + 0.285485 -0.00199067 0 0.226149 -0.0422662 0 0.0555819 0.000122009 0 0.143806 -0.0298186 0 + 0.252553 -0.000252453 0 0.312408 -0.1894 0 0.365841 -0.0234741 0 0.329696 0.0444526 0 + 0.0623415 0.0196913 0 0.245741 -0.0202676 0 0.190219 -0.117174 0 0.116444 0.00502617 0 + 0.249236 -0.00699349 0 0.153422 0.173755 0 0.241063 0.0178141 0 0.279105 0.0163839 0 + 0.00290442 -0.00177218 0 0.0552343 -2.53708e-05 0 0.0877448 -0.00444414 0 0.183447 0.156199 0 + 0.373822 -0.0137262 0 0.135077 0.0158834 0 0.343429 0.147297 0 0.293136 -0.000420353 0 + 0.241719 -0.0430305 0 0.275119 -0.147717 0 0.126389 -0.0152517 0 0.0104822 0.00582659 0 + 0.235351 0.0376506 0 0.249807 0.0880826 0 0.229331 -0.0420943 0 0.381801 0.133892 0 + 0.183461 -0.0367209 0 0.242545 0.0183107 0 0.2783 0.00050483 0 0.0205033 0.00062514 0 + 0.389205 -0.057013 0 0.0367786 -3.66343e-06 0 0.0786984 -0.0122176 0 0.197114 -0.026397 0 + 0.273394 0.0207845 0 0.148512 -0.0316146 0 0.355296 -0.0293293 0 0.278138 -0.0315193 0 + 0.325641 0.0382165 0 0.03068 -0.000296156 0 0.28366 -0.0192185 0 0.171241 -0.0148209 0 + 0.0627345 0.000127766 0 0.356679 0.0208354 0 0.201874 0.116721 0 0.23915 -0.0261746 0 + 0.0589696 -0.0153263 0 0.311661 0.021658 0 0.18667 0.0259134 0 0.2329 -0.00357438 0 + 0.0928669 -0.00900738 0 0.158906 0.0390621 0 0.228524 -0.000852477 0 0.245264 -0.0972921 0 + 0.224292 -0.00315665 0 0.319722 -0.0271924 0 0.270928 0.00893655 0 -0.0139895 0.000219358 0 + 0.354382 -0.033195 0 0.241445 -0.0658174 0 0.081176 0.0162361 0 0.0703395 -0.0126927 0 + 0.337305 -0.0485263 0 0.349897 -0.0403569 0 0.118663 -0.0208394 0 0.38824 0.0207614 0 + 0.151916 -0.00475033 0 0.172234 -0.0288897 0 0.0371536 -0.00257526 0 0.22737 -0.0495492 0 + 0.0341741 0.0103481 0 0.00296008 0.0073718 0 0.36699 -0.00194055 0 0.212369 -0.0408634 0 + 0.285554 -0.110671 0 0.219481 -0.0291507 0 0.0652597 0.0235017 0 0.307123 0.032077 0 + 0.214701 -0.0117794 0 0.278767 0.000462761 0 0.331907 0.0446051 0 0.334131 0.115481 0 + 0.0644976 0.00337009 0 -0.00202661 0.00276739 0 0.16362 0.0251453 0 -0.0148646 0.000169534 0 + 0.15722 0.00519415 0 0.1147 -0.000103532 0 0.276673 0.0243684 0 0.285657 -0.0417728 0 + 0.0154414 -0.00261989 0 0.29276 -0.000419978 0 0.0512423 -0.00755888 0 0.101342 0.00243334 0 + 0.287433 0.02724 0 0.239208 0.0143121 0 0.381668 -0.00498152 0 0.37909 -0.010015 0 + 0.247582 0.0171976 0 0.351096 0.00139048 0 0.256199 0.0154689 0 0.0747832 -0.0190674 0 + 0.244725 -0.0314085 0 0.274358 -0.02059 0 0.194997 -0.0415505 0 0.165227 -0.169742 0 + 0.280595 0.023253 0 0.285065 -0.0105238 0 0.0523963 0.000891884 0 0.0618995 -0.0594859 0 + -0.00126975 0.00879784 0 0.33767 0.0430316 0 0.092357 -0.0226394 0 0.172122 -0.0347474 0 + 0.25011 -0.0430382 0 -0.000454861 0.000730386 0 -0.00813716 0.000722888 0 0.391991 -0.0431749 0 + 0.38318 0.000293976 0 0.153388 0.020272 0 0.0555251 -0.0584542 0 0.234861 -0.0059182 0 + -0.00221115 0.00273836 0 0.328289 -0.178892 0 -0.000717677 0.00769597 0 0.318408 -0.029912 0 + 0.233552 -0.0421365 0 0.0899778 -0.0144044 0 0.361932 -0.150858 0 0.275132 0.0244231 0 + 0.276469 -0.159866 0 0.336998 0.0589543 0 0.157871 0.0334875 0 0.290484 0.104846 0 + 0.285488 0.0251322 0 0.25201 -0.0074076 0 0.279528 0.0275615 0 0.244178 -0.0460386 0 + 0.152364 0.0149815 0 0.0486851 -0.00464297 0 0.2102 -0.0125258 0 0.319739 0.0364644 0 + 0.202959 -0.00867544 0 0.134369 -0.0855274 0 0.111797 -0.0260094 0 0.284852 4.37141e-06 0 + 0.258482 0.044306 0 0.117321 -0.00274849 0 0.130853 0.0277959 0 0.0255406 0.0139355 0 + 0.203176 -0.00280732 0 0.245383 -0.0168719 0 0.199272 -0.00219209 0 0.312593 0.0272834 0 + 0.226931 -0.00322549 0 0.0651587 0.0179205 0 0.260325 0.0177443 0 0.328587 0.0452118 0 + 0.332722 -0.00422278 0 0.0608096 -0.00404733 0 0.374706 -0.0470585 0 0.0148332 -9.98089e-05 0 + 0.299539 0.000561692 0 0.273365 -0.00390486 0 -0.00180173 0.00475401 0 0.284537 -0.0411557 0 + 0.0233855 0.00768121 0 0.130278 0.0285559 0 0.287873 -0.00101387 0 0.310631 -0.0293309 0 + 0.0590278 0.0107043 0 0.259685 0.0101529 0 0.268604 -0.0066987 0 0.157782 0.0270304 0 + 0.271187 -0.0441507 0 0.0970241 -0.0271283 0 0.26951 0.00136136 0 0.23039 0.0421395 0 + -0.0023529 0.00517339 0 0.2654 -0.00693907 0 0.0225604 -0.000121553 0 0.132536 -0.0291201 0 + 0.325246 0.0402523 0 0.280555 0.119198 0 0.181901 0.10348 0 0.0769525 0.026007 0 + 0.129834 0.0193507 0 -0.00357756 -0.00912335 0 0.188774 -0.141606 0 0.172135 0.142466 0 + 0.255301 0.00643749 0 0.372077 -0.00920071 0 0.291983 -0.000571117 0 0.383505 0.00574799 0 + 0.258785 -0.0175872 0 0.157196 0.0326141 0 0.0427231 6.63201e-05 0 0.19829 -0.129491 0 + 0.0949264 0.00679137 0 0.276505 -0.1121 0 0.0741109 -0.0225103 0 0.12725 -0.0124815 0 + 0.165814 -0.0324498 0 0.276821 0.0195253 0 0.266787 0.0271715 0 0.295228 0.0298865 0 + 0.241486 0.069428 0 0.293389 -0.000507802 0 0.150599 -0.00183354 0 0.270546 0.0198405 0 + 0.270302 -0.0104764 0 0.00836432 -0.00455129 0 0.201647 0.0298239 0 0.0368078 0.0113084 0 + 0.190497 -0.10836 0 0.276368 0.00214831 0 0.268696 -0.00477022 0 0.392398 0.0394398 0 + 0.361419 -0.0133413 0 0.367405 -0.108635 0 0.268424 -0.00656878 0 0.211705 0.0108752 0 + 0.296948 0.000532386 0 0.367027 0.0243765 0 0.0225133 0.00056066 0 0.0820881 0.00291481 0 + 0.0843023 7.56143e-05 0 0.277433 0.000555463 0 0.214713 0.0131233 0 0.0234887 0.00449264 0 + 0.0152725 0.00013919 0 0.261326 0.0216288 0 0.0194638 -0.000238541 0 0.288418 0.000754517 0 + 0.0293816 2.41289e-05 0 0.290863 -0.000439667 0 0.270295 -0.107265 0 0.209144 -0.0303561 0 + 0.234712 0.0526108 0 0.162833 0.025677 0 0.0794258 -0.00136631 0 0.0168306 -0.000226039 0 + 0.287925 0.0478263 0 0.320955 0.0187918 0 0.00298009 -0.00649398 0 0.340784 0.00759839 0 + 0.263723 -0.0216506 0 0.0417166 -0.000406807 0 0.057053 -5.70815e-05 0 0.215508 -0.0345444 0 + 0.254057 -0.0429398 0 0.0255197 0.000110882 0 0.273999 0.00102012 0 0.175047 0.00916747 0 + 0.269432 -0.0316856 0 0.0114748 -0.000583792 0 0.387337 0.0341619 0 0.285891 -0.0228723 0 + 0.276314 -0.0199365 0 0.207651 -0.14025 0 0.0920835 -0.0076575 0 0.0664193 -6.40279e-05 0 + 0.152229 -0.0353314 0 0.26956 -0.04346 0 0.122684 -0.0268389 0 0.272793 0.0474136 0 + 0.0238662 0.000123294 0 0.254326 0.00111343 0 0.162136 -0.0685133 0 0.0611975 -0.00989567 0 + 0.248207 -0.0712431 0 0.111158 0.0324947 0 0.219488 0.00791779 0 0.0809153 -0.0313913 0 + 0.0189802 0.00684454 0 0.297153 -0.000247155 0 0.0640429 -0.107441 0 0.185376 0.0229392 0 + 0.0144346 -0.00022564 0 0.203125 -0.0410716 0 0.155335 -0.009372 0 -0.00163137 0.00336105 0 + 0.268514 -0.0322084 0 0.0641376 -0.00373707 0 0.0197955 0.00016949 0 0.33221 -0.0383848 0 + 0.276616 0.0199447 0 0.3089 0.0342571 0 0.0424017 0.000450865 0 0.0238975 6.12418e-05 0 + 0.268349 -0.00973748 0 0.286268 0.0274768 0 0.184023 0.00593329 0 0.279182 0.00747886 0 + 0.326407 0.0440443 0 0.329401 -0.170882 0 0.358108 0.15457 0 0.0142583 -7.85948e-05 0 + 0.114537 0.00053505 0 0.136189 -0.0244687 0 0.0213618 0.000342919 0 0.290375 -0.000436678 0 + 0.343947 0.0280859 0 0.235672 0.0150411 0 0.236893 0.0123729 0 0.0231086 -3.59468e-05 0 + 0.247899 -0.0103608 0 0.188528 0.150471 0 -0.00553559 0.00746039 0 0.0112305 -0.00476935 0 + 0.327575 0.037927 0 0.0472519 0.00951353 0 0.261555 0.0106379 0 0.342567 0.0190052 0 + 0.278437 0.0248064 0 0.160226 -0.158117 0 0.367153 -0.0369975 0 0.254347 0.00619444 0 + 0.240887 -0.0026934 0 0.329312 0.0156165 0 0.256883 0.00425796 0 0.143433 0.0298749 0 + 0.108035 -0.0239843 0 0.140645 -0.0920827 0 0.304024 0.0312571 0 0.00894571 -0.00747517 0 + 0.14095 -0.0253062 0 0.291869 -0.111681 0 0.188037 -0.0346369 0 0.221398 0.01504 0 + 0.0674972 -0.00012359 0 0.0729214 0.078237 0 0.0877285 -0.0178313 0 0.0384288 0.00126005 0 + 0.155971 0.132245 0 0.0157325 0.000205588 0 0.126408 0.0323747 0 0.0918337 0.017555 0 + 0.00787581 -0.00210737 0 0.205691 0.187801 0 0.0731634 -0.0122725 0 0.237263 -0.0389338 0 + 0.284988 0.0273794 0 0.0131857 -0.0090987 0 0.0674226 -0.010073 0 0.262513 -0.00840287 0 + 0.250254 -0.0474794 0 0.0292046 0.000294155 0 0.0629821 -0.023003 0 0.112258 0.0305061 0 + 0.281486 0.0119012 0 0.138411 -0.0224297 0 0.0144629 -0.000164148 0 0.255284 -0.0150539 0 + 0.322152 0.0419293 0 0.21203 0.0150181 0 0.259923 0.0151636 0 0.318302 0.171847 0 + 0.274078 0.0199652 0 0.0289721 4.45889e-06 0 0.293025 0.0295075 0 0.0365234 0.0127891 0 + 0.0215692 -8.71933e-05 0 0.0426433 -0.0111841 0 0.0296269 -0.000270758 0 0.255035 -0.0740425 0 + 0.274929 0.104865 0 0.04728 6.95064e-05 0 0.189952 -0.0291115 0 0.298338 0.0297742 0 + 0.222789 0.0355316 0 0.0899514 0.000461721 0 0.237894 -0.0428862 0 0.3568 -0.0341262 0 + 0.31486 -0.0268758 0 0.32429 -0.121506 0 0.248329 -0.0145398 0 0.149682 -0.0301284 0 + 0.0497982 -0.00231372 0 0.0611502 -0.00669514 0 0.359282 -0.0486642 0 0.0237383 -0.0098215 0 + 0.365675 -0.0226759 0 0.0219616 -0.000124539 0 0.283943 0.0950457 0 0.199143 -0.00436013 0 + 0.240392 0.0447051 0 0.0827215 0.000239713 0 0.169938 0.0334445 0 0.0273082 0.00509651 0 + 0.044487 6.31905e-05 0 0.382568 0.0112449 0 0.275251 0.0238224 0 0.242447 -0.055189 0 + 0.243732 -0.0316938 0 0.0179456 0.000121601 0 0.268423 -0.00462127 0 0.274845 0.0248704 0 + 0.0204912 -0.000381808 0 0.321687 0.0363681 0 0.0513831 -0.00251992 0 0.0755767 -0.0205761 0 + 0.0490267 -0.00740026 0 0.00186966 -0.00563239 0 0.10817 0.0225952 0 0.213613 -0.00106098 0 + 0.153165 -0.0331701 0 0.298586 0.031295 0 0.162004 0.0628902 0 0.261872 -0.095671 0 + 0.0422795 -0.00119202 0 0.156927 -0.0233619 0 0.261062 0.0387102 0 0.316968 -0.0281649 0 + 0.339625 0.175118 0 0.104578 -0.011921 0 0.32177 -0.0286479 0 0.256428 0.00438473 0 + 0.302263 0.0369481 0 0.31823 -0.0325282 0 0.287115 0.0274392 0 0.264974 -0.0385354 0 + -0.00579435 0.00515148 0 0.0403068 -0.000305149 0 0.0224955 0.00637859 0 0.368393 0.0846754 0 + 0.171587 -0.032633 0 0.359152 -0.0276373 0 0.256779 0.0043695 0 0.288332 -0.0441699 0 + 0.290532 0.0334574 0 0.296412 0.0372459 0 0.261867 -0.0451661 0 0.259324 -0.0521013 0 + 0.0810434 0.0151207 0 0.143305 0.029 0 0.213852 0.0397906 0 0.0286251 -0.000237893 0 + 0.0172348 0.000363298 0 0.314339 0.0344099 0 0.376159 0.0303139 0 0.133779 0.0237004 0 + 0.106671 -0.00981812 0 0.256675 0.0119926 0 0.211717 -0.0363069 0 0.21345 0.00110707 0 + 0.166605 -0.101547 0 0.117218 -0.0668088 0 0.392902 0.0285006 0 0.265902 -0.00137555 0 + 0.102257 -0.0137812 0 0.0207535 -0.000200301 0 0.108495 -0.026948 0 0.354497 0.0080353 0 + 0.220381 0.00913956 0 0.203038 -0.00739648 0 0.287999 -0.000454769 0 0.380679 0.0165843 0 + 0.0795974 0.0153722 0 0.0528084 -0.00255363 0 0.0386585 0.00755808 0 0.275575 0.0309729 0 + 0.166782 -0.0079651 0 0.196797 -0.00103048 0 0.011893 -0.000192057 0 0.329522 -0.0419785 0 + 0.373348 -0.00680251 0 0.277432 0.0218691 0 0.155945 -0.0297232 0 0.159856 -0.00980003 0 + 0.301889 0.0329032 0 0.270564 -0.0102445 0 0.208751 0.169592 0 0.21559 0.0451162 0 + 0.0282685 0.00719734 0 0.216489 -0.162896 0 0.203826 -0.036938 0 0.233006 0.00717714 0 + 0.218329 -0.0187887 0 0.301871 -0.168595 0 -0.00967404 0.000970988 0 0.25113 -0.0131777 0 + 0.327459 0.0401003 0 0.191143 -0.00518952 0 0.342047 0.125914 0 0.267239 -0.0141334 0 + 0.100066 -0.00361217 0 0.385747 0.119212 0 0.242718 0.0426704 0 0.0212653 0.00776905 0 + 0.244844 -0.0403435 0 0.164868 -0.126345 0 0.274926 -0.00174091 0 0.285853 0.0387475 0 + 0.356344 -0.0311743 0 0.0456451 -0.0115362 0 0.211696 0.00846455 0 0.0766515 -0.0123143 0 + 0.350409 -0.0190572 0 0.298805 -0.111378 0 0.252428 0.0247244 0 -0.00430638 0.00206882 0 + 0.111833 0.000507209 0 -0.00400114 -0.00896421 0 0.061732 -0.0197402 0 0.283036 0.0154722 0 + 0.222017 -0.01212 0 0.340709 -0.154355 0 0.255629 0.00837143 0 0.255964 0.0435749 0 + 0.333183 0.0442081 0 0.269551 0.0392959 0 0.0381037 0.00128265 0 0.323159 0.0385162 0 + 0.301863 0.0477291 0 0.350357 0.104697 0 0.0743782 0.0205701 0 -0.00509807 0.00368126 0 + -0.00247828 0.00618011 0 0.13903 -0.0206963 0 0.214259 0.0237858 0 0.191183 -0.0056367 0 + 0.258982 -0.114152 0 0.269661 0.0356841 0 0.0132225 -5.20724e-05 0 0.175808 -0.00191413 0 + 0.271189 0.0168552 0 0.253884 -0.0206443 0 0.336784 -0.141673 0 0.0410368 -0.0015905 0 + 0.34243 -0.0396465 0 0.0263892 -0.00019607 0 0.268581 -0.00671415 0 0.193398 0.00286566 0 + -0.00277048 0.00655201 0 0.324706 0.045835 0 0.338889 0.0136767 0 0.339414 0.0420522 0 + 0.331641 0.182424 0 0.255479 -0.0306833 0 0.237253 0.0550973 0 0.26068 -0.0186915 0 + 0.320604 0.0463624 0 0.223966 -0.0315457 0 0.287397 -0.000450486 0 0.0876226 -0.0145122 0 + 0.0618707 0.102843 0 0.181834 0.0059489 0 -0.00142709 -0.00612426 0 0.209746 -0.0362962 0 + 0.314264 0.0470301 0 -0.00108027 0.00826873 0 0.0123183 0.000195404 0 0.0419507 -0.00112582 0 + 0.0723676 -0.0600215 0 0.336823 0.0121321 0 0.34203 -0.0379892 0 0.0948681 0.0028189 0 + 0.240723 0.0418601 0 0.271753 0.0402051 0 0.264248 -0.00111333 0 0.0668631 -0.0186722 0 + 0.240949 -0.0124033 0 0.25098 -0.0349294 0 0.0771426 0.0260696 0 0.242237 0.194493 0 + -0.000711351 0.00234049 0 0.312355 0.0427609 0 0.247248 -0.0125712 0 0.24182 -0.0583156 0 + 0.314096 -0.0304599 0 0.105215 0.00655633 0 0.263212 -0.0406213 0 0.187532 -0.0172434 0 + 0.210597 -0.0300532 0 0.263195 -0.0134854 0 0.193477 -0.0346595 0 0.140236 -0.0156205 0 + 0.0937569 -0.0103076 0 0.236124 -0.0377645 0 0.316376 -0.00873309 0 0.0772048 -0.0220123 0 + 0.0468816 0.00181372 0 0.197891 0.0370724 0 0.213419 -0.010481 0 0.0823597 -0.00562398 0 + 0.28428 0.00360859 0 0.00372307 -9.82775e-05 0 0.186115 -0.0281054 0 0.240292 0.106565 0 + 0.250691 -0.0142875 0 0.218637 0.034353 0 0.280282 0.0236565 0 0.264616 -0.00261094 0 + 0.185726 -0.0134476 0 0.246932 0.0464641 0 0.0140629 9.18408e-05 0 0.382693 0.0267268 0 + 0.23316 0.182679 0 0.34291 -0.145117 0 0.234545 0.0247631 0 0.30296 0.0321118 0 + 0.154453 -0.0319457 0 0.323213 -0.0240073 0 0.00831317 0.00136091 0 0.264748 -0.00106396 0 + 0.267231 0.0436574 0 0.147972 -0.00417716 0 0.299987 0.0315671 0 0.0453597 0.0143844 0 + 0.275937 0.0305752 0 0.285917 0.0274593 0 0.355492 -0.0343107 0 -0.0113942 -0.000714372 0 + 0.309427 -0.00416753 0 0.0129843 5.49531e-05 0 0.210188 0.00667145 0 0.0254643 0.01411 0 + 0.248698 -0.0400338 0 0.305201 -0.108958 0 0.376144 -0.0889829 0 0.199359 0.00709777 0 + 0.150692 0.00747493 0 0.184018 0.0946746 0 0.211052 -0.0026657 0 0.079412 -0.0232908 0 + 0.316061 0.0341398 0 0.293422 -0.000522036 0 0.27166 0.0127821 0 0.114679 -0.027589 0 + 0.257909 0.00871517 0 0.109415 -0.00773865 0 0.25342 -0.0223092 0 0.319655 0.0433648 0 + 0.21316 -0.04627 0 0.11456 0.032764 0 0.11605 0.0166038 0 0.29913 0.0379788 0 + 0.27075 0.101748 0 0.395784 0.036355 0 0.251611 0.0058826 0 0.077539 0.11922 0 + 0.212493 0.0414191 0 0.229103 -0.00333756 0 0.28892 0.0370303 0 0.126351 0.060661 0 + 0.143246 0.00684354 0 0.104941 -0.00155837 0 0.262897 -0.0781876 0 0.0884708 0.0282188 0 + 0.0971795 -0.0085032 0 0.0480032 -0.000570187 0 0.0817452 4.5607e-05 0 0.22028 0.0410466 0 + 0.302609 -0.0269969 0 0.226077 0.00962544 0 0.215619 -0.00322667 0 0.0728902 0.0156906 0 + 0.18683 -0.0264605 0 0.213971 -0.0480824 0 0.275363 0.0247577 0 0.236753 -0.00528284 0 + 0.247904 -0.0133259 0 0.216793 -0.0105657 0 0.0624213 0.0122962 0 0.0324495 -1.56992e-05 0 + 0.274462 0.0189051 0 0.383565 0.0350581 0 0.23673 0.00782216 0 0.266379 -0.00627375 0 + 0.226624 -0.0802655 0 0.178202 -0.0239361 0 0.240443 -0.0104308 0 0.222463 -0.00465457 0 + 0.254765 0.0653346 0 0.237978 -0.111421 0 0.100765 0.0286207 0 0.328842 -0.0361073 0 + 0.313615 0.113137 0 0.156547 -0.0196727 0 0.266009 -0.00636971 0 0.310314 -0.0292683 0 + 0.261762 -0.0286578 0 0.268841 0.200602 0 -0.011733 0.00106995 0 0.144593 0.0141195 0 + 0.0318589 -4.8025e-05 0 0.198144 0.0553307 0 0.257911 0.00841188 0 0.23987 -0.00607736 0 + 0.182846 0.0311558 0 0.214914 -0.0492686 0 0.175047 -0.0223819 0 0.0137087 -7.76929e-05 0 + 0.0500259 0.0841673 0 0.192961 0.026821 0 0.298195 -0.0259672 0 0.193711 -0.0245005 0 + 0.0240827 0.000159311 0 0.221948 -0.00304284 0 0.27561 0.032161 0 0.255103 0.00535054 0 + 0.168015 -0.0142716 0 0.343041 0.00836656 0 0.135701 0.00474735 0 0.153352 0.0220179 0 + 0.291327 -0.0245523 0 0.265254 -0.00608003 0 0.293415 -0.0437638 0 0.0424462 -0.00837775 0 + 0.218798 0.0418268 0 0.284407 -0.000461604 0 0.143197 0.0370539 0 0.0397726 0.00940227 0 + 0.255572 0.00544659 0 0.173221 0.0360837 0 0.244978 -0.12951 0 0.252232 -0.00841084 0 + 0.266786 -0.00710479 0 0.0905425 -0.0226669 0 0.0704444 0.0279347 0 0.196612 -0.0373956 0 + 0.105905 -0.00210234 0 0.158453 -0.0217777 0 0.303634 0.0332569 0 0.228755 -0.169495 0 + 0.212501 -0.00318679 0 0.265708 -0.00599867 0 0.034234 0.00687974 0 -0.00339899 -0.00469554 0 + 0.295934 0.0374131 0 0.159613 -0.0336206 0 0.033295 -0.0100262 0 0.272657 -0.0432086 0 + 0.28469 3.80811e-05 0 0.266921 -0.000147494 0 0.131205 0.0135755 0 0.322084 -0.0139073 0 + 0.203367 0.027009 0 0.200541 0.0413382 0 0.118517 0.0179691 0 0.321338 0.0185981 0 + 0.257699 -0.059097 0 0.19621 -0.00400564 0 0.268853 -0.00713348 0 0.396994 0.0441839 0 + 0.10413 -0.0163147 0 0.0315716 0.00659173 0 0.0488155 -0.00708652 0 0.2157 0.0406535 0 + 0.228245 0.00106615 0 0.0452434 -0.0116074 0 0.0483765 0.0864933 0 0.37047 0.14889 0 + 0.261083 0.0116083 0 -0.00429149 -0.00851459 0 0.250309 0.148364 0 0.288371 -0.0230339 0 + 0.0108621 -0.00336828 0 0.243435 -0.00713072 0 0.0123096 -0.000177272 0 0.347416 0.091109 0 + 0.255887 0.00426973 0 0.233523 0.0153913 0 0.318852 0.0409527 0 0.229603 0.00919003 0 + 0.222693 0.0218049 0 0.27132 -0.0328285 0 0.252366 -0.0648638 0 0.204493 0.0280168 0 + 0.249777 -0.0682041 0 0.214069 -0.0467853 0 0.134353 -0.000801476 0 0.261959 -0.0346005 0 + 0.224416 0.0412204 0 0.275442 0.0194532 0 0.256556 0.00427964 0 0.228755 -0.000123763 0 + 0.267182 -0.00612364 0 0.379027 0.0327191 0 0.270447 -0.0130595 0 0.211816 0.00734802 0 + 0.266876 0.097347 0 0.317833 0.0339796 0 0.105834 -0.0220451 0 0.0503661 -0.000534551 0 + 0.332522 0.139781 0 0.319883 0.118119 0 0.237263 0.0199761 0 0.0422461 0.0170749 0 + 0.242079 0.0126559 0 0.283708 -0.000453858 0 0.00591248 -0.00466487 0 0.265012 0.0337715 0 + 0.278666 -0.0306853 0 0.267373 -0.00602494 0 0.109813 -0.0125157 0 0.195483 0.0339597 0 + 0.150455 0.0165872 0 0.261673 0.014294 0 0.104428 -0.00431901 0 0.119994 0.0240776 0 + 0.200477 0.0239172 0 0.209834 0.0239536 0 0.271869 -0.00108483 0 0.204761 -0.013197 0 + 0.236358 0.0148784 0 0.140958 0.119677 0 0.14256 -0.00800612 0 0.0240268 -0.000229126 0 + 0.379203 0.0402687 0 0.287212 -0.00113292 0 0.265355 -0.0760862 0 0.259809 0.0288221 0 + 0.167393 0.0275614 0 0.0940125 0.00198535 0 0.259573 0.0737186 0 0.259055 0.0187291 0 + 0.0124719 0.000206993 0 0.304262 0.043215 0 0.21892 0.00480782 0 0.271728 0.0183655 0 + 0.256065 0.00417703 0 0.259373 -0.00654593 0 0.276286 0.0226634 0 0.180508 -0.0224936 0 + 0.169876 0.0287472 0 0.0451164 -0.000270048 0 0.0998502 0.0271162 0 0.258342 0.00887499 0 + 0.143356 0.0189871 0 0.190679 -0.0226153 0 0.266454 -0.031878 0 -0.0041554 -0.00607901 0 + 0.154366 -0.0113449 0 0.122854 -0.0174609 0 0.080121 -0.0780434 0 0.130841 0.000629812 0 + 0.00579493 0.0031515 0 0.291398 0.0378248 0 0.212718 0.0268451 0 0.384265 -0.0248659 0 + 0.320954 -0.039075 0 0.210697 0.0249402 0 0.119309 -0.024879 0 0.255065 0.00414499 0 + 0.280091 -0.0222447 0 0.292603 -0.0753355 0 0.207648 0.0421667 0 0.314417 -0.0150568 0 + 0.0484894 0.0086159 0 0.0342797 -2.48503e-05 0 0.214091 0.0278943 0 0.254396 -0.000925502 0 + 0.0244739 -0.000150543 0 0.292533 -0.00534226 0 0.108335 -0.0145653 0 0.316185 -0.0321037 0 + 0.12535 0.0189878 0 0.0121986 -4.82286e-05 0 0.0170916 -0.000124609 0 0.324216 -0.0402729 0 + 0.387794 0.119977 0 0.14428 -0.0167176 0 0.0756658 0.00199764 0 0.1117 -0.0104395 0 + 0.244329 -0.117296 0 0.201144 -0.0238147 0 0.373561 0.0115125 0 0.252944 -0.0360884 0 + 0.205407 0.0397904 0 0.396122 0.0515566 0 0.0182074 0.000225797 0 0.336783 -0.0409366 0 + 0.0726991 4.24458e-05 0 0.106955 0.00463723 0 0.0773014 0.000808564 0 0.172696 -0.0203745 0 + 0.199455 -0.0270326 0 0.200703 -0.00320378 0 0.0702488 0.00370307 0 0.23022 0.0401576 0 + 0.170075 0.0229455 0 0.160915 -0.0179393 0 0.206446 -0.00888933 0 0.0837646 -0.0151878 0 + 0.266235 -0.00974575 0 0.211268 -0.0473085 0 0.025988 -0.00485598 0 0.279225 -0.0200025 0 + 0.359791 -0.149539 0 0.0527606 0.0119126 0 0.208453 0.0111011 0 0.226893 0.0405928 0 + 0.267421 -0.0175023 0 0.111259 -0.0113793 0 0.207482 -0.0646624 0 -0.00891457 0.00487158 0 + 0.162405 -0.0200025 0 0.256708 0.0464407 0 0.0133971 8.49904e-05 0 0.226046 -0.0379178 0 + 0.228468 0.01228 0 0.244296 0.0201322 0 0.0367732 0.00538652 0 0.269637 -0.00349057 0 + 0.303207 -0.00975193 0 0.199834 -0.0364001 0 0.209564 -0.00301664 0 0.26174 0.0297428 0 + 0.12467 0.0133347 0 0.220753 0.0078316 0 0.239099 -0.051005 0 0.0214045 -0.000420481 0 + 0.28967 0.0108393 0 0.220101 -0.00443489 0 0.0651547 0.0233188 0 0.263578 0.0918189 0 + 0.300406 -0.0417356 0 0.257568 0.00803831 0 0.218631 0.0237973 0 0.219672 0.0247472 0 + 0.255075 0.00525976 0 0.253965 0.00401276 0 0.142951 0.013252 0 0.00414471 -0.00221825 0 + 0.0626115 0.000331818 0 0.359805 -0.0302753 0 0.0719513 0.0159165 0 -0.00214182 -0.00457404 0 + 0.219837 0.0132097 0 -0.0045199 -0.00779712 0 0.255299 0.00406482 0 0.329461 0.057657 0 + 0.166052 0.022016 0 0.225714 -0.0227859 0 0.328946 -0.041977 0 0.0241933 -0.000144993 0 + 0.258681 0.0146739 0 0.26478 0.0275209 0 0.277782 0.0388369 0 0.29984 0.000114077 0 + 0.27799 -0.0272418 0 0.0481631 -7.33911e-05 0 0.343128 0.0395418 0 0.178264 -0.010743 0 + 0.14411 -0.0177263 0 0.322737 0.188093 0 0.209893 -0.00255565 0 0.368819 0.119295 0 + 0.280477 0.0932342 0 0.203593 0.0113036 0 0.113946 -0.0090065 0 0.281207 -0.026994 0 + 0.159062 -0.0116997 0 0.226628 0.0234319 0 0.119155 0.0248338 0 0.269345 -0.0195502 0 + 0.290824 -0.00958439 0 0.270288 0.0164488 0 0.112273 0.0294398 0 0.109009 -0.00230072 0 + 0.282185 0.0150118 0 0.33417 0.0333728 0 0.203456 -0.00616027 0 -0.00576341 0.00179425 0 + 0.0458048 0.000413762 0 0.00870309 -0.00127749 0 0.217104 0.0172934 0 0.373551 0.037892 0 + 0.199792 0.0422522 0 0.18765 -0.0206539 0 0.185068 -0.0186955 0 0.298721 -0.0260619 0 + 0.287657 -0.00053244 0 0.256752 0.00445169 0 0.280232 -0.000461045 0 0.124956 -0.0252503 0 + 0.229372 0.0189746 0 0.203484 0.00305037 0 0.25089 -0.0352995 0 0.0465496 -0.0566543 0 + 0.34694 0.166691 0 0.336235 0.00182024 0 0.243721 -0.00658847 0 0.245469 -0.0135256 0 + 0.24246 -0.197597 0 0.259827 -0.029951 0 0.353828 -0.0314306 0 0.223789 0.0128742 0 + 0.14011 0.0344532 0 -0.00295934 0.00403044 0 0.183408 0.0349587 0 0.155316 -0.0153945 0 + 0.273411 0.0181138 0 0.179982 0.0047328 0 0.302413 0.0227122 0 0.234982 -0.0371671 0 + 0.295501 -0.0434136 0 0.249045 0.0166955 0 0.0865784 0.000146798 0 0.247899 -0.0266622 0 + 0.0504312 -0.0924203 0 0.134996 0.0221487 0 0.23103 0.0119268 0 0.266784 0.0284087 0 + 0.173156 0.00871733 0 0.0150863 0.000126661 0 0.288199 -0.00359226 0 0.293711 0.00577734 0 + 0.266278 -0.0401645 0 0.217529 0.0104186 0 0.256809 -0.0662069 0 0.251939 -0.0119202 0 + 0.254267 0.00394344 0 0.268839 0.0205557 0 0.210127 0.00854065 0 0.0157874 -0.000115584 0 + 0.193792 -0.00899316 0 0.245916 -0.00606968 0 0.192678 -0.00932059 0 0.221106 0.0131624 0 + 0.256975 0.00411369 0 0.256694 0.00448862 0 0.281176 -0.0307079 0 0.241314 0.0139003 0 + 0.234095 0.0229376 0 0.202469 -0.0263285 0 0.234266 -0.00484596 0 0.0119085 -4.44487e-05 0 + 0.242703 -0.0250732 0 0.31115 -0.105724 0 0.294508 -0.0214917 0 0.256779 -0.0732664 0 + 0.0334036 0.0307028 0 0.257689 -0.0800622 0 0.393768 0.0583853 0 0.0296376 -1.43569e-05 0 + 0.175624 -0.0184656 0 0.16415 -0.0219901 0 0.1732 0.00611801 0 0.295351 0.00540338 0 + 0.0886184 0.0276014 0 0.27341 0.0231161 0 0.206471 0.0087466 0 0.268904 -0.00685811 0 + 0.227871 0.0243601 0 0.254209 0.00513408 0 0.346742 0.124193 0 0.259023 0.0736515 0 + 0.0213476 0.000467927 0 0.24221 -0.0429842 0 0.133386 -0.016169 0 0.252595 0.00387392 0 + 0.241397 -0.038632 0 0.0111156 -0.000166369 0 0.257237 0.00421691 0 0.243949 0.029165 0 + 0.264805 -0.0247513 0 0.195639 0.00923394 0 0.155991 0.0308719 0 0.246489 0.0290578 0 + 0.214656 -0.0361532 0 0.170613 -0.0183256 0 0.234151 0.0172977 0 0.243964 -0.0249906 0 + 0.146012 0.0242325 0 0.259576 -0.0167826 0 0.218191 -0.0481715 0 0.268673 0.0261447 0 + 0.272186 0.0204488 0 0.2651 0.0169098 0 0.29444 0.03014 0 0.166869 0.0229239 0 + 0.228258 0.0245949 0 0.308913 -0.0408907 0 0.213095 0.0107904 0 0.254982 -0.0165437 0 + 0.0334543 0.0156862 0 0.0681596 -0.0126261 0 -0.00648931 -0.00575556 0 0.0516198 0.000171849 0 + 0.318547 -0.0332224 0 0.00376289 0.00477996 0 0.0101662 0.000867463 0 0.27938 -0.000452643 0 + 0.273766 -0.0367979 0 0.105259 -0.0088312 0 0.261829 -0.0265872 0 0.216205 0.0105212 0 + 0.0158229 -0.00619445 0 0.306299 -0.0865011 0 0.226107 -0.00536516 0 0.229892 -0.00779142 0 + 0.292303 0.00524937 0 0.200729 -0.0157535 0 0.353871 -0.0339295 0 0.25297 0.00381491 0 + 0.240766 0.0223083 0 0.23536 0.023823 0 0.206503 -0.00640401 0 0.0454506 -0.000343593 0 + 0.147053 -0.00848973 0 0.250956 0.00373065 0 0.184937 0.0317331 0 0.0591415 -0.0169578 0 + 0.276248 0.000570428 0 0.0988461 0.0195067 0 0.201129 0.00901491 0 0.33665 0.027468 0 + 0.0735467 -0.0126339 0 0.199165 -0.0244967 0 0.0573824 -0.000128919 0 0.257559 0.00829556 0 + 0.294548 0.00255786 0 0.18613 -0.0191815 0 0.236614 -0.0421414 0 0.253888 0.0338047 0 + 0.195291 0.0324566 0 0.259207 0.0190445 0 0.21181 0.00353408 0 0.327026 0.0649511 0 + 0.183177 -0.0168025 0 0.303612 -0.0271945 0 0.190405 -0.00229032 0 0.353533 0.0363282 0 + 0.119842 -0.000621905 0 0.272125 0.0904981 0 0.170693 0.0343287 0 0.105159 0.00191872 0 + 0.313238 -0.0303449 0 0.0235028 0.000247681 0 0.131195 0.0261471 0 0.0181046 -0.000394356 0 + 0.148507 0.00724963 0 0.294469 -0.0241839 0 0.251126 -0.0261653 0 0.153551 0.0196789 0 + 0.246443 0.0215433 0 0.280493 -0.0438073 0 0.288029 -0.0236486 0 0.202303 0.0153648 0 + 0.305776 0.0322108 0 0.239411 -0.00967844 0 0.349081 -0.10424 0 0.172854 -0.0145257 0 + 0.224065 -0.00322007 0 0.279795 0.000389968 0 0.311489 -0.0222783 0 0.274193 0.0215412 0 + 0.251466 0.0206964 0 0.255352 -0.0171736 0 0.193352 0.00729179 0 0.0124681 6.23595e-05 0 + 0.270672 0.0269701 0 0.351346 0.0368386 0 0.0938037 -0.118865 0 0.191028 0.00382013 0 + 0.0897729 -0.0948711 0 0.0838258 -0.000188468 0 0.0593172 -0.0849659 0 0.301238 0.127153 0 + 0.012301 -4.41862e-05 0 0.289413 -0.00660896 0 0.167767 -0.0123667 0 0.0756593 3.61476e-05 0 + 0.129851 0.0123244 0 0.339466 -0.0178642 0 -0.0118669 0.000569574 0 0.0924092 6.29438e-05 0 + 0.0126163 -6.27122e-05 0 0.25073 -0.014144 0 0.387934 0.118029 0 0.00423939 -0.00560851 0 + 0.268931 -0.00359651 0 0.32225 -0.031242 0 0.0676562 2.43045e-05 0 0.329898 -0.0218658 0 + 0.220053 -0.00517514 0 0.342251 -0.0384455 0 0.13839 0.157504 0 0.156973 -0.00753227 0 + 0.27776 -0.0208312 0 0.242217 0.0231606 0 0.189158 0.00743101 0 0.277099 0.000529357 0 + 0.28739 -0.0100026 0 0.244478 0.00350091 0 0.247478 0.00364002 0 0.291857 -0.000536186 0 + 0.165823 0.00443649 0 -0.00474486 -0.00682634 0 0.252999 0.00490708 0 0.00987278 0.00841798 0 + 0.205056 -0.0697217 0 0.207025 0.0111597 0 0.223021 0.0275415 0 0.0380413 0.0716571 0 + 0.09975 0.0408744 0 0.0998636 0.027762 0 0.177916 -0.0376774 0 0.253389 -0.0459356 0 + -0.0145415 0.000773637 0 0.280829 -0.0334068 0 0.25994 -0.000893496 0 0.17488 0.00311127 0 + 0.252385 -0.040651 0 0.00533859 -0.00449153 0 0.216185 0.0211147 0 0.245609 0.00619915 0 + 0.231728 -0.00555184 0 0.255875 0.019788 0 0.288295 0.0395902 0 0.152889 0.0161792 0 + 0.265486 0.0194545 0 0.188643 -0.0507775 0 0.153706 0.0219684 0 0.348218 -0.00604517 0 + 0.171064 -0.0341728 0 0.227552 0.0124292 0 0.240995 0.0332915 0 0.0787128 -0.0204594 0 + 0.275908 0.0221859 0 0.0761064 0.00102513 0 0.112363 -0.0284214 0 0.182654 -0.0339684 0 + 0.24803 0.0223559 0 0.278071 -0.00177738 0 0.20126 0.0112298 0 0.220239 0.00969672 0 + 0.19801 -0.00283153 0 0.218806 -0.0145808 0 0.177327 0.00604945 0 -0.00568683 0.00332184 0 + 0.142728 -0.00091458 0 0.178635 0.00231485 0 0.061289 0.00992749 0 0.347025 0.0298424 0 + 0.0701013 0.000187355 0 0.314551 0.0414904 0 0.137207 -0.00083861 0 0.275771 0.0198294 0 + 0.270926 0.0184412 0 0.224309 -0.017478 0 0.0674366 0.0146773 0 0.284522 0.0271245 0 + 0.212504 -0.00921878 0 0.196121 0.0700338 0 0.201133 0.00704828 0 0.25302 0.0214552 0 + 0.0480671 -0.0020111 0 0.0366946 0.0010709 0 0.243078 -0.0117844 0 0.0428533 0.000325813 0 + 0.192784 -0.0206935 0 0.259848 -0.0102474 0 0.0153433 -0.000121003 0 0.201037 -0.0283154 0 + 0.195981 -0.022631 0 0.145101 -0.0127571 0 0.220196 -0.00469463 0 0.207008 -0.00428857 0 + 0.10926 0.00047915 0 0.117108 -0.0594037 0 0.221489 -0.016038 0 0.257331 0.0204887 0 + 0.260507 0.013851 0 0.216379 0.00814384 0 0.193869 0.00926188 0 0.259903 -0.00360471 0 + 0.268332 -0.0179519 0 0.389432 0.0650495 0 0.316599 -0.101608 0 0.181078 0.0246065 0 + 0.203055 -0.00229226 0 0.0170881 9.63528e-05 0 0.0294706 0.0577551 0 0.292085 0.029049 0 + 0.190162 -0.018796 0 0.235244 -0.00654041 0 0.285365 -0.0209749 0 0.166422 0.00789538 0 + 0.242801 -0.0507759 0 0.213971 0.0162955 0 0.21689 0.00531612 0 0.210296 0.00888142 0 + 0.313256 0.0264683 0 0.359637 -0.0282558 0 0.239741 0.00334527 0 0.21884 -0.0104971 0 + 0.267208 0.0339419 0 0.235676 0.00316779 0 0.247581 -0.0124635 0 0.238771 -0.0842457 0 + 0.338106 0.000998546 0 0.222096 0.160027 0 0.275201 -0.000452155 0 0.0115573 4.32881e-05 0 + 0.234602 -0.0201978 0 0.261696 0.00258171 0 0.287936 -0.0407418 0 0.334957 -0.101174 0 + 0.254927 -0.0138213 0 0.255946 0.00769846 0 0.0650991 -0.00476924 0 0.258229 0.0726488 0 + 0.229389 -0.00573827 0 0.246331 0.188064 0 0.0687452 -0.000198675 0 0.0101582 1.05262e-05 0 + 0.231635 -0.0156922 0 0.188857 0.00379841 0 0.299824 -0.0351515 0 0.196723 0.00567348 0 + -0.0029985 0.00708888 0 0.229844 0.00145413 0 0.26817 -0.00654129 0 0.215062 0.00823567 0 + 0.194135 -0.0363314 0 0.0580073 -0.00057836 0 0.174046 -0.132857 0 0.292444 -0.0306258 0 + 0.351212 -0.0457146 0 0.290139 -0.000534687 0 0.0944023 -0.0021473 0 0.243516 0.0194091 0 + 0.302897 0.0353401 0 0.023488 0.000140087 0 0.176985 -0.0288142 0 0.203553 0.0337444 0 + 0.262534 -0.0114761 0 0.00213254 0.00618592 0 0.22839 0.0145016 0 0.188778 0.00173023 0 + 0.188442 0.00582583 0 0.271367 0.0168562 0 0.244981 -0.0210558 0 0.299054 0.0358727 0 + -0.00117894 0.00618613 0 0.254271 0.00505057 0 -0.00226728 -0.00548518 0 0.206563 0.00683062 0 + 0.0639942 0.0916377 0 0.0447112 0.00146131 0 0.0157605 -0.00744547 0 -0.00359417 0.00562738 0 + 0.206599 -0.168235 0 0.216769 0.0220288 0 0.227302 -0.0189259 0 0.180429 -0.0493213 0 + 0.0738648 0.00086012 0 0.130356 -0.0123733 0 0.160675 0.00123807 0 0.236534 -0.00974623 0 + 0.0364834 -0.00484693 0 0.00995692 -0.00805952 0 0.325419 0.0355563 0 0.35592 -0.118013 0 + 0.267645 -0.00575977 0 0.275627 0.0205396 0 0.195311 0.00725628 0 0.282469 0.0259665 0 + 0.0454497 0.000443695 0 0.114296 -0.0084535 0 0.356961 0.0296062 0 0.358951 -0.0319468 0 + 0.204344 -0.0431832 0 -0.00846639 -0.00505888 0 0.179986 -0.0648444 0 0.272403 0.0189836 0 + 0.28852 0.0134539 0 0.00495274 0.00164602 0 0.199406 0.00906512 0 0.236589 0.00316574 0 + 0.00745428 0.00165029 0 0.235034 -0.00370215 0 0.121417 -0.0302494 0 0.232161 0.00298615 0 + 0.266078 -0.00244456 0 0.0673708 0.00225545 0 0.292673 0.0290755 0 0.243765 -0.0423957 0 + 0.320009 -0.0254924 0 0.280018 -0.0298882 0 0.224978 0.0217604 0 0.0538645 0.00050352 0 + 0.322082 0.0402182 0 0.233997 0.0143011 0 0.266644 -0.00587876 0 0.266934 -0.00579528 0 + 0.273515 0.0254355 0 0.300284 0.0430076 0 0.237647 -0.054582 0 0.174662 0.00989606 0 + 0.228786 -0.0143787 0 0.261621 0.0160562 0 0.0837108 0.000271493 0 0.2537 -0.009592 0 + 0.269882 -0.0183096 0 0.244367 -0.0079285 0 0.211784 -0.0145829 0 0.261774 -0.0292064 0 + 0.244886 0.0369907 0 0.259463 -0.0151404 0 0.331158 -0.0399567 0 0.221335 -0.00343853 0 + 0.312804 0.192142 0 0.236006 0.0385065 0 0.287706 -0.0187077 0 0.243638 -0.185141 0 + 0.271614 0.0246527 0 0.218742 0.0407159 0 0.166057 -0.142363 0 0.353036 0.0336336 0 + 0.256679 0.0072336 0 0.24032 -0.00669452 0 -0.0131747 0.0016592 0 0.256975 -0.0102092 0 + 0.226346 -0.0131045 0 0.221253 -0.041974 0 0.126764 0.105894 0 0.361773 0.0957714 0 + 0.238535 0.0144939 0 0.276586 -0.0217525 0 0.276489 -0.0120135 0 0.213161 -0.00173675 0 + 0.206319 -0.00763429 0 0.0389188 0.0119436 0 0.222436 -0.0145252 0 0.268656 -0.00679889 0 + 0.162876 0.00248188 0 0.343659 -0.00249284 0 0.352059 -0.00956267 0 0.308684 0.0693169 0 + 0.266373 0.0765674 0 0.263119 0.0151064 0 0.0440688 0.000239229 0 0.150086 -0.0586222 0 + 0.240922 -0.042056 0 0.164652 0.00198126 0 0.356177 -0.0239099 0 0.359073 -0.0311647 0 + 0.239031 0.0140044 0 0.252213 -0.012706 0 0.168226 0.0038697 0 0.196539 0.00265701 0 + 0.189102 0.00168414 0 0.308911 0.0263072 0 0.196739 -0.00211113 0 0.279189 0.000436957 0 + 0.229026 0.0151733 0 0.183113 0.0205739 0 0.28621 0.040481 0 0.172759 0.00479015 0 + 0.273971 -0.000439335 0 0.202625 -0.155569 0 0.290151 -0.0271053 0 0.22972 -0.00637574 0 + 0.256527 0.00745453 0 0.217881 -0.00283811 0 0.213577 -0.00498043 0 0.272341 -0.0123548 0 + 0.238404 0.0207755 0 0.169448 -0.0994351 0 0.252859 0.0152293 0 0.023313 0.000142295 0 + 0.0677467 7.25511e-05 0 0.194777 0.00569831 0 0.317386 0.0461864 0 0.211026 -0.00383727 0 + 0.291537 0.028311 0 0.243479 0.0136273 0 0.268297 -0.00695742 0 0.160149 -0.0023722 0 + 0.17872 0.00147552 0 0.274066 0.112273 0 0.234794 0.0149473 0 0.253991 0.00722026 0 + 0.271869 -0.0089872 0 0.271305 -0.00338953 0 0.224298 -0.0118728 0 0.301539 -0.0238915 0 + 0.2702 -0.00308393 0 0.278764 0.0327825 0 -0.005017 -0.00562815 0 0.0508318 -8.59492e-05 0 + 0.365017 -0.0247583 0 0.246393 0.00836332 0 0.263949 -0.0259533 0 0.227545 -0.0562429 0 + 0.260988 -0.0156065 0 0.050045 0.00013635 0 0.279175 -0.0264744 0 0.28784 -0.0237688 0 + 0.247691 -0.00845771 0 0.218234 -0.0118363 0 0.276965 -0.0176053 0 0.340005 -0.0900836 0 + 0.331243 -0.0660059 0 0.143941 0.0315063 0 0.196131 -0.00376924 0 0.175482 0.00201737 0 + 0.244494 0.00891155 0 0.216566 -0.00312786 0 0.27619 0.0218674 0 0.193364 -0.00468114 0 + 0.0433094 -8.76857e-05 0 0.268636 0.0188185 0 0.225102 -0.0159247 0 0.259771 -0.008338 0 + 0.260894 0.0194669 0 0.249836 0.0194042 0 0.360887 0.00139519 0 0.271795 0.017521 0 + 0.0122533 -5.40427e-05 0 0.263216 -0.0182603 0 0.255087 0.00441849 0 0.18569 0.00244064 0 + 0.219722 0.028962 0 0.0434969 0.000308688 0 0.105553 -0.00101225 0 0.253899 0.00434503 0 + 0.218929 0.0148704 0 0.369862 -0.0209128 0 0.275083 -0.016838 0 0.26774 -0.0059696 0 + 0.0233 -9.27757e-05 0 0.308449 0.0420707 0 0.0482036 -0.00566204 0 0.259266 0.00909816 0 + 0.0487259 9.10212e-06 0 0.21722 -0.193721 0 0.0819323 0.00123149 0 0.263087 0.0165939 0 + 0.24574 -0.0105602 0 0.265392 -0.0114428 0 0.228137 -0.0173553 0 0.151835 0.0138941 0 + 0.225338 0.00934472 0 0.334274 0.0401986 0 0.38284 0.0706108 0 0.165396 0.00484879 0 + 0.272242 -0.00926553 0 0.253977 0.00471745 0 0.128444 -0.0272342 0 0.0724365 -0.0109206 0 + 0.23996 0.0146156 0 0.247391 0.0131949 0 0.24958 0.00851731 0 0.231153 -0.0187571 0 + 0.271852 -0.0177997 0 0.11708 -0.000553427 0 0.212545 0.0396827 0 0.267551 -0.0174246 0 + 0.326304 0.145534 0 -0.00484669 -0.00244375 0 0.0199138 2.55987e-05 0 0.208251 0.00545013 0 + 0.0666077 -0.00125259 0 0.204241 0.0126122 0 0.184046 -0.00542325 0 0.251682 -0.0219956 0 + 0.233195 -0.00682991 0 0.294267 -0.000598641 0 0.245815 -0.0246077 0 0.111071 -0.000514586 0 + 0.265292 -0.0192229 0 0.244479 0.0141926 0 0.246487 -0.00631132 0 0.246555 -0.163107 0 + 0.271803 -0.0160339 0 0.171884 0.0096987 0 -0.000181638 0.000792637 0 0.245717 -0.0139659 0 + 0.17268 -0.159849 0 0.217168 -0.00536624 0 0.0763239 0.00182382 0 0.260321 -0.0172613 0 + 0.264367 0.0155651 0 0.142733 -0.00586554 0 0.256529 -0.00825267 0 0.263962 0.0141436 0 + 0.26895 -0.0152788 0 0.257283 -0.00963026 0 0.187125 0.00745667 0 0.203492 -0.00397672 0 + 0.0216471 8.19397e-05 0 0.248422 0.0137128 0 0.0861385 0.00126171 0 0.222602 -0.0106768 0 + 0.0102494 -2.23193e-06 0 0.199778 -0.00407912 0 0.24997 0.0395971 0 0.268648 0.0479455 0 + 0.0211713 -0.00136917 0 0.0122541 -4.37131e-05 0 0.334294 0.0482058 0 0.2929 -0.0420918 0 + 0.263927 -0.00929187 0 0.0690879 0.00112417 0 0.288861 -0.00726941 0 0.264454 -0.00908544 0 + 0.263195 -0.0158657 0 0.259589 -0.0865587 0 0.249121 0.00818812 0 0.295248 -0.033279 0 + 0.247848 -0.00627616 0 0.274978 0.0249771 0 0.109505 -0.000498771 0 0.211955 -0.00799978 0 + 0.204223 -0.0049668 0 0.255849 0.00803157 0 0.204893 0.00688224 0 0.189446 0.00231056 0 + 0.210426 -0.00418281 0 0.323729 0.0503014 0 0.21571 -0.00933622 0 0.177643 0.00473092 0 + 0.268114 -0.00608039 0 0.184418 0.0135948 0 0.274434 0.0248798 0 0.197192 0.00237776 0 + 0.204812 0.0088117 0 0.114005 0.0202985 0 0.270609 -0.00311244 0 0.231986 -0.0142564 0 + 0.110178 0.00380959 0 0.226943 0.0302017 0 0.230785 -0.00959196 0 0.182066 -0.0797517 0 + 0.0252658 -0.0116096 0 0.264203 -0.0165081 0 0.335121 -0.0399158 0 0.265808 -0.0160796 0 + 0.04024 7.80838e-05 0 0.226627 -0.00364507 0 0.0226103 0.00015327 0 0.0225905 6.38274e-05 0 + 0.234839 -0.015517 0 0.259102 0.00231226 0 0.0734204 0.0152525 0 0.257057 0.00233834 0 + 0.374074 -0.0166353 0 0.216039 -0.0278585 0 0.171133 0.00219631 0 -0.0112304 -0.000320289 0 + 0.260409 -0.0102335 0 0.256909 0.099274 0 0.285635 -0.0206928 0 0.202082 0.00202326 0 + 0.265024 0.0145745 0 0.194822 0.00183372 0 0.0271668 0.00234865 0 0.246746 0.0062243 0 + 0.223028 -0.00459231 0 0.313471 0.10187 0 0.268341 -0.0121216 0 0.197142 -0.00971808 0 + 0.128713 -0.00483053 0 0.30012 -0.034251 0 0.297198 0.0307096 0 0.0400037 5.75271e-05 0 + 0.262713 -0.0152216 0 0.159658 0.0017516 0 0.0535805 0.000450057 0 0.251955 -0.00855969 0 + 0.292868 -0.0297291 0 0.184202 0.00380634 0 0.252082 0.0083248 0 0.22952 -0.0130341 0 + 0.168187 0.0013772 0 0.196457 0.00192645 0 0.348633 -0.0132324 0 0.251452 0.00427352 0 + 0.25403 0.0110064 0 0.179506 0.00106717 0 0.265939 -0.0145338 0 0.310259 0.164878 0 + 0.018684 0.00031133 0 0.214636 -0.00264451 0 0.252598 0.00763619 0 0.224288 -0.0078214 0 + 0.253613 0.00237762 0 0.175004 0.00604937 0 0.161629 0.00381714 0 0.233858 -0.0328169 0 + 0.24828 0.00937374 0 0.227406 -0.0118472 0 0.255433 -0.0319406 0 0.242901 0.00228802 0 + 0.250838 0.00235927 0 0.0105472 -9.99028e-06 0 0.353834 -0.0316593 0 0.253552 -0.0102052 0 + 0.24896 0.00701226 0 0.170265 0.0014509 0 0.0414228 0.0001214 0 0.181733 0.03116 0 + 0.336807 0.0991041 0 0.232739 0.0131609 0 0.261374 0.0117408 0 0.223486 -0.00555585 0 + 0.18302 -0.0360429 0 0.222154 -0.0455794 0 0.218421 -0.00339755 0 0.239357 0.0264369 0 + 0.250137 0.00480836 0 0.217462 0.00281536 0 0.30259 0.0474096 0 0.246475 0.00234409 0 + 0.0395408 2.23563e-05 0 0.252119 0.00500941 0 0.253056 -0.0561929 0 0.278472 -0.0170536 0 + 0.182227 0.00316278 0 0.255009 0.00481358 0 0.196671 0.00186676 0 0.181889 0.00378717 0 + 0.21361 -0.00277506 0 0.224185 0.0460461 0 0.255943 0.0104932 0 0.0285936 -2.22338e-05 0 + 0.162053 0.00161167 0 0.270754 -0.00262313 0 0.163569 0.00117855 0 0.069545 0.000252756 0 + 0.191965 -0.00195393 0 0.283284 0.0442919 0 0.170148 0.00130441 0 0.211397 -0.0025579 0 + 0.249269 0.00412966 0 0.0216842 8.89031e-05 0 0.0384913 -0.0157339 0 0.124962 -0.000665063 0 + 0.125785 -0.000683566 0 -0.00535956 -0.00423315 0 0.267997 -0.00587962 0 0.286014 -0.0433117 0 + 0.255946 -0.0116065 0 0.0286709 0.0119608 0 0.0104793 -0.000145521 0 0.160725 -0.000938984 0 + 0.231233 0.0463125 0 0.195409 0.00382557 0 0.302841 -0.0245792 0 0.243898 0.00852376 0 + 0.247923 -0.00727174 0 0.0643853 0.000521821 0 0.078843 6.74793e-05 0 0.293176 0.0359372 0 + 0.275776 -0.0162636 0 0.268137 -0.00605165 0 0.272857 -0.0155223 0 0.103519 0.0732063 0 + 0.290374 -0.0262388 0 0.0526612 -9.61078e-05 0 0.194399 0.0150212 0 0.0517551 -0.000102516 0 + 0.271047 -0.00337624 0 -0.000140945 0.00455974 0 0.339289 -0.0946823 0 0.177291 -0.0309428 0 + 0.234224 0.00594865 0 0.209281 0.00473948 0 0.177367 0.0120747 0 0.250382 0.0067623 0 + 0.250674 0.00912564 0 0.114165 0.0902985 0 0.0208136 -2.19333e-05 0 0.0639156 0.0014119 0 + 0.214375 -0.00380367 0 0.290033 -0.000505074 0 0.0107245 2.67377e-05 0 0.10966 -0.000488868 0 + 0.252136 0.00296134 0 0.213348 0.0454591 0 0.151115 -0.00267923 0 0.19845 0.00271095 0 + 0.225703 0.0109043 0 0.25894 0.0108207 0 0.07924 0.000362418 0 0.271194 -0.00266132 0 + 0.161988 0.00148564 0 0.271355 -0.0031726 0 0.20783 -0.0027764 0 0.226518 -0.00590309 0 + 0.213815 -0.00449263 0 0.162958 0.00483816 0 0.041782 -0.000107461 0 0.27006 -0.0148404 0 + 0.375165 0.0752372 0 0.244692 -0.00782288 0 0.19383 -0.00186961 0 0.243535 -0.00839926 0 + 0.318955 0.150092 0 0.233169 0.00298932 0 -0.000300631 -0.00096525 0 0.175907 -0.00606476 0 + 0.287889 -0.0229564 0 0.251006 -0.0083594 0 0.267565 -0.00634668 0 0.25162 -0.00687421 0 + 0.256736 0.0108424 0 0.0204252 -1.19954e-05 0 0.253298 0.00949352 0 0.0881909 0.0280896 0 + 0.228997 -0.00447026 0 0.182336 -0.0328223 0 0.224909 -0.0293615 0 0.211353 -0.00159467 0 + 0.253146 0.00483738 0 0.253773 -0.0108903 0 0.287565 0.0269752 0 0.152403 -0.00662568 0 + 0.252688 0.00882744 0 0.165574 0.00251697 0 0.205219 0.00309776 0 0.0403462 7.5204e-05 0 + 0.24954 0.00291254 0 0.251426 0.00944786 0 0.255499 0.00817818 0 0.251704 0.00462094 0 + 0.255176 0.00873662 0 0.253512 0.00525889 0 0.105094 -0.000426727 0 0.266907 -0.119191 0 + 0.268172 -0.00651075 0 0.20902 -0.00247054 0 0.257154 0.00792737 0 0.252966 -0.00682841 0 + 0.245542 0.00397284 0 0.177143 0.00172254 0 0.248351 0.0045078 0 0.277151 0.0203688 0 + 0.0555304 -0.0197893 0 0.256087 0.00815556 0 0.261575 0.0223157 0 0.30587 -0.0258376 0 + 0.25432 0.00850992 0 0.247042 0.00618099 0 0.0474784 7.91183e-05 0 0.0413539 -5.5109e-05 0 + 0.336661 0.0334101 0 0.221774 0.0265597 0 0.278167 -0.0202259 0 0.251518 0.00801911 0 + 0.124708 -0.0201792 0 0.253328 0.00737928 0 0.354922 -0.0130274 0 0.14193 0.00129832 0 + 0.253506 0.00968943 0 0.192669 -0.00167015 0 0.223436 -0.00426131 0 0.0786653 0.000326441 0 + 0.255949 0.00737246 0 0.154652 -0.01556 0 0.256712 -0.00867486 0 0.220494 -0.00401727 0 + 0.0203868 2.31011e-05 0 0.0301997 0.00818412 0 0.162283 0.00135441 0 0.253163 0.00622064 0 + 0.170328 -0.0385345 0 0.246217 -0.00774003 0 0.242843 -0.0069992 0 0.170299 0.00478275 0 + 0.267569 0.00150337 0 0.252986 0.00627219 0 0.194453 -0.00235782 0 0.0110202 -2.26394e-05 0 + 0.262262 -0.00879739 0 0.249677 0.00330349 0 0.271517 -0.00243076 0 0.177306 0.00159332 0 + 0.0414616 -6.72294e-05 0 0.144863 0.00134804 0 0.201684 0.0123129 0 0.0802096 -3.0887e-05 0 + 0.208169 0.0010594 0 0.271857 -0.00220138 0 0.170852 0.00255833 0 0.145196 -0.00487099 0 + 0.243398 0.00432386 0 0.23761 -0.0116122 0 0.179731 -0.00196056 0 0.270105 -0.0205334 0 + 0.00929224 0.000128619 0 0.202475 -0.0429181 0 0.167817 0.00188106 0 0.252937 0.0278204 0 + 0.0407756 -0.0127797 0 0.226477 0.0295304 0 0.256209 0.0078215 0 0.18128 -0.00299938 0 + 0.267601 -0.00913109 0 0.247281 0.0087477 0 0.162397 0.00180347 0 0.255193 0.00648718 0 + 0.272496 0.0173011 0 0.363939 0.0171761 0 0.00975121 4.24103e-06 0 0.24761 -0.00697405 0 + 0.270913 0.00121706 0 0.134363 0.000649127 0 0.128136 -0.000708673 0 0.0108427 2.0798e-05 0 + 0.0510036 -8.03358e-05 0 0.179778 0.108849 0 0.252242 -0.00823373 0 0.18933 -0.00320573 0 + 0.177888 -0.00160467 0 0.0501651 0.000116781 0 0.229152 -0.00381446 0 0.224248 0.0200476 0 + 0.147563 0.00593551 0 0.32113 0.123727 0 0.307294 0.158531 0 0.155607 0.0135548 0 + 0.2338 -0.00243633 0 0.253366 0.00912824 0 0.178154 -0.00376314 0 0.177853 0.00207254 0 + 0.251945 0.0050691 0 0.261784 -0.008807 0 0.340578 0.0423407 0 0.27121 -0.0090549 0 + 0.177941 -0.0204981 0 0.251408 0.00657957 0 0.233949 -0.00499235 0 0.153312 0.00197043 0 + 0.245511 0.00428557 0 0.302814 -0.0205766 0 0.188511 -0.00127281 0 0.255882 0.00705054 0 + 0.257731 -0.0114024 0 0.28544 -0.0199682 0 0.204432 -0.00187233 0 0.174812 0.00166421 0 + 0.0205202 -1.13081e-05 0 0.246617 0.0045862 0 0.256043 0.0084074 0 0.251777 0.0131865 0 + 0.255925 -0.039352 0 0.267748 -0.00464554 0 0.207826 -0.00358959 0 0.0500436 0.000126756 0 + 0.222803 -0.0509426 0 0.190519 0.00580622 0 0.0819881 -0.000192877 0 0.0406488 -4.7101e-05 0 + 0.126262 0.000953657 0 0.265313 -0.00113888 0 0.252742 0.00474688 0 0.17243 0.00134158 0 + 0.269428 -0.00922331 0 0.15891 0.00379258 0 0.270102 0.0469901 0 0.230772 0.0390633 0 + 0.23194 0.00465469 0 0.246903 0.00321293 0 0.187652 -0.0328273 0 0.241263 0.0121334 0 + 0.0972375 -0.00034864 0 0.274553 0.0185845 0 0.254015 0.00455325 0 0.0475243 8.06433e-05 0 + 0.253314 -0.00163027 0 0.243785 0.00466402 0 0.212669 0.00582569 0 0.17989 0.00312934 0 + 0.230201 0.00996782 0 0.226569 -0.00226497 0 0.268953 0.00140139 0 0.139546 -0.0278941 0 + 0.257795 -0.00852855 0 0.268014 -0.00471814 0 0.167396 0.00169877 0 0.254933 0.00877159 0 + 0.330208 -0.0393617 0 0.184904 0.00221835 0 0.198361 -0.00142376 0 0.242253 0.00377659 0 + 0.201349 -0.0025664 0 0.309801 0.19188 0 0.235359 0.0108801 0 0.153679 0.00147468 0 + 0.230256 -0.0374013 0 0.25713 0.00763621 0 0.253742 0.00805807 0 0.271065 -0.00238593 0 + 0.256726 0.00801562 0 0.186388 -0.00156371 0 0.151869 0.00111513 0 0.269774 0.0157451 0 + 0.256227 0.00749469 0 0.266356 -0.00214252 0 0.0532705 0.000395247 0 0.250438 -0.00756782 0 + 0.119598 -0.000593033 0 0.149389 0.000804552 0 0.0699011 -0.000165732 0 0.249821 0.00593466 0 + 0.172356 0.00307844 0 0.271398 -0.00215011 0 0.107441 -0.000454961 0 0.210593 -0.00291641 0 + 0.254441 0.0069682 0 0.0217778 7.6135e-05 0 0.187493 -0.00581558 0 0.0762402 -0.0238009 0 + 0.243759 -0.00632046 0 0.344202 0.0455129 0 0.245386 -0.00561417 0 0.25845 0.00859583 0 + 0.207229 0.00275525 0 0.0960609 -0.000345816 0 0.24915 0.00694496 0 0.177435 0.00190882 0 + 0.040247 6.40297e-05 0 0.142597 -0.000916542 0 0.255111 0.00475344 0 0.0211506 -1.38752e-05 0 + 0.177234 0.00180021 0 0.16107 0.000940588 0 0.0209726 -1.47276e-05 0 0.220633 0.00814393 0 + 0.204382 0.00388273 0 0.254762 -0.00807253 0 0.255788 0.00698646 0 0.186043 -0.0938926 0 + 0.0414073 -5.1832e-05 0 0.24539 0.00286045 0 0.0418687 -5.7698e-05 0 0.24597 0.0123096 0 + 0.259702 -0.0143762 0 0.248634 0.00763566 0 0.256345 0.00708178 0 0.25713 0.00837181 0 + 0.199517 0.00297874 0 0.24192 0.00276798 0 0.238186 0.00430723 0 0.244621 -0.00494298 0 + 0.242892 -0.012534 0 0.0109139 2.87865e-05 0 0.00951829 0.000114157 0 0.238796 0.00316148 0 + 0.259997 -0.00909393 0 0.251466 0.00467784 0 0.219696 -0.00173399 0 0.278986 -0.0403517 0 + 0.192271 0.00257286 0 0.267602 -0.00567211 0 0.0793109 -0.000225113 0 0.241082 -0.0180622 0 + 0.15366 0.00133768 0 0.252257 -0.00148304 0 0.161214 -0.00798925 0 0.257159 0.00788737 0 + 0.24152 -0.00413719 0 0.298805 0.107103 0 0.182983 -0.00190763 0 0.0500842 -7.63506e-05 0 + 0.284827 -0.00121789 0 0.272503 0.000901586 0 0.286447 -0.00114345 0 0.250367 -0.00626775 0 + 0.281103 0.0403586 0 0.236864 0.0037798 0 0.267737 -0.00558874 0 0.255728 0.00288998 0 + 0.200807 -0.00182778 0 0.204209 -0.0027039 0 0.318293 0.185499 0 0.239876 -0.00609094 0 + 0.239987 0.0034025 0 0.28108 -0.0422043 0 0.0488496 7.98724e-05 0 0.256235 0.0071521 0 + 0.232682 0.0033293 0 0.182857 -0.00161619 0 0.274574 0.0357996 0 0.257721 0.00858306 0 + 0.259559 -0.00162865 0 0.164276 0.00115645 0 0.0399677 4.58667e-05 0 0.265658 -0.00494233 0 + 0.257676 0.010603 0 -0.0101819 0.00246243 0 0.170765 0.00127849 0 0.144922 0.00120047 0 + 0.228381 0.00280893 0 0.278424 -0.0221134 0 0.274477 -0.021378 0 0.0380902 4.84303e-05 0 + 0.276331 0.000662822 0 0.216262 0.00726704 0 0.196162 -0.0019311 0 0.0537209 -0.0001219 0 + 0.199315 -0.0356416 0 0.224856 -0.00220913 0 0.188674 -0.00161567 0 0.254865 0.00506219 0 + 0.0835351 0.000232481 0 0.175057 0.00185076 0 0.253849 0.00509642 0 0.252596 0.00157182 0 + 0.117238 -0.000586693 0 0.245103 0.00325765 0 0.0656337 0.000138102 0 0.159338 0.00155636 0 + 0.273733 -0.00962696 0 0.25714 -0.187069 0 0.182382 -0.030913 0 0.261098 -0.00644238 0 + 0.254835 0.00692167 0 0.271996 -0.00298047 0 0.237522 0.00222634 0 0.267892 -0.00587328 0 + 0.265683 -0.00206791 0 0.196444 -0.00955312 0 0.250898 0.00513954 0 0.237423 0.00651071 0 + 0.316817 0.0298734 0 0.253391 0.00747318 0 0.255112 0.009944 0 0.267737 -0.00694683 0 + 0.240037 0.0112266 0 0.182673 0.00216109 0 0.276457 -0.0110541 0 0.159278 0.00142802 0 + 0.357713 0.0259086 0 0.252705 0.00452296 0 0.0193425 1.10437e-05 0 0.258409 0.00328547 0 + 0.244517 -0.00697243 0 -0.000308101 0.00105577 0 0.270891 -0.00289107 0 0.239988 0.00219956 0 + 0.102122 -0.000428612 0 0.271968 -0.00863219 0 0.197548 -0.0021804 0 0.191031 0.00222485 0 + 0.180727 0.00757351 0 0.257958 0.0108138 0 0.16737 0.00134207 0 0.279552 -0.0135679 0 + 0.0117146 5.34694e-05 0 0.260067 -0.00602028 0 0.210494 -0.00247533 0 0.184486 0.00165736 0 + 0.278899 0.0221889 0 0.220822 -0.00355778 0 0.25522 0.00885649 0 0.0413067 -5.61368e-05 0 + 0.172393 -0.0126592 0 0.251351 0.00664848 0 0.262112 0.0127449 0 0.198686 -0.00177349 0 + 0.263325 0.0012113 0 0.274135 0.000811594 0 0.265835 0.00116163 0 0.219915 -0.00281306 0 + 0.24278 0.00274644 0 0.0788346 -0.000215559 0 0.282246 0.0238622 0 0.259158 -0.0055947 0 + 0.216684 -0.00285722 0 0.24385 0.0022633 0 0.258136 0.0102959 0 0.222293 0.00203867 0 + 0.246766 -0.00561681 0 0.16983 0.00156375 0 0.254002 0.00528236 0 0.0506813 -7.99163e-05 0 + 0.261722 -0.0051502 0 0.242487 0.00311298 0 0.265102 0.0135486 0 0.259409 0.0012749 0 + 0.240935 0.00404191 0 0.255614 0.00498752 0 0.176844 -0.00163511 0 0.231206 -0.00243116 0 + 0.188201 -0.0169659 0 0.196969 -0.00341395 0 0.179229 0.00144059 0 0.258681 0.00347869 0 + 0.0104061 -1.09843e-06 0 0.182045 -0.00146163 0 0.0691113 -0.000148823 0 0.256308 0.00129718 0 + 0.254944 0.00523595 0 0.0390942 4.39488e-05 0 0.22508 -0.00230059 0 0.17517 -0.0015415 0 + 0.244637 0.00462777 0 0.267043 -0.00652372 0 0.37742 -0.012115 0 0.260962 0.00288927 0 + 0.284997 0.0475263 0 0.236829 -0.00801276 0 0.173554 -0.00171477 0 0.19992 -0.00200281 0 + 0.0193981 1.27526e-05 0 0.169948 0.00151296 0 0.269005 -0.0169391 0 0.268354 -0.00643578 0 + 0.257512 0.00338577 0 0.0380175 5.12071e-05 0 0.308188 -0.0269117 0 0.26042 -0.00473897 0 + 0.258632 0.00310975 0 0.235055 0.00541063 0 0.14783 0.00100508 0 0.219925 0.00631786 0 + 0.256075 0.00490561 0 0.250399 0.00476021 0 0.050874 -9.42581e-05 0 0.253437 0.00533375 0 + 0.26251 -0.00590575 0 0.167366 0.00150633 0 0.255092 0.00456968 0 0.273464 -0.0328731 0 + 0.116312 -0.000384941 0 0.0391187 4.40496e-05 0 0.266565 -0.019807 0 0.183046 -0.00175134 0 + 0.261725 -0.00553181 0 0.252606 0.00773163 0 0.258889 0.00334217 0 0.261044 -0.00514231 0 + 0.271026 -0.00879951 0 0.255683 0.00514957 0 0.145213 0.00110732 0 0.182456 -0.00171154 0 + 0.239629 0.00315065 0 0.181437 -0.00190617 0 0.181869 0.00182445 0 0.216817 -0.00202974 0 + 0.188938 -0.00210587 0 0.232749 0.0429415 0 0.167545 -0.00137661 0 0.256155 0.00468332 0 + 0.259261 0.00337504 0 0.249979 0.00827175 0 0.228856 -0.00604147 0 0.249109 0.00156754 0 + 0.261524 0.00180123 0 0.108185 -0.000485523 0 0.156238 -0.00258701 0 0.137242 0.000831497 0 + 0.198402 -0.00165573 0 0.256462 -0.00512753 0 0.254124 0.00463773 0 0.263252 -0.00509385 0 + 0.237768 0.0254896 0 0.150799 0.00142149 0 0.0750638 0.000187997 0 0.236705 0.00432477 0 + 0.253889 0.00712649 0 0.239042 0.00432755 0 0.256249 0.00480207 0 0.246398 0.00152744 0 + 0.241838 0.0136928 0 0.341605 -0.0396678 0 0.237646 0.00378412 0 0.262744 0.0134032 0 + 0.237135 0.00355812 0 0.267931 -0.00891396 0 0.120241 -0.000614324 0 0.201373 -0.00194898 0 + 0.271676 -0.00295828 0 0.260251 0.0104457 0 0.0499563 0.000102193 0 0.275022 -0.0104511 0 + 0.290845 0.0233743 0 0.130835 -0.000917445 0 0.206117 -0.00179303 0 0.24393 0.00431059 0 + 0.258961 0.00348792 0 0.146764 -0.00126547 0 0.139944 0.000849975 0 0.249951 0.00440327 0 + 0.260072 -0.00555979 0 0.0471779 7.67368e-05 0 0.206256 -0.0013531 0 0.258894 0.00346887 0 + 0.248584 0.00489927 0 0.156157 0.00201454 0 0.196003 -0.00205637 0 0.254767 0.00671762 0 + 0.262643 -0.00864074 0 0.0479524 7.04211e-05 0 0.250264 0.006829 0 0.0231254 0.000120992 0 + 0.207073 -0.00524163 0 0.201937 -0.00314043 0 0.0794434 0.00067545 0 0.252819 0.00200571 0 + 0.0104373 -5.11657e-06 0 0.185766 -0.00182569 0 0.258708 -0.00151492 0 0.26561 -0.00533175 0 + 0.253984 0.00474569 0 0.267238 -0.00657942 0 0.159672 -0.0012181 0 0.279772 0.0249944 0 + 0.247984 0.00454359 0 0.236593 -0.0407148 0 0.185103 -0.00177868 0 0.262738 -0.00528224 0 + 0.265056 0.00163946 0 0.258274 -0.00428602 0 0.228343 0.00266927 0 0.261897 -0.00636219 0 + 0.273058 -0.0293783 0 0.233625 0.00333829 0 0.238331 0.00403782 0 0.238363 0.00136942 0 + 0.230008 0.00127856 0 0.154596 0.00117137 0 0.176647 -0.00153363 0 0.0407833 -4.86205e-05 0 + 0.215009 -0.00814969 0 0.256117 0.00504528 0 0.259616 0.00305647 0 0.256961 0.00365469 0 + 0.238746 0.00298061 0 0.0390108 4.6796e-05 0 0.26126 -0.00260386 0 0.195806 0.0257294 0 + 0.273005 -0.0260224 0 0.24101 0.00217937 0 0.249677 0.0019927 0 0.273018 -0.00929772 0 + 0.236445 0.00224133 0 -0.00568262 0.00329278 0 0.103578 -0.000432699 0 0.26123 -0.00472618 0 + 0.236133 0.00431754 0 0.238992 0.00264629 0 0.206405 -0.00246062 0 0.190214 0.00251963 0 + 0.260203 0.00261836 0 0.28628 -0.00114474 0 0.243993 0.00463435 0 0.095056 0.05509 0 + 0.225638 -0.0106939 0 0.134568 -0.00078603 0 0.188327 -0.00180883 0 0.173024 0.00131159 0 + 0.170366 -0.00143572 0 0.239732 0.00279441 0 0.256104 0.00479379 0 0.193452 0.00461621 0 + 0.0383126 4.64318e-05 0 0.246015 0.00509329 0 0.214903 -0.00147707 0 0.272009 -0.00274158 0 + 0.268173 -0.0056241 0 0.0949613 0.000303729 0 0.190736 0.00176754 0 0.251557 0.00801071 0 + 0.243957 4.42007e-05 0 0.208776 -0.0033572 0 0.255878 0.0047114 0 0.17151 -0.00173783 0 + 0.263911 -0.00506461 0 0.260919 -0.00597293 0 0.217446 -0.00404988 0 0.248452 0.00861081 0 + 0.223015 -0.00378946 0 0.0770826 -0.000196551 0 0.267112 0.01519 0 0.254349 0.00423347 0 + 0.259242 0.00184209 0 0.0500774 -8.07932e-05 0 0.25413 0.00427174 0 0.165387 -0.00152992 0 + 0.243328 0.0040202 0 0.255841 0.00272861 0 0.257617 0.00370512 0 0.256256 0.00492911 0 + 0.256049 0.00683603 0 0.248307 0.00610695 0 0.230353 0.00214991 0 0.0492947 7.52755e-05 0 + 0.0965196 0.00054297 0 0.183505 0.00102057 0 0.252884 0.00411957 0 0.0210759 -1.74144e-05 0 + 0.267289 -0.00545054 0 0.2654 -0.00654725 0 0.258047 0.0037129 0 0.202159 -0.00206601 0 + 0.256469 -0.0251579 0 0.261818 -0.00511641 0 0.275559 -0.0106292 0 0.202265 -0.00222745 0 + 0.15081 0.00128283 0 0.271224 -0.00835174 0 0.267901 -0.0056558 0 0.267254 -0.00556537 0 + 0.157255 -0.00136225 0 0.194565 -0.00161377 0 0.210831 -0.00218457 0 0.096801 -0.000366692 0 + 0.257714 0.00321724 0 0.252708 0.00452345 0 0.163156 0.00128835 0 0.246086 -0.00497643 0 + 0.256812 0.00381624 0 0.0753032 0.0136871 0 0.247607 0.00389968 0 0.110394 0.000371504 0 + 0.2567 0.00458627 0 0.189839 0.00105306 0 0.266014 -0.00608557 0 0.255665 0.00465301 0 + 0.249675 0.00408711 0 0.262483 -0.00548735 0 0.249615 0.00444753 0 0.170389 0.00193543 0 + 0.229558 -0.00237272 0 0.204249 -0.00180695 0 0.263211 -0.00585101 0 0.219912 -0.00152108 0 + 0.188738 0.0306022 0 0.241927 0.00396571 0 0.233107 0.00283041 0 0.25829 0.0037062 0 + 0.253141 0.00138034 0 0.266062 -0.00527986 0 0.169949 0.00175654 0 0.0738853 0.000184038 0 + 0.155158 -0.00306586 0 0.282049 0.0315357 0 0.256739 0.0238687 0 0.156808 0.00105957 0 + 0.0403796 -5.76027e-05 0 0.134815 0.000783041 0 0.160015 0.0012703 0 0.258301 0.00368315 0 + 0.105242 0.000941697 0 0.155068 0.00115893 0 0.260389 -0.00251845 0 0.330523 -0.117455 0 + 0.141912 0.00114778 0 0.226316 -0.00159711 0 0.120127 0.000600514 0 0.247457 0.00422021 0 + 0.26789 -0.00628366 0 0.226813 -0.00235948 0 0.240876 0.00151544 0 0.255233 0.00294997 0 + 0.234394 0.00124927 0 0.178264 0.00150739 0 0.257684 0.0027217 0 0.250111 0.00153967 0 + 0.167491 0.00145487 0 0.284183 -0.000882282 0 0.25747 0.00385427 0 0.179983 0.000952159 0 + 0.143253 -0.00175563 0 0.266491 -0.00554701 0 0.116037 -0.000568309 0 0.0199592 -0.00276168 0 + 0.2442 0.00138349 0 0.153294 0.00109074 0 0.173366 0.00260119 0 0.259187 0.00336365 0 + 0.257629 0.0015025 0 0.118319 -0.000576767 0 0.242138 -0.00455718 0 0.282905 -0.0014763 0 + 0.143928 0.000958305 0 0.258088 0.00364588 0 0.159681 0.00129737 0 0.123248 0.000645219 0 + 0.265169 -0.00503611 0 0.257234 0.00126493 0 0.259016 0.00302516 0 0.251405 0.00368114 0 + 0.210311 -0.00656233 0 0.263533 -0.00473816 0 0.252581 0.00418122 0 0.246075 -0.00959267 0 + 0.257897 0.00384955 0 0.0192297 -8.54346e-06 0 0.213628 0.00105083 0 0.282914 -0.00149883 0 + 0.235639 0.00267364 0 0.251728 -0.00624311 0 0.254395 -0.00740237 0 0.361392 0.113165 0 + 0.0873099 0.016813 0 0.268144 -0.00641235 0 0.256281 0.00684792 0 0.201717 0.00261435 0 + 0.25097 0.00401356 0 0.235718 0.00123592 0 0.258468 -0.00279326 0 0.142233 0.00105406 0 + 0.169059 -0.00101183 0 0.271512 -0.00132202 0 0.204049 -0.00149036 0 0.247397 0.00720871 0 + 0.217991 0.00110871 0 0.0383673 3.34346e-05 0 0.25685 -0.0135422 0 0.204663 -0.00230449 0 + 0.239979 0.00355548 0 0.248148 0.00563363 0 0.258116 0.00382995 0 0.261743 0.0119713 0 + 0.263235 0.0601505 0 0.26069 -0.00217643 0 0.169562 0.00132619 0 0.272356 -0.00252268 0 + 0.233323 0.00315724 0 0.264058 -0.00529961 0 0.248153 -0.0206847 0 0.167729 0.00142394 0 + 0.181001 0.00131307 0 0.239101 0.00128046 0 0.259087 0.00303064 0 0.230766 0.00120019 0 + 0.211249 -0.00225687 0 0.216911 -0.00273389 0 0.16597 0.000785851 0 0.258107 0.00379583 0 + 0.0379188 5.33197e-05 0 0.194704 -0.00292617 0 0.262632 -0.0030944 0 0.263392 -0.00626331 0 + 0.192182 -0.00208553 0 0.201725 -0.00200718 0 0.223701 0.00116017 0 0.264954 -0.00566414 0 + 0.155915 0.00113885 0 0.251356 0.00396246 0 0.142652 0.000889346 0 0.180036 -0.00116069 0 + 0.0192393 1.32279e-05 0 0.269708 0.00102041 0 0.154787 0.00068504 0 0.244413 0.00328324 0 + 0.244658 0.00373676 0 0.250563 0.00195908 0 0.16595 0.00121463 0 0.20047 -0.00170572 0 + 0.257861 0.00374825 0 0.00963819 4.5217e-06 0 0.258185 0.00343037 0 0.265382 -0.00637681 0 + 0.284515 -0.00113934 0 0.229482 0.00267396 0 0.236861 0.00210918 0 0.144558 0.000958218 0 + 0.169947 -0.00141413 0 0.268507 0.000707859 0 0.163445 -0.00131322 0 0.273299 -0.00304654 0 + 0.22961 0.00296664 0 -0.0101359 -0.00402393 0 0.230616 -0.00186953 0 0.103182 -0.00108691 0 + 0.259157 0.00336318 0 0.0223207 0.000104898 0 0.157608 0.00104097 0 0.0912811 0.000325234 0 + 0.162139 -0.00125545 0 0.283507 -0.00137775 0 0.267144 -0.0141427 0 0.219587 0.00110475 0 + 0.186187 -0.00146998 0 0.0505101 -7.78411e-05 0 0.247108 0.00393239 0 0.263856 -0.00543635 0 + 0.258817 0.00333979 0 0.272543 0.0180419 0 0.247163 0.00193713 0 0.258256 0.00330234 0 + 0.18241 0.00161609 0 0.266413 -0.00460103 0 0.260327 0.00305498 0 0.244927 0.00634042 0 + 0.229292 0.00152814 0 0.242735 0.00403435 0 0.273467 -0.00306926 0 0.342708 -0.0877352 0 + 0.111145 -0.000474258 0 0.14449 0.000884473 0 0.140116 0.000877355 0 0.279268 -0.00209253 0 + 0.0844423 -0.000204672 0 0.10535 0.000439473 0 0.19605 -0.0023091 0 0.18114 -0.0016267 0 + 0.257638 0.00359522 0 0.0380243 4.40233e-05 0 0.259044 0.00348747 0 0.269079 -0.00404215 0 + 0.0966089 -0.000344856 0 0.0117408 4.65e-05 0 0.0993347 0.000392913 0 0.308593 0.0319608 0 + 0.107773 -0.000494767 0 0.251796 0.00318434 0 0.238533 -0.00698625 0 0.283468 -0.00135234 0 + 0.257509 0.0032505 0 0.263302 -0.00346529 0 0.266114 -0.00561339 0 0.241074 0.00433696 0 + 0.256522 0.00319091 0 0.197012 0.00114142 0 0.24007 -0.0143635 0 0.116825 0.00049648 0 + 0.0636206 0.000146105 0 0.00892495 -7.35823e-05 0 0.0936173 -0.000372781 0 0.268654 -0.00460296 0 + 0.250052 -0.0095628 0 0.2695 -0.00423663 0 0.279097 -0.00209688 0 0.264176 -0.00633736 0 + 0.245196 0.00305336 0 0.260777 -0.00322727 0 0.24112 0.0051214 0 0.242853 0.00565936 0 + 0.255 -0.00323672 0 0.000802019 0.00735117 0 0.177417 -0.00157739 0 0.272722 -0.0025583 0 + 0.233937 -0.00401536 0 0.236489 0.00298945 0 0.245274 0.00557113 0 0.171413 0.00124736 0 + 0.253915 0.00127937 0 0.211665 -0.00194775 0 0.020327 1.7471e-05 0 0.0204047 1.81141e-05 0 + 0.0785742 -0.000210608 0 0.190993 0.00111459 0 0.259161 -0.0051044 0 0.145434 0.00087317 0 + 0.233091 0.00213979 0 0.234624 0.00400337 0 0.265113 -0.00592281 0 0.256409 0.00266945 0 + 0.260037 0.0031774 0 0.173469 -0.00143034 0 0.212274 -0.00264896 0 0.266335 -0.00639113 0 + 0.0470823 8.03575e-05 0 0.254111 0.00135024 0 0.000135847 0.00421273 0 0.184548 -0.00174403 0 + 0.263403 -0.00418388 0 0.248111 0.00190764 0 0.0725309 0.000199774 0 0.257372 0.00368623 0 + 0.136862 -0.000826053 0 0.171861 0.00136587 0 0.0384441 5.49653e-05 0 0.241701 0.00313172 0 + 0.00944297 4.60397e-08 0 0.0188023 8.01839e-06 0 0.259755 0.000928167 0 0.284025 -0.00104077 0 + 0.101367 -0.000436317 0 0.0889913 -0.000332171 0 0.262759 0.00245743 0 0.262744 -0.00796304 0 + 0.0182699 1.11127e-05 0 0.271454 0.000641738 0 0.0984428 -0.000404821 0 0.18707 -0.00169212 0 + 0.256834 0.00153895 0 0.233314 0.00253342 0 0.266757 -0.00545052 0 0.24599 0.00426161 0 + 0.174067 -0.00147938 0 0.160063 0.00107304 0 0.259909 -0.00317477 0 0.264895 -0.00651324 0 + 0.0109406 3.41723e-05 0 0.266037 -0.00549891 0 0.171981 0.000861301 0 0.175289 -0.00128002 0 + 0.186263 -0.001517 0 0.252844 -0.00348171 0 0.24445 0.00187738 0 0.240278 0.00404633 0 + 0.176539 0.00143789 0 0.252944 0.000892012 0 0.253092 -0.00747613 0 0.13901 0.000533724 0 + 0.161707 0.00102085 0 0.251352 0.00125725 0 0.260945 0.0027912 0 0.267894 0.0013441 0 + 0.228574 0.00240473 0 0.146809 0.000780171 0 0.206469 -0.00260656 0 0.260002 0.00317589 0 + 0.182379 -0.00154378 0 0.267287 -0.00256026 0 0.248941 0.000897444 0 0.114298 -0.000489505 0 + 0.262673 -0.00469365 0 0.165282 0.00123347 0 0.158528 0.0011096 0 0.255494 0.00635281 0 + 0.250277 0.00591573 0 0.257939 0.00338888 0 0.157797 0.00112138 0 0.194453 -0.00150549 0 + 0.294632 -0.0341674 0 0.258542 0.00343337 0 0.271981 -0.00313036 0 0.266337 -0.0119349 0 + 0.236514 0.00282292 0 0.271 -0.0012464 0 0.154097 -0.0011045 0 0.187425 -0.0010111 0 + 0.257125 0.00332807 0 0.262407 0.00256666 0 0.230155 -0.00257685 0 0.150762 0.000999662 0 + 0.264437 0.00169885 0 0.18275 0.00157976 0 0.177193 0.00167085 0 0.194488 -0.00155923 0 + 0.259241 0.00315149 0 0.249276 0.00312126 0 0.256101 0.00326023 0 0.147377 0.000841258 0 + 0.267514 -0.00538041 0 0.175285 -0.00131789 0 0.265061 -0.00570303 0 0.162879 0.00119426 0 + 0.268054 -0.00552805 0 0.261035 0.00279667 0 0.174216 0.000874521 0 0.264064 -0.00552203 0 + 0.234887 0.000864586 0 0.216387 -0.00810509 0 0.281749 -0.00146261 0 0.207663 0.030684 0 + 0.112398 -0.000525683 0 0.116861 -0.000590215 0 0.010016 -1.53383e-06 0 0.145768 0.0005999 0 + 0.0652112 0.015138 0 0.235952 0.00109502 0 0.231324 0.00394567 0 0.203341 -0.0345326 0 + 0.232209 -0.00301813 0 0.192548 -0.00130284 0 0.254274 0.00282455 0 0.040316 8.59685e-05 0 + 0.254817 0.00318395 0 0.238447 0.00196644 0 0.148992 0.000956805 0 0.00266481 -0.00189771 0 + 0.251609 0.00132695 0 0.24176 0.00294496 0 0.260848 0.00185448 0 0.270978 -0.00377326 0 + 0.248181 0.00139761 0 0.238439 0.000893645 0 0.261168 -0.000255728 0 0.193445 -0.00182099 0 + 0.243107 0.000905398 0 0.284359 -0.000919563 0 0.275197 -0.00239672 0 0.0695476 -0.00120372 0 + 0.232354 0.00105509 0 0.240647 0.00111719 0 0.182358 -0.00115628 0 0.0898087 -0.000329963 0 + 0.252572 0.00275445 0 0.271407 -0.00358869 0 0.0711654 -0.000170124 0 0.244456 0.00307985 0 + 0.263146 0.00170588 0 0.176074 0.00146659 0 0.266113 0.00174734 0 0.248903 -0.0025535 0 + 0.143556 0.000887959 0 0.267719 -0.00289987 0 0.266058 -0.00480272 0 0.252238 0.00646472 0 + 0.245678 0.00267954 0 0.236641 0.00266383 0 0.271803 -0.00341352 0 0.0113464 3.90887e-05 0 + 0.12677 0.000677431 0 0.159285 0.00109438 0 0.252249 0.00639439 0 0.19315 -0.00177299 0 + 0.0472081 7.91016e-05 0 0.271626 -0.00310269 0 0.271835 0.00108709 0 0.15929 0.000993602 0 + 0.27221 -0.00322684 0 0.270976 -0.00357892 0 0.279628 -0.00109514 0 0.0923944 -0.000357922 0 + 0.26303 0.00231782 0 0.249079 0.00384327 0 0.265892 0.00115316 0 0.263173 -0.00517443 0 + 0.234968 0.00131966 0 0.112884 -0.00577097 0 0.108326 -0.000484767 0 0.24349 0.00510298 0 + 0.211228 -0.00104058 0 0.259252 -0.00464629 0 0.081345 0.000589237 0 0.204039 -0.00167887 0 + 0.237285 0.00108156 0 0.272612 -0.00303275 0 0.26317 0.00196435 0 0.239663 0.00379087 0 + 0.204123 -0.00174241 0 0.263596 0.00218353 0 0.261439 0.00202544 0 0.262317 0.00260868 0 + 0.165493 0.000643713 0 0.177104 -0.000895716 0 0.146313 -0.000975637 0 0.263792 0.00201232 0 + 0.253449 0.00328229 0 0.254011 -0.00355126 0 0.282234 -0.00132572 0 0.274752 -0.00276284 0 + 0.270471 0.00120038 0 0.246086 0.00126841 0 0.136184 0.00078375 0 0.273678 -0.0259579 0 + 0.174648 -0.000900847 0 0.128132 -0.000627587 0 0.265329 -0.00469854 0 0.23978 0.000880354 0 + 0.284421 -0.00110909 0 0.0374452 4.74068e-05 0 0.271646 -0.00318663 0 0.149869 0.000947153 0 + 0.0775279 0.0216983 0 0.246972 0.00218965 0 0.23899 0.00184543 0 0.248937 -0.00763343 0 + 0.192355 -0.00146026 0 0.254654 -0.00228494 0 0.186402 -0.00123355 0 0.247561 0.00318002 0 + 0.251928 0.00279964 0 0.209947 0.000649479 0 0.229133 0.00215558 0 0.226227 -0.00146692 0 + 0.263056 -0.00375807 0 0.13766 0.000719568 0 0.120977 0.000482854 0 0.195725 -0.0018797 0 + 0.13396 0.00059628 0 0.262155 -0.0044363 0 0.21702 -0.0021098 0 0.0108546 2.38746e-05 0 + 0.265872 -0.00451873 0 0.262716 0.00239316 0 0.266926 0.00163351 0 0.0935604 0.000350565 0 + 0.266491 0.00173721 0 0.262671 0.0025084 0 0.253672 0.00287632 0 0.0465066 7.58514e-05 0 + 0.0802505 -0.000242596 0 0.194587 -0.00134281 0 0.269356 -0.00438427 0 0.254846 -0.00302851 0 + 0.2393 0.00083309 0 0.255541 -0.0107188 0 0.174329 0.00123971 0 0.0929548 -0.000352892 0 + 0.257112 0.00278941 0 0.0732638 0.000202106 0 0.234004 0.00189986 0 0.243957 0.000842017 0 + 0.180203 -0.00111866 0 0.181144 -0.000957054 0 0.269584 0.00122381 0 0.265367 0.00198925 0 + 0.174891 0.001614 0 0.270384 -0.00781 0 0.00933161 6.31034e-06 0 0.190965 0.00147194 0 + 0.259608 0.00253396 0 0.236417 0.0014782 0 0.224501 0.00109125 0 0.0368519 5.99299e-05 0 + 0.260046 0.00130268 0 0.182006 -0.00128982 0 0.14736 0.00100876 0 0.272355 -0.00277123 0 + 0.197807 -0.00511209 0 0.22012 -0.00213496 0 0.230759 0.00203024 0 0.249911 0.00271724 0 + 0.186604 -0.00160956 0 0.269051 0.00106704 0 0.244876 0.00198192 0 0.161617 -0.000999053 0 + 0.279335 -0.00104299 0 0.272239 -0.00210671 0 0.128856 -0.000715114 0 0.273012 -0.0028333 0 + 0.180011 -0.00149301 0 0.268445 -0.00453993 0 0.236857 0.0025121 0 0.248065 0.00277775 0 + 0.268344 0.00123891 0 0.183235 -0.000988588 0 0.265495 0.00182185 0 0.0452513 -6.67154e-05 0 + 0.260292 0.00205059 0 0.234777 -0.00340822 0 0.29021 0.026983 0 0.250538 -0.0168526 0 + 0.242801 0.00158668 0 0.158963 -0.00118956 0 0.148131 0.000960498 0 0.270541 -0.00391758 0 + 0.184935 -0.000800597 0 0.205819 -0.001007 0 0.137215 0.000782035 0 0.272968 -0.00212394 0 + 0.271013 -0.00374764 0 0.150014 0.000717382 0 0.256721 0.00197094 0 0.2638 0.00164963 0 + 0.215294 0.00104875 0 0.224443 0.00276647 0 0.14179 0.000849089 0 0.225739 0.00193516 0 + 0.282091 -0.00129149 0 0.1693 -0.00097542 0 0.189889 0.0208571 0 0.168589 -0.00132538 0 + 0.265815 -0.00682004 0 0.0385139 -6.7022e-05 0 0.272111 -0.00168821 0 0.260073 -0.00457571 0 + 0.23382 0.00374435 0 0.188284 0.00938635 0 0.148336 0.000615909 0 0.247765 0.00297217 0 + 0.245324 -0.0123768 0 0.186156 -0.00142277 0 0.271944 -0.00341227 0 0.274944 -0.00230664 0 + 0.232064 0.000779421 0 0.0169421 9.59324e-05 0 0.172932 -0.00130793 0 0.145401 0.000450519 0 + 0.277625 -0.00231866 0 0.188897 -0.00166246 0 0.264187 -0.00408322 0 0.2715 -0.00357811 0 + 0.21496 -0.00197623 0 0.252964 0.00333859 0 0.235763 0.000807162 0 0.00904967 7.39449e-05 0 + 0.26465 0.00213292 0 0.234541 0.00178734 0 0.159002 0.000816134 0 0.275155 -0.00258591 0 + 0.24217 0.00260006 0 0.261848 0.00241596 0 0.28163 -0.0014311 0 0.179013 -0.000727713 0 + 0.2613 0.00213671 0 0.140826 0.000849546 0 0.229756 0.00240348 0 0.235916 0.00335348 0 + 0.240641 0.000820008 0 0.272395 -0.00323375 0 0.0622131 -0.000131768 0 0.269637 -0.0042016 0 + 0.202396 -0.000954813 0 0.179679 -0.00171193 0 0.146098 -0.000971077 0 0.176952 -0.000704248 0 + 0.226615 -0.0026886 0 0.276605 -0.00246151 0 0.272831 -0.00304469 0 0.142763 0.00084088 0 + 0.265016 -0.00353087 0 0.166219 -0.000618026 0 0.0912468 -0.000340473 0 0.255736 -0.00239558 0 + 0.25991 0.00213035 0 0.158591 -0.00106889 0 0.212968 -0.00106793 0 0.180087 -0.00140766 0 + 0.27499 -0.00278334 0 0.272212 -0.00197389 0 0.273934 -0.00204774 0 0.0402307 -5.14563e-05 0 + 0.233168 0.00352497 0 0.128647 0.000686251 0 0.232069 0.00283015 0 0.252194 0.00215808 0 + 0.172926 -0.00127269 0 0.224473 -0.00274613 0 0.151855 0.000500259 0 0.146769 0.00101193 0 + 0.280554 -0.00189504 0 0.244337 0.00211868 0 0.258422 0.00210983 0 0.256546 -0.00357846 0 + 0.234248 0.00212879 0 0.257463 0.00192427 0 0.225645 0.00278209 0 0.264182 0.0019476 0 + 0.191342 -0.00191111 0 0.195131 -0.00177816 0 0.0184132 1.54877e-05 0 0.274325 -0.00293056 0 + 0.247323 0.00281258 0 0.226924 -0.00306643 0 0.26128 -0.00434455 0 0.183643 -0.0016839 0 + 0.258135 -0.00453651 0 0.161172 -0.00119861 0 0.274569 -0.00206237 0 0.27433 -0.00293822 0 + 0.165895 -0.0011711 0 0.276644 -0.00246463 0 0.267146 -0.00286164 0 0.160576 0.000562892 0 + 0.237164 0.000795752 0 0.184051 0.0018829 0 0.257323 -0.00395819 0 -0.00807388 0.00475481 0 + 0.19252 -0.00161749 0 0.261795 -0.00459459 0 0.268251 -0.00322874 0 0.277765 -0.00232241 0 + 0.228518 0.00295536 0 0.274684 -0.00203122 0 0.194922 -0.00218287 0 0.264412 0.000761338 0 + 0.271094 0.000852232 0 0.275548 0.000677586 0 0.272714 -0.00230224 0 0.275171 -0.00233822 0 + 0.261674 0.00170499 0 0.264778 -0.0047261 0 0.158706 -0.00104393 0 0.0176941 0.000167936 0 + 0.228789 0.00311172 0 0.154211 0.000941281 0 0.172957 -0.00123621 0 0.189117 -0.000815604 0 + 0.261527 -0.00226723 0 0.209913 -0.00196597 0 0.0117664 2.30653e-05 0 0.194689 -0.00166854 0 + 0.231548 0.00112574 0 0.255911 -0.00308376 0 0.246069 0.00221957 0 0.0101263 -4.18174e-06 0 + 0.0196855 -8.97673e-06 0 0.167853 0.013277 0 0.155128 0.000919778 0 0.257759 0.00216251 0 + 0.236981 0.00156078 0 0.173119 -0.00116349 0 0.235829 0.00252385 0 0.275892 -0.00262713 0 + 0.258978 0.000837662 0 0.275293 -0.00259292 0 0.175735 -0.00145257 0 0.260403 -0.00246774 0 + 0.159223 -0.000962705 0 0.283974 -0.00122984 0 0.161087 -0.00111086 0 0.124278 0.000645884 0 + 0.131332 0.000747691 0 0.259296 0.00218879 0 0.269764 -0.00314963 0 0.133358 0.000746585 0 + 0.260737 0.00219969 0 0.192424 -0.00156464 0 0.257739 0.00306604 0 0.129777 0.000684074 0 + 0.00889306 5.712e-06 0 0.189452 -0.00104302 0 0.244969 -0.000159098 0 0.270367 -0.00319685 0 + 0.275006 -0.00277906 0 0.239935 0.00263 0 0.151682 0.000912494 0 0.252117 0.0421462 0 + 0.166589 0.00106979 0 0.266317 0.000490146 0 0.232096 0.00268158 0 0.161175 -0.00108431 0 + 0.168323 -0.00121465 0 0.273079 -0.00301993 0 0.199207 -0.00189099 0 0.160524 -0.00125151 0 + 0.263425 -0.00315016 0 0.260673 0.0028903 0 0.254894 0.00125031 0 0.262276 -0.00369497 0 + 0.262968 0.000518463 0 0.186209 -0.00133002 0 0.261337 -0.00250747 0 0.0198683 -1.6863e-05 0 + 0.220125 0.00258445 0 0.263496 0.000789409 0 0.205728 -0.00213236 0 0.258473 -0.00308662 0 + 0.230875 -0.0120122 0 0.232223 0.0025387 0 0.26121 -0.00377945 0 0.264982 -0.00317506 0 + 0.259929 0.00176933 0 0.234693 0.00200498 0 0.0910781 -0.000328992 0 0.269907 -0.00399756 0 + 0.249093 0.00213767 0 0.0177464 6.49544e-06 0 0.262049 0.0019628 0 0.162589 0.00132662 0 + 0.200208 -0.000970186 0 0.224491 -0.00194627 0 0.267146 -0.00374485 0 0.274212 -0.00291482 0 + 0.265171 0.00177653 0 0.0349099 3.02412e-05 0 0.267699 -0.00318797 0 0.155277 0.00108091 0 + 0.175502 -0.000527968 0 0.264661 0.00184172 0 0.0193371 1.2346e-05 0 0.019292 1.26933e-05 0 + 0.266032 -0.00178278 0 0.239701 0.00153372 0 0.0191948 1.28995e-05 0 0.21846 -0.00244238 0 + 0.179687 -0.00133055 0 0.236651 0.000752931 0 0.257704 0.00228268 0 0.172323 0.000950918 0 + 0.189007 -0.00113158 0 0.235751 0.00157624 0 0.0645367 2.18271e-05 0 0.284273 -0.00133676 0 + 0.257652 0.00810691 0 0.156021 0.00107149 0 0.240453 0.00206491 0 0.188349 -0.00146905 0 + 0.173837 -0.00100983 0 0.194741 -0.000891138 0 0.241513 0.000763072 0 0.258487 -0.00389968 0 + 0.25996 0.00179283 0 0.256032 0.0021294 0 0.248455 0.00102031 0 0.23297 0.000728322 0 + 0.264933 0.00127448 0 0.262596 0.00203012 0 0.018118 9.90727e-06 0 0.00918792 4.00261e-06 0 + 0.265818 0.00142388 0 0.276095 -0.00199405 0 0.0201199 -1.74268e-05 0 0.0191608 1.05983e-05 0 + 0.00960882 1.13917e-06 0 0.268152 0.00143711 0 0.275513 -0.00198223 0 0.181977 -0.00141923 0 + 0.169107 -0.00136996 0 0.253485 0.00186182 0 0.233565 0.00149972 0 0.272468 -0.000385664 0 + 0.199335 -0.00111021 0 0.176356 -0.00151186 0 0.274278 -0.00293732 0 0.239792 -0.00782666 0 + 0.20762 -0.0010345 0 0.0363259 -4.04888e-05 0 0.154355 0.000511042 0 0.254215 0.00267 0 + 0.182918 -0.000775735 0 0.175517 -0.00116629 0 0.140372 0.000747773 0 0.043664 4.78973e-05 0 + 0.271487 0.00114041 0 0.235194 0.0018866 0 0.284927 -0.00102276 0 0.260303 -0.00371086 0 + 0.100586 -0.000411985 0 0.277868 -0.00190306 0 0.277763 -0.00164734 0 0.185693 -0.000593345 0 + 0.209048 -0.00233386 0 0.245463 0.00185185 0 0.218813 0.00104508 0 0.236289 0.000853124 0 + 0.280111 -0.00193906 0 0.271748 -0.00191732 0 0.269698 -0.00402228 0 0.354089 -0.0334107 0 + 0.240971 0.00193658 0 0.272892 0.000796747 0 0.25802 0.000549544 0 0.238051 0.000741882 0 + 0.224359 0.00263677 0 0.227058 0.00193114 0 0.256237 -0.00387592 0 0.356825 -0.00808868 0 + 0.279974 -0.00198091 0 0.267154 0.00146904 0 0.200605 -0.00176643 0 0.264261 -0.00346726 0 + 0.151598 0.000993237 0 0.100698 -0.000403532 0 0.0847613 -0.000268472 0 0.258487 -0.00324296 0 + 0.164059 -0.000596158 0 0.152446 0.000980139 0 0.235363 -0.00249393 0 0.0995068 -0.000186836 0 + 0.254074 0.00056325 0 0.25664 0.00361444 0 0.167035 -0.000940861 0 0.262323 0.00233758 0 + 0.251084 0.000558694 0 0.18195 -0.00137573 0 0.232942 0.00111463 0 0.222975 0.00109775 0 + 0.276079 -0.00209152 0 0.250584 0.00135389 0 0.239222 0.00356221 0 0.265943 -0.0032518 0 + 0.260115 0.00288052 0 0.222496 -0.00236994 0 0.201584 -0.00216965 0 0.265055 -0.0025433 0 + 0.270862 0.00120228 0 0.281471 -0.00165755 0 0.233751 0.00104385 0 0.244228 0.0010151 0 + 0.264174 0.0021735 0 0.10275 -0.000391293 0 0.252636 0.00189926 0 0.245079 0.000570592 0 + 0.237658 0.00146284 0 0.262468 0.00132319 0 0.255237 0.000549328 0 0.145775 0.000797714 0 + 0.15313 0.000478887 0 0.125727 0.000651216 0 0.122212 -0.000490395 0 0.261055 0.0219046 0 + 0.240292 0.000568706 0 0.27729 -0.00230131 0 0.110479 0.000395339 0 0.00892898 2.96568e-06 0 + 0.202071 -0.000997987 0 0.10845 -0.000380718 0 0.26669 -0.00186529 0 0.0435795 5.01897e-05 0 + 0.273797 0.000717826 0 0.224379 0.00251196 0 0.276996 -0.00191224 0 0.0096909 3.54472e-06 0 + 0.0672057 0.000121895 0 0.268913 0.00142464 0 0.15554 0.000821418 0 0.317121 -0.0256395 0 + 0.266553 0.00153027 0 0.206475 -0.00192752 0 0.265509 0.0138267 0 0.272765 -0.00324465 0 + 0.0625753 -0.000127756 0 0.228664 0.00162329 0 0.179689 -0.00137242 0 0.259122 0.00260557 0 + 0.206147 -0.000962943 0 0.130399 0.00063356 0 0.0624167 -0.000128323 0 0.23352 0.00201719 0 + 0.262367 0.00165312 0 0.188357 -0.0013727 0 0.0365136 -4.32553e-05 0 0.250304 0.0018553 0 + 0.255469 -0.00350757 0 0.257451 0.0018218 0 0.281492 -0.00167968 0 0.118051 0.000461795 0 + 0.00890293 1.97171e-06 0 0.283692 -0.00149205 0 0.266271 0.00141718 0 0.285273 -0.000907533 0 + 0.271003 0.0011424 0 0.275534 -0.00207829 0 0.229959 0.00143712 0 0.224494 0.0023905 0 + 0.235746 0.00177319 0 0.263994 0.00212364 0 0.279592 -0.00177375 0 0.00919935 -2.51662e-05 0 + 0.152619 0.000892838 0 0.165964 -0.00114014 0 0.134418 0.000748895 0 0.229573 0.00253635 0 + 0.0177046 6.06865e-06 0 0.277517 -0.00210471 0 0.0198954 1.06005e-05 0 0.0199559 1.1273e-05 0 + 0.270323 0.00127167 0 0.270645 0.00105342 0 0.224722 0.00137999 0 0.0886164 -0.000272951 0 + 0.196489 0.00218327 0 0.182581 -0.00157985 0 0.257862 0.0025696 0 0.269532 0.00132118 0 + 0.144755 0.000813114 0 0.139881 0.000693679 0 0.161293 -0.00105572 0 0.26295 -0.00321123 0 + 0.017743 9.27933e-06 0 0.166363 -0.001046 0 0.232435 0.00240097 0 0.224829 0.00154655 0 + 0.229522 0.00203761 0 0.173253 -0.00112642 0 0.15388 -0.000961601 0 0.270867 0.000870975 0 + 0.185577 0.00103226 0 0.277531 -0.00192135 0 0.0703424 -0.000165191 0 0.244945 0.0012896 0 + 0.215956 -0.0007283 0 0.265366 0.00154989 0 0.267898 -0.00261453 0 0.240813 0.0101744 0 + 0.270269 0.000283194 0 0.137899 0.000605208 0 0.24154 0.00181416 0 0.272954 -0.00260136 0 + 0.188402 -0.00151806 0 0.180634 -0.00103671 0 0.126889 0.000653012 0 0.175466 -0.00139165 0 + 0.143635 0.000697151 0 0.252385 0.00123098 0 0.0446883 -6.55525e-05 0 0.241451 0.00104234 0 + 0.236684 0.000553608 0 0.109984 -0.000497445 0 0.06036 -9.52669e-05 0 0.210396 -0.00119452 0 + 0.124251 0.000545673 0 0.262181 -0.0031605 0 0.176081 0.000722139 0 0.168419 -0.00127622 0 + 0.279096 -0.00195664 0 0.255621 0.00148268 0 0.104329 0.000358082 0 0.258216 0.00177691 0 + 0.253361 0.00145802 0 0.274856 -0.00253395 0 0.276401 -0.00243977 0 0.150859 -0.00100516 0 + 0.280073 -0.00191851 0 0.217327 -0.00126304 0 0.262355 -0.00284985 0 0.27784 -0.00222036 0 + 0.0351391 2.84963e-05 0 0.266402 0.0018186 0 0.276967 -0.00170407 0 0.233527 0.000769762 0 + 0.283589 -0.00150766 0 0.00969121 -1.7091e-06 0 0.0196367 -1.72912e-05 0 0.279869 -0.00134773 0 + 0.195451 -0.0010946 0 0.248617 0.00123114 0 0.152706 -0.000512942 0 0.25797 0.000861514 0 + 0.268406 -0.00442152 0 0.271111 0.000425633 0 0.182649 0.00106613 0 0.15254 0.000736877 0 + 0.270039 0.00118511 0 0.0438657 -4.87918e-05 0 0.161536 -0.00122922 0 0.224696 0.0022721 0 + 0.22523 -0.00135499 0 0.0604265 -9.20931e-05 0 0.271745 0.000790031 0 0.264256 -0.00312543 0 + 0.244607 0.00146135 0 0.233651 0.00133279 0 0.0183897 1.53467e-05 0 0.00929794 7.82928e-06 0 + 0.277524 0.00043187 0 0.168442 -0.00114909 0 0.257706 -0.00334579 0 0.211125 -0.000675624 0 + 0.266921 0.00136404 0 0.27281 -0.00299589 0 0.223988 -0.000779566 0 0.269284 -0.00311527 0 + 0.153714 -0.000985283 0 0.277498 -0.00171299 0 0.267329 -0.00481629 0 0.241681 0.000558846 0 + 0.0687044 0.000180137 0 0.269512 0.00123747 0 0.262686 0.00221771 0 0.201235 -0.00114275 0 + 0.247852 0.00132363 0 0.238099 0.00101081 0 0.257547 -0.00318351 0 0.273073 0.000974843 0 + 0.272196 -0.00341218 0 0.179931 -0.000539093 0 0.268802 0.00111783 0 0.15187 0.000551615 0 + 0.256635 -0.00177726 0 0.018061 -8.52652e-06 0 0.27579 -0.00141784 0 0.116175 -0.000560582 0 + 0.247517 0.002045 0 0.167256 0.000834116 0 0.164363 0.000671355 0 0.238819 0.00280929 0 + 0.0454567 -6.87221e-05 0 0.263768 -0.00247596 0 0.162615 -0.000872966 0 0.17604 -0.00104509 0 + 0.0454496 -7.8553e-05 0 0.20614 -0.000625213 0 0.137403 0.000457363 0 0.273431 0.00025656 0 + 0.289256 -0.000744309 0 0.179397 -0.000564395 0 0.0708606 -0.000169341 0 0.183776 -0.0007106 0 + 0.25241 0.00148969 0 0.146201 -0.000868612 0 0.237957 0.00209318 0 0.28891 -0.000828391 0 + 0.0197462 1.60036e-05 0 0.0092587 5.02002e-06 0 0.168269 -0.000811015 0 0.156923 -0.000698191 0 + 0.260057 0.00201349 0 0.00894086 2.73735e-06 0 0.216638 0.00191674 0 0.160865 0.000686466 0 + 0.282055 -0.00152457 0 0.229969 0.00192399 0 0.209507 -0.00155193 0 0.263267 0.00127952 0 + 0.0611491 0.000104602 0 0.0683092 -0.000121161 0 0.254682 0.00151656 0 0.230472 0.00181485 0 + 0.145982 -0.000886603 0 0.219443 -0.000726982 0 0.161788 0.00053802 0 0.253167 0.000503162 0 + 0.27886 -0.00211357 0 0.248832 0.000510561 0 0.255703 -0.00174506 0 0.277532 -0.00221595 0 + 0.173254 0.000913468 0 0.0366849 -4.58351e-05 0 0.268097 0.00133853 0 0.153588 -0.00100795 0 + 0.280885 -0.0018496 0 0.0189645 -6.36844e-06 0 0.260067 -0.00273223 0 0.268391 -0.00633296 0 + 0.191075 -0.000840671 0 0.201472 -0.00109219 0 0.209731 -0.00189451 0 0.266001 0.00149326 0 + 0.272575 -0.00174932 0 0.0609025 -0.000104249 0 0.0177688 7.51021e-06 0 0.268123 0.00116874 0 + 0.0963397 0.000297753 0 0.173458 -0.000510331 0 0.275805 -0.00230912 0 0.177829 0.000939631 0 + 0.169847 -0.000908675 0 0.101716 -0.000115704 0 0.190016 -0.000957236 0 0.17497 -0.00086595 0 + 0.160871 0.00104739 0 0.25773 0.00141804 0 0.15868 0.000742198 0 0.234251 0.00140773 0 + 0.28231 -0.00166107 0 0.249045 0.00358359 0 0.179457 -0.000696809 0 0.284805 -0.000989832 0 + 0.149342 0.000538546 0 0.250098 0.000498475 0 0.276 0.000693824 0 0.184745 0.00140569 0 + 0.101523 -0.000419385 0 0.24984 0.00145869 0 0.170814 -0.000807225 0 0.285128 -0.000874157 0 + 0.141608 0.00054933 0 0.268593 0.00136219 0 0.278057 -0.00191406 0 0.27236 0.000752758 0 + 0.0964372 -0.000316483 0 0.184821 0.00161737 0 0.20413 -0.00143016 0 0.0749319 -0.000232231 0 + 0.281234 -0.00181449 0 0.249681 0.000687095 0 0.249785 -0.00264903 0 0.257495 -0.00303403 0 + 0.147078 0.000637878 0 0.171372 0.000511163 0 0.169307 0.000767091 0 0.16676 -0.000976378 0 + 0.198574 -0.00131386 0 0.279659 -0.00154601 0 0.206033 -0.00147102 0 0.274185 -0.00174448 0 + 0.164358 0.000930819 0 0.207938 -0.000989178 0 0.220529 0.000926517 0 0.255379 0.00229535 0 + 0.0185284 -1.07612e-05 0 0.273054 0.000854618 0 0.269235 0.000804959 0 0.275895 -0.00261759 0 + 0.280254 -0.000447018 0 0.262033 0.00263632 0 0.23318 0.000988354 0 0.20342 -0.000669332 0 + 0.278513 -0.00202113 0 0.255476 0.00179525 0 0.1433 0.000642391 0 0.172905 -0.000534163 0 + 0.190798 -0.00187169 0 0.276861 0.000610128 0 0.257105 0.00119873 0 0.271827 0.000894264 0 + 0.240392 0.0014352 0 0.132161 0.0005218 0 0.0437441 5.01222e-05 0 0.279623 -0.00193197 0 + 0.266682 0.00119054 0 0.214737 -0.000676589 0 0.140383 0.000567995 0 0.0178239 7.72259e-06 0 + 0.122445 -0.000576458 0 0.270145 0.000813804 0 0.20053 -0.00135236 0 0.221299 0.00193279 0 + 0.114766 -0.000151706 0 0.0442014 -5.76632e-05 0 0.106085 -0.000292071 0 0.174961 -0.000552897 0 + 0.0179114 -7.90024e-06 0 0.280697 -0.00183768 0 0.0684109 0.000155244 0 0.24556 0.000502201 0 + 0.216494 -0.00179762 0 0.266642 0.000853018 0 0.226165 0.00137303 0 0.259544 0.000357914 0 + 0.177409 -0.00067397 0 0.127771 0.00039116 0 0.282211 -0.00167586 0 0.271664 0.000991977 0 + 0.245255 0.00371308 0 0.0353376 -3.16823e-05 0 0.199587 -0.00106142 0 0.00869209 5.07426e-05 0 + 0.18674 -0.00114101 0 0.282378 -0.00159209 0 0.187639 -0.00061234 0 0.274068 -0.00237565 0 + 0.267533 0.000816308 0 0.258584 0.00138184 0 0.0364656 -4.09902e-05 0 0.269154 0.00130281 0 + 0.172941 -0.000658224 0 0.234431 0.000718933 0 0.270591 0.000921333 0 0.284802 -0.00119844 0 + 0.264977 0.00107277 0 0.261846 -0.000383492 0 0.281701 -0.00174041 0 0.0929371 -0.000342709 0 + 0.252412 0.000371066 0 0.193488 -0.00106237 0 0.245279 0.000688324 0 0.168692 -0.00108412 0 + 0.281018 -0.00182136 0 0.044607 -5.73219e-05 0 0.282118 -0.00170826 0 0.133613 0.000503514 0 + 0.180404 -0.00107685 0 0.263488 0.00186103 0 0.255471 0.000372817 0 0.175824 -0.00108529 0 + 0.230291 0.000890889 0 0.259843 0.00239736 0 0.273543 -0.00172462 0 0.219941 -0.00205165 0 + 0.173605 -0.00104783 0 0.277774 0.000521716 0 0.231915 -0.00148832 0 0.0358794 -4.33849e-05 0 + 0.186951 -0.0010973 0 0.12808 0.000515478 0 0.226171 0.000963357 0 0.293891 -0.00048372 0 + 0.289214 -0.000721635 0 0.264834 0.000859963 0 0.182544 -0.00111292 0 0.246297 0.00038419 0 + 0.204385 -0.00131604 0 0.282961 -0.00156316 0 0.221746 0.00183293 0 0.0580093 8.27905e-05 0 + 0.188813 -0.00117768 0 0.166634 0.00118912 0 0.276144 0.000632859 0 0.291565 -0.00070439 0 + 0.0911808 -0.000209138 0 0.271087 -0.00208041 0 0.201008 -0.000576805 0 0.282178 -0.0015727 0 + 0.271214 0.000939269 0 0.276684 0.000427527 0 0.235426 0.000913688 0 0.167315 -0.00090923 0 + 0.256662 0.000360497 0 0.225324 0.00102566 0 0.276792 -0.0023186 0 0.242675 0.000856777 0 + 0.241429 0.000386021 0 0.29126 -0.000710543 0 0.271561 0.000830107 0 0.21966 0.000984394 0 + 0.03572 3.10943e-05 0 0.0453456 6.29476e-05 0 0.222248 0.00173607 0 0.255934 -0.00241063 0 + 0.186162 -0.0013762 0 0.0807991 -0.000259606 0 0.262894 -0.00243788 0 0.266303 -0.00214278 0 + 0.164926 0.00081892 0 0.285088 -0.00126617 0 0.233889 0.000501367 0 0.282798 -0.00161337 0 + 0.251734 -0.00261208 0 0.284165 -0.00141192 0 0.0356289 -3.90988e-05 0 0.274482 -0.00196536 0 + 0.282634 -0.00164129 0 0.270095 -0.0022756 0 0.282937 -0.00160045 0 0.175329 -0.00124162 0 + 0.22808 0.00172207 0 0.256021 -0.00118884 0 0.277361 -0.00230166 0 0.262341 0.000463122 0 + 0.127117 0.000568696 0 0.26988 0.000966474 0 0.267939 0.0014567 0 0.263093 0.00107897 0 + 0.278761 0.000445841 0 0.270377 0.000442741 0 0.249342 -0.00167298 0 0.285269 -0.00108479 0 + 0.244999 0.00399611 0 0.262317 -0.00212843 0 0.219294 0.00147192 0 0.232943 0.00142047 0 + 0.275432 0.00072174 0 0.146728 0.000432156 0 0.232634 0.00082407 0 0.265838 0.000979182 0 + 0.260225 0.00117462 0 0.133202 0.000660422 0 0.269123 -0.00212827 0 0.170837 -0.000635757 0 + 0.167621 -0.000876294 0 0.243063 0.00123398 0 0.0451168 -6.73595e-05 0 0.175022 0.000755697 0 + 0.276642 0.000591552 0 0.272074 -0.00228115 0 0.256023 -0.00230167 0 0.258615 0.000479832 0 + 0.27864 -0.00218677 0 0.0351516 3.48279e-05 0 0.278395 -0.00184045 0 0.236236 0.0161417 0 + 0.132605 0.000260848 0 0.285439 -0.00126074 0 0.266695 0.000893663 0 0.0691208 0.000125104 0 + 0.231025 0.00170991 0 0.214287 -0.000709826 0 0.293297 -0.000572215 0 0.278075 -0.00201863 0 + 0.268464 0.000986982 0 0.220801 0.00146916 0 0.248555 -0.00259716 0 0.279271 -0.00193047 0 + 0.200428 -0.00140907 0 0.273297 0.000812249 0 0.268004 -0.00119467 0 0.209881 -0.000627726 0 + 0.292045 -0.000664261 0 0.269517 -0.00231558 0 0.181687 -0.000880907 0 0.1348 0.00048695 0 + 0.242394 0.000710346 0 0.218094 0.000780395 0 0.262247 0.00111447 0 0.194853 -0.00123945 0 + 0.235543 0.00283034 0 0.146995 -0.000808526 0 0.286283 -0.000936591 0 0.154627 -0.000671725 0 + 0.27326 -0.00285026 0 0.272863 -0.00202189 0 0.176275 -0.00100598 0 0.268875 -0.00202151 0 + 0.147287 -0.000615577 0 0.160611 0.000507175 0 0.237778 0.000377181 0 0.263006 -0.00230511 0 + 0.272283 0.000577506 0 0.22116 -0.00114967 0 0.211511 -0.00187512 0 0.27211 0.00108419 0 + 0.266696 0.00106093 0 0.223918 0.000812147 0 0.26934 0.000641559 0 0.228588 0.00144669 0 + 0.144105 0.000513452 0 0.265029 0.00101593 0 0.242141 0.000492368 0 0.260028 0.00169711 0 + 0.161345 -0.000754378 0 0.229219 0.00107085 0 0.270892 0.000779556 0 0.273095 -0.0023432 0 + 0.292306 -0.000657074 0 0.264783 0.000905936 0 0.271183 0.000199336 0 0.269188 0.000945124 0 + 0.25437 0.000593553 0 0.256266 -0.00340443 0 0.284381 -0.00138306 0 0.280392 -0.00183952 0 + 0.140087 0.000428903 0 0.152285 0.00066891 0 0.280767 0.00031966 0 0.0828836 -0.000270968 0 + 0.266496 0.00165855 0 0.255524 0.00140113 0 0.0931031 0.000279049 0 0.0182102 9.37863e-06 0 + 0.284835 -0.00122407 0 0.126878 0.00044653 0 0.235126 0.00167952 0 0.28144 -0.00174576 0 + 0.19701 -0.00087823 0 0.263939 0.000988023 0 0.142549 0.000717309 0 0.134758 0.000366697 0 + 0.222126 0.000921113 0 0.286806 -0.00107979 0 0.227542 0.00182465 0 0.2228 0.00164237 0 + 0.130606 0.000370133 0 0.269351 0.000895744 0 0.144184 -0.000793823 0 0.283587 -0.00148564 0 + 0.274425 0.000720829 0 0.153282 0.000387731 0 0.274446 0.000481989 0 0.223399 0.00155179 0 + 0.281612 -0.00158047 0 0.00897956 -2.95045e-06 0 0.0441388 -5.13326e-05 0 0.168621 -0.000779141 0 + 0.147977 0.000460949 0 0.265694 0.000317068 0 0.285741 -0.000933553 0 0.26279 -0.004747 0 + 0.149289 0.000442363 0 0.275238 0.000648549 0 0.00930519 -3.76934e-06 0 0.141484 0.000500562 0 + 0.273793 -0.00195097 0 0.269195 0.00141487 0 0.242584 0.0029245 0 0.276076 -0.00190096 0 + 0.176537 -0.000969528 0 0.145384 0.000496705 0 0.160305 -0.000841651 0 0.268334 -0.00210494 0 + 0.195035 -0.00119015 0 0.29108 -0.000762122 0 0.194707 -0.00129049 0 0.00828622 1.47393e-05 0 + 0.272156 0.000489634 0 0.0100599 -1.18293e-05 0 0.238947 0.000691731 0 0.272233 0.000839791 0 + 0.03533 2.92736e-05 0 0.260507 0.000915667 0 0.161743 -0.000726725 0 0.156942 0.000574691 0 + 0.279167 -0.0016467 0 0.137692 0.00055149 0 0.187695 -0.000969267 0 0.0356699 -4.18751e-05 0 + 0.289073 -0.000868993 0 0.163604 -0.00078298 0 0.265292 0.000226697 0 0.270078 0.00085735 0 + 0.265934 0.00110202 0 0.250203 0.000602318 0 0.255123 -0.0024915 0 0.267398 0.00114461 0 + 0.270728 -0.00197825 0 0.242847 0.000377791 0 0.262722 0.000912973 0 0.252116 0.000964869 0 + 0.151952 0.000405182 0 0.209408 -0.000658121 0 0.00892069 9.89559e-06 0 0.0193499 1.94704e-05 0 + 0.293489 -0.000542447 0 0.109929 -0.00048074 0 0.175212 -0.000830606 0 0.254845 -0.00237168 0 + 0.272944 -0.000471569 0 0.267841 -0.00177976 0 0.26781 0.000219999 0 0.230046 0.00100434 0 + 0.280269 -0.00165608 0 0.273662 -0.00285407 0 0.219753 0.000775793 0 0.164252 0.000491243 0 + 0.189942 -0.000745431 0 0.163983 -0.000753928 0 0.276457 -0.00176534 0 0.137635 0.000339598 0 + 0.0847224 -0.000273471 0 0.268793 0.000209411 0 0.269027 0.000544356 0 0.282502 -0.00115395 0 + 0.0586064 6.78525e-05 0 0.270348 -0.00205663 0 0.0356263 -3.40081e-05 0 0.181629 0.000565369 0 + 0.266255 -0.00410032 0 0.250513 -0.00170243 0 0.263927 0.000938083 0 0.149642 -0.000641813 0 + 0.265882 0.000927862 0 0.0578159 6.41038e-05 0 0.239069 0.000507479 0 0.242271 0.000972481 0 + 0.260592 0.00131783 0 0.276152 -0.00147933 0 0.130812 0.000486216 0 0.240177 0.00105789 0 + 0.214996 0.001392 0 0.284785 -0.000898844 0 0.263703 -0.00442178 0 0.204377 -0.00060848 0 + 0.28066 -0.00168382 0 0.263086 0.00102205 0 0.0789239 -0.000218498 0 0.186671 -0.000670793 0 + 0.271476 -0.00225485 0 0.107569 -0.000128797 0 0.273156 0.00075816 0 0.238131 0.000544894 0 + 0.268548 0.000835048 0 0.284845 -0.00138589 0 0.27139 -0.00177945 0 0.252873 -0.00253851 0 + 0.270238 -0.00174444 0 0.177406 -0.000859698 0 0.281247 -0.00157662 0 0.267158 -0.00393384 0 + 0.211631 -0.00140369 0 0.236763 0.00102411 0 0.282173 -0.00149716 0 0.283246 -0.0014886 0 + 0.109068 -0.00014333 0 0.264628 0.00208936 0 0.284151 -0.000896343 0 0.154537 -0.00089019 0 + 0.186704 0.000155165 0 0.108558 -0.000234911 0 0.249707 0.00120769 0 0.0175958 -8.40572e-06 0 + 0.0992667 -0.000109199 0 0.229282 0.00136086 0 0.225554 -0.000798078 0 0.170463 -0.000840054 0 + 0.176648 0.000143846 0 0.285748 -0.00128265 0 0.254552 0.000330782 0 0.141902 0.000301125 0 + 0.278977 -0.00104774 0 0.224838 0.000761343 0 0.291625 -0.000711688 0 0.270404 0.00103585 0 + 0.177214 -0.000461044 0 0.168628 0.000129961 0 0.220037 -0.00145173 0 0.250129 0.000338573 0 + 0.157762 0.000116801 0 0.234024 -0.0218912 0 0.275212 0.000454519 0 0.186211 -0.000701088 0 + 0.223013 0.00086548 0 0.130548 0.000405425 0 0.194077 0.000167708 0 0.0840605 -0.000178872 0 + 0.0836478 -0.000182643 0 0.27054 0.000710494 0 0.149422 0.000396885 0 0.243796 0.000349031 0 + 0.239371 0.000609883 0 0.276141 -0.0016851 0 0.0424288 3.85826e-05 0 0.220973 0.000646275 0 + 0.144359 0.000342386 0 0.230892 0.000941454 0 0.149093 0.000102557 0 0.283492 -0.000738284 0 + 0.291265 -0.000750411 0 0.226183 0.00122292 0 0.187283 -0.000516233 0 0.262899 -0.0017483 0 + 0.164243 9.22476e-05 0 0.254937 -0.00226189 0 0.23117 0.000833723 0 0.265171 -0.00529305 0 + 0.272118 -0.00200249 0 0.238756 0.000349178 0 0.293824 -0.00049537 0 0.142787 8.85669e-05 0 + 0.283027 0.000139964 0 0.233886 0.000680649 0 0.126645 -0.000416119 0 0.250988 0.000461561 0 + 0.259556 0.000941945 0 0.13606 0.000430248 0 0.267021 -0.00175762 0 0.267585 0.000965192 0 + 0.114987 0.000290166 0 0.151654 0.000102026 0 0.174089 -0.00097292 0 0.269863 0.000738964 0 + 0.221257 0.000979384 0 0.286119 -0.00119611 0 0.253969 -0.00170093 0 0.285711 -0.000441937 0 + 0.227637 0.0012147 0 0.285278 -0.00132253 0 0.265685 0.000824573 0 0.267927 -0.0020035 0 + 0.261818 0.000941546 0 0.149437 0.000593784 0 0.274855 -0.000566944 0 0.257138 0.0009355 0 + 0.269304 0.000680101 0 0.278696 -0.00163643 0 0.0942012 -0.000158533 0 0.2865 -0.00108043 0 + 0.213698 0.000741858 0 0.237857 0.00186306 0 0.275903 -0.000573751 0 0.106379 -0.000282127 0 + 0.237332 0.00198336 0 0.262509 0.00156673 0 0.181398 -0.000583274 0 0.0345082 2.93142e-05 0 + 0.248112 0.000967455 0 0.138796 0.000401247 0 0.2728 0.000499335 0 0.117894 0.000302793 0 + 0.285448 -0.00130346 0 0.094808 5.25134e-05 0 0.0602547 -8.84752e-05 0 0.193337 -0.000539302 0 + 0.275556 -0.00132025 0 0.0835866 -0.000173526 0 0.276193 -0.00133274 0 0.279794 -0.00165493 0 + 0.128147 0.000291061 0 0.25947 -0.00397856 0 0.274017 -0.000890468 0 0.121808 -0.000295137 0 + 0.282106 -0.00155011 0 0.278877 -0.00184601 0 0.219962 0.00139048 0 0.221055 -0.000744919 0 + 0.286977 -0.00115667 0 0.017852 6.88305e-06 0 0.0439883 -5.23524e-05 0 0.113731 -0.000330382 0 + 0.120687 0.000343735 0 0.261069 -0.00468058 0 0.240994 0.000987604 0 0.139283 -0.000582345 0 + 0.280093 -0.00139033 0 0.237593 0.000957388 0 0.286424 -0.00118891 0 0.267313 0.000688143 0 + 0.161827 -0.000968297 0 0.270142 0.000611156 0 0.195908 -0.000778147 0 0.292249 -0.000659931 0 + 0.196333 -0.000743526 0 0.227546 -0.00120213 0 0.175404 -0.00120394 0 0.273932 0.000549101 0 + 0.133346 0.000381911 0 0.293469 -0.000563187 0 0.23539 0.00049389 0 0.279699 -0.00180053 0 + 0.0425986 3.15179e-05 0 0.0174137 7.29719e-06 0 0.231755 0.000881355 0 0.282216 -0.00126425 0 + 0.269929 0.000522028 0 0.21904 0.000733075 0 0.250496 0.0011209 0 0.0683657 -0.000115065 0 + 0.150647 0.000573852 0 0.147542 -0.000756824 0 0.267553 0.00108744 0 0.134705 0.000443177 0 + 0.277855 -0.000715088 0 0.244177 0.000613611 0 0.172411 0.000105125 0 0.276601 -0.000981994 0 + 0.130876 0.000535745 0 0.195697 -0.00104794 0 0.226716 0.000668396 0 0.217194 0.00117525 0 + 0.246883 0.00049156 0 0.246472 0.000466358 0 0.284213 -0.000741753 0 0.268295 0.00127677 0 + 0.292222 -0.000113414 0 0.266336 0.000214261 0 0.253729 0.000233434 0 0.182754 -0.00107035 0 + 0.00930211 7.47139e-06 0 0.266902 0.000555742 0 0.294476 -0.000170098 0 0.184022 7.89964e-05 0 + 0.247557 0.000245155 0 0.0882549 -0.000283736 0 0.106635 -0.000133961 0 0.0660567 -5.6296e-05 0 + 0.124115 0.000429458 0 0.256832 0.000234008 0 0.254797 0.000977812 0 0.188733 -0.000851188 0 + 0.243487 0.00148287 0 0.0354321 -3.58449e-05 0 0.260945 0.000222883 0 0.220668 0.00131244 0 + 0.0969524 -0.000308032 0 0.267887 -0.00106873 0 0.274396 0.000503716 0 0.274308 0.000824538 0 + 0.157073 -0.000555132 0 0.00896573 -2.84913e-06 0 0.264272 -0.00178902 0 0.10997 -0.00013611 0 + 0.220001 0.000688389 0 0.225772 0.000713363 0 0.134933 -0.000508851 0 0.101619 0.000227621 0 + 0.286978 -0.000970898 0 0.132071 0.000471756 0 0.117151 -0.000160416 0 0.279079 -0.0014599 0 + 0.115681 -0.000149157 0 0.228583 0.0010135 0 0.272896 0.000590315 0 0.287859 -0.00104948 0 + 0.258033 0.000224555 0 0.0418597 -2.01027e-05 0 0.266773 -0.00607307 0 0.266459 0.000720736 0 + 0.245446 0.000997843 0 0.0434956 4.67021e-05 0 0.0658119 8.48573e-05 0 0.126458 0.000337484 0 + 0.254306 0.00687377 0 0.271344 0.00114558 0 0.216399 -0.00069383 0 0.265248 0.000696146 0 + 0.142778 0.00048355 0 0.287756 -0.00107917 0 0.045999 5.4343e-05 0 0.228817 0.000793375 0 + 0.0185493 2.34537e-05 0 0.00839439 1.14482e-05 0 0.185768 -0.000733631 0 0.107847 -0.000208307 0 + 0.105083 6.78857e-05 0 0.142627 -0.000564897 0 0.268155 0.000624875 0 0.268457 0.000878941 0 + 0.190703 -0.000877673 0 0.0334228 1.796e-05 0 0.191499 9.14823e-05 0 0.0916245 -0.000211226 0 + 0.0949363 7.92597e-05 0 0.176513 -0.000733642 0 0.292426 -0.000649939 0 0.250676 -0.00130093 0 + 0.234983 0.000339983 0 0.2613 -0.000549652 0 0.287418 -0.000967942 0 0.0907994 -0.000210093 0 + 0.175042 0.00120156 0 0.291844 -0.000702806 0 0.282668 -0.00119069 0 0.285778 -0.00124469 0 + 0.26016 0.00111264 0 0.273706 0.000526585 0 0.268991 0.000565883 0 0.150449 -0.000492839 0 + 0.0576747 -4.15721e-05 0 0.278237 -0.000674257 0 0.233478 0.000566777 0 0.271481 0.000607881 0 + 0.264334 0.000723199 0 0.259867 -0.00177003 0 0.155066 -0.000830581 0 0.186209 -0.000566292 0 + 0.263946 0.000293839 0 0.177882 -0.000644445 0 0.164289 -0.000722608 0 0.287064 -0.000856121 0 + 0.223796 0.00103256 0 0.176542 0.000375035 0 0.0436831 -4.44677e-05 0 0.275796 -0.000693549 0 + 0.211764 -0.00134242 0 0.252835 0.000259187 0 0.276606 -0.000702593 0 0.163557 -0.000620166 0 + 0.132035 0.000354945 0 0.279421 0.000415437 0 0.253745 0.00100118 0 0.263229 -0.00101299 0 + 0.232528 0.000606451 0 0.262613 0.000230362 0 0.181446 -0.000918913 0 0.267298 0.000654888 0 + 0.195197 -0.000555298 0 0.280794 -0.00186307 0 0.168871 -0.00104831 0 0.144206 0.000380413 0 + 0.243521 0.000483019 0 0.00933653 1.33509e-06 0 0.25199 -0.00194262 0 0.284233 -0.00120854 0 + 0.260121 0.000310382 0 0.280631 -0.00140469 0 0.286741 -0.00116696 0 0.00900983 -2.24412e-06 0 + 0.229729 0.000742198 0 0.279615 2.50239e-05 0 0.222176 0.00116618 0 0.266909 0.000578694 0 + 0.242644 0.000247682 0 0.222622 0.000641221 0 0.178588 -0.000758407 0 0.273927 0.000467026 0 + 0.0420258 3.49004e-05 0 0.168598 -0.000420554 0 0.0343605 2.06609e-05 0 0.266079 0.000637001 0 + 0.285615 -0.00129112 0 0.206261 -0.00185971 0 0.23897 0.000241223 0 0.218685 0.000544562 0 + 0.261945 -0.00172252 0 0.119424 0.000288783 0 0.215424 0.000738673 0 0.255788 0.000394801 0 + 0.149878 -0.000512661 0 0.0426019 4.17129e-05 0 0.204969 -0.00115409 0 0.224588 0.000563504 0 + 0.217315 -0.000630051 0 0.174857 0.000549421 0 0.278999 -0.000681232 0 0.280379 1.31917e-05 0 + 0.258975 -0.00174353 0 0.260095 0.00024976 0 0.145569 0.000365436 0 0.281563 -0.00125742 0 + 0.225282 -0.000673189 0 0.274658 0.000800194 0 0.161095 0.000757865 0 0.223247 0.000767654 0 + 0.271953 0.000557742 0 0.143074 -0.000453329 0 0.225957 0.000343465 0 0.0423694 3.49449e-05 0 + 0.277493 0.000427151 0 0.15734 -0.000671104 0 0.259793 0.000232885 0 0.274052 -0.000719802 0 + 0.141585 0.00037158 0 0.284286 -0.0011399 0 0.0684039 -0.000121166 0 0.214477 0.000991901 0 + 0.276713 -0.00150249 0 0.245978 0.000530033 0 0.245332 0.00136174 0 0.224642 0.000970565 0 + 0.184263 0.000407085 0 0.00869519 2.57421e-06 0 0.292941 -0.000610039 0 0.275554 -0.00167065 0 + 0.231634 0.00035017 0 0.165732 -0.000642608 0 0.269474 -0.00172422 0 0.283334 -0.00134481 0 + 0.241055 0.000722665 0 0.295701 -0.000348649 0 0.239377 0.00113298 0 0.262333 0.000596894 0 + 0.272256 -0.00258399 0 0.0684147 -0.00011607 0 0.202572 -0.000499103 0 0.15702 0.000420015 0 + 0.279703 -0.00131079 0 0.281941 -0.0017178 0 0.274145 0.000296994 0 0.209087 0.000992867 0 + 0.27478 0.000413245 0 0.255953 0.000260061 0 0.0674784 0.000115966 0 0.264701 0.000586012 0 + 0.281912 0.000245162 0 0.290122 -7.92767e-05 0 0.220697 0.000728245 0 0.25351 0.000642976 0 + 0.271554 -0.000802817 0 0.24001 0.000472707 0 0.276112 -0.00243113 0 0.294814 -0.000179108 0 + 0.275127 -0.00278626 0 0.0178844 -7.96101e-06 0 0.27674 -0.00180939 0 0.251516 0.000404197 0 + 0.196652 -0.000917486 0 0.272718 0.000530809 0 0.147647 -0.000239196 0 0.281508 -0.00140661 0 + 0.18192 -0.000556948 0 0.164575 -0.000570521 0 0.251864 -0.00132455 0 0.102066 -0.000196828 0 + 0.295959 -0.000347705 0 0.270423 -0.000559673 0 0.278387 -0.000782794 0 0.176057 -0.000504515 0 + 0.03508 -2.64454e-05 0 0.226581 0.000494523 0 0.230653 0.000694355 0 0.197785 -0.000801255 0 + 0.152149 -0.000532812 0 0.0172551 6.60463e-06 0 0.272088 -0.00133688 0 0.108468 0.000185841 0 + 0.241495 0.00204403 0 0.145384 -0.000472337 0 0.268126 0.000591603 0 0.293389 -0.000142435 0 + 0.283817 -0.00120474 0 0.266003 0.000604843 0 0.2649 0.00143341 0 0.1501 -0.000621243 0 + 0.097036 -0.000344699 0 0.243282 0.000660606 0 0.148394 -0.000712722 0 0.26517 0.000662069 0 + 0.270916 0.000343974 0 0.252238 -0.00175683 0 0.22729 0.00080128 0 0.0943274 -9.69247e-05 0 + 0.169562 -0.000941451 0 0.278428 -0.00145262 0 0.239253 0.000369935 0 0.12354 0.000357964 0 + 0.242033 0.00191524 0 0.0822364 -0.000231032 0 0.189758 -0.000508899 0 0.225507 0.000911616 0 + 0.286518 -0.000985457 0 0.155071 -0.000869924 0 0.271309 0.000511139 0 0.294234 -0.000160135 0 + 0.292576 -0.000122591 0 0.0340754 2.31237e-05 0 0.278315 -0.00128874 0 0.274428 -0.000680938 0 + 0.277589 2.83592e-05 0 0.155779 -0.000782389 0 0.0353701 -3.22955e-05 0 0.220387 0.000540456 0 + 0.218199 -0.000844596 0 0.287155 -0.00111382 0 0.262655 0.000861813 0 0.293503 -0.00014138 0 + 0.285015 -0.00132795 0 0.228204 0.000750177 0 0.130889 0.000300664 0 0.237549 0.000702546 0 + 0.273712 0.000447533 0 0.287964 -0.00101418 0 0.146947 0.000350094 0 0.276028 0.000453433 0 + 0.169605 -0.000722112 0 0.247439 0.000625791 0 0.287006 -0.00104105 0 0.270558 -0.00155497 0 + 0.254771 -0.00146164 0 0.268716 -0.00135074 0 0.264471 -0.00134526 0 0.285524 -0.000103301 0 + 0.247445 -0.00154044 0 0.275431 -0.000798042 0 0.172477 -0.000686096 0 0.04425 3.80477e-05 0 + 0.0174198 5.17487e-06 0 0.284701 -0.00114336 0 0.167775 -0.000543554 0 0.197919 6.69344e-05 0 + 0.240224 0.000341894 0 0.0166691 6.78211e-06 0 0.00848083 3.33615e-06 0 0.179918 -0.000666187 0 + 0.251322 -0.00146457 0 0.16679 -0.00048009 0 0.162314 -0.000904472 0 0.280515 -0.00110312 0 + 0.291633 -0.00010519 0 0.281041 -0.00125033 0 0.14541 8.78545e-05 0 0.281422 -0.00117391 0 + 0.155433 -0.000804021 0 0.252853 -0.00167235 0 0.12649 -0.00047116 0 0.119685 -0.000329242 0 + 0.231586 0.000649175 0 0.2855 -2.24996e-05 0 0.27288 0.000439275 0 0.270003 6.12821e-05 0 + 0.223601 0.000601196 0 0.273197 -0.000711308 0 0.292212 -0.000640224 0 0.272189 -0.00337295 0 + 0.246272 0.000927846 0 0.271995 -0.00119248 0 0.296769 -0.000268445 0 0.17133 -0.000608101 0 + 0.157643 -0.000366117 0 0.152657 -0.000246844 0 0.289586 -0.000405239 0 0.257165 0.00025044 0 + 0.105251 9.48293e-05 0 0.100543 -0.000129643 0 0.261324 0.000613509 0 0.0883269 5.11472e-05 0 + 0.243609 0.000222186 0 0.178371 -0.000617232 0 0.287555 -4.50215e-05 0 0.288103 -0.00092068 0 + 0.236701 0.000227293 0 0.288967 -0.000947425 0 0.272174 0.000460866 0 0.179421 9.16058e-05 0 + 0.0442733 3.23271e-05 0 0.221654 0.000683426 0 0.250949 0.000813626 0 0.263737 0.000608636 0 + 0.221777 0.000450155 0 0.215352 0.000935575 0 0.293762 -0.000526573 0 0.166653 8.86451e-05 0 + 0.26779 0.000529315 0 0.278606 -0.00211559 0 0.258765 0.0006155 0 0.234857 0.000468124 0 + 0.273565 -0.000672425 0 0.282227 7.3761e-06 0 0.231966 0.000574298 0 0.279168 -0.00130131 0 + 0.169567 0.000147293 0 0.248489 0.00021955 0 0.00873644 1.13448e-06 0 0.240475 0.000416803 0 + 0.0173357 5.36933e-06 0 0.226391 0.000855178 0 0.260987 0.00102293 0 0.249329 0.00065086 0 + 0.275652 -0.00240528 0 0.132351 0.000290839 0 0.240172 0.000775819 0 0.278185 -0.000860484 0 + 0.190717 0.00211686 0 0.0856623 5.15507e-05 0 0.252312 0.00030074 0 0.182169 0.000159203 0 + 0.177147 9.66719e-05 0 0.288483 -0.000967596 0 0.156152 -0.000748743 0 0.248326 0.00058019 0 + 0.251799 0.000752145 0 0.230155 0.000249 0 0.210365 -0.000598541 0 0.155687 -0.000415486 0 + 0.251422 0.000587777 0 0.237197 0.00058394 0 0.141445 0.000411431 0 0.156774 9.96076e-05 0 + 0.280387 0.000273162 0 0.283191 -0.00120219 0 0.289925 -0.00086822 0 0.262841 -0.00147489 0 + 0.274842 0.000301218 0 0.288499 -0.000915653 0 0.287057 -0.000891428 0 0.241945 0.000672529 0 + 0.138742 0.000442763 0 0.136367 0.00031786 0 0.28217 -8.68729e-05 0 0.263715 0.000219401 0 + 0.285208 -0.00114394 0 0.0333972 1.46213e-05 0 0.227919 0.000847442 0 0.219264 4.75664e-05 0 + 0.285331 -0.00111246 0 0.0736586 -0.000215649 0 0.238456 0.000654808 0 0.279638 -0.0011006 0 + 0.282739 -0.000411072 0 0.284543 -0.00127826 0 0.231738 0.00180495 0 0.21562 -0.00123101 0 + 0.216853 -0.000661316 0 0.216248 0.000881678 0 0.273367 5.10264e-05 0 0.288202 -0.000884067 0 + 0.283591 -0.000419413 0 0.281791 -0.00149443 0 0.199202 -0.000560877 0 0.284314 -0.00140141 0 + 0.290562 -0.000779894 0 0.203597 0.00110137 0 0.214267 0.000519596 0 0.123642 0.000326509 0 + 0.181636 -0.000470351 0 0.179932 0.000160648 0 0.186222 7.17324e-05 0 0.279034 -0.000867388 0 + 0.041986 2.79554e-05 0 0.296724 -0.000273586 0 0.21136 -0.000542073 0 0.27253 0.00037116 0 + 0.0170616 3.52662e-06 0 0.173422 -0.000629597 0 0.242636 -0.000533684 0 0.249986 0.000274172 0 + 0.137805 0.000306231 0 0.134956 0.000329813 0 0.265389 0.000509895 0 0.167193 0.000147642 0 + 0.280864 -0.000696868 0 0.14297 0.000356687 0 0.0975379 -0.000184413 0 0.121198 0.000257311 0 + 0.211549 -0.000994282 0 0.271922 0.000659138 0 0.271789 0.000327678 0 0.241278 -0.000520949 0 + 0.256321 0.000647156 0 0.286096 -0.00108401 0 0.247728 0.000307165 0 0.227585 0.000463001 0 + 0.156322 -0.000398344 0 0.171331 -0.000416854 0 0.255362 -0.00131883 0 0.150616 0.000424222 0 + 0.281368 -0.000927084 0 0.254103 0.000250145 0 0.268668 0.000350335 0 0.24537 0.000416286 0 + 0.275211 -0.0023008 0 0.269284 0.000440116 0 0.293875 -0.000517101 0 0.00853072 4.69645e-07 0 + 0.280164 -0.000692134 0 0.217162 0.000830018 0 0.243747 0.000581853 0 0.246559 0.000674814 0 + 0.28755 -2.29161e-05 0 0.182226 -0.000844922 0 0.263983 0.000500261 0 0.118036 -0.000155592 0 + 0.0342779 1.82136e-05 0 0.2312 0.000224595 0 0.0164903 5.99091e-06 0 0.249816 -0.00151307 0 + 0.254953 -0.00138912 0 0.154144 -0.000383037 0 0.290233 -0.000785616 0 0.296698 -0.000248449 0 + 0.205664 -0.000655569 0 0.29412 -0.000481724 0 0.163285 -0.000427059 0 0.227608 0.0003386 0 + 0.287699 -0.00101547 0 0.245236 0.000278189 0 0.279481 -8.12463e-05 0 0.285991 -0.0261021 0 + 0.227107 0.000214572 0 0.275172 0.00031239 0 0.296699 -0.000254442 0 0.280606 -0.000921025 0 + 0.148804 -0.00068547 0 0.22913 0.000702197 0 0.290946 -0.000694904 0 0.24474 0.000320865 0 + 0.263304 -0.00274833 0 0.261226 0.000792074 0 0.152545 0.000294918 0 0.290154 -0.000840165 0 + 0.151138 0.000309402 0 0.227058 0.000592047 0 0.220333 -0.000659929 0 0.220741 0.000479734 0 + 0.257505 -0.00261005 0 0.271763 0.000386834 0 0.190295 -0.00048515 0 0.262063 0.000725908 0 + 0.267587 0.000776566 0 0.222062 -0.0013578 0 0.172365 -0.000558602 0 0.252882 -0.00266188 0 + 0.0725408 -0.000206678 0 0.270149 0.000401316 0 0.270916 0.000550633 0 0.122706 0.00024739 0 + 0.282416 -0.00164948 0 0.201519 -0.000550393 0 0.165654 -0.000524849 0 0.246175 -0.00151138 0 + 0.244078 0.000240572 0 0.287175 -0.00106989 0 0.116536 0.000283157 0 0.236509 0.000333547 0 + 0.268302 0.000458 0 0.0171052 4.14304e-06 0 0.235692 0.000252086 0 0.261152 -0.00121052 0 + 0.255207 0.000666356 0 0.150734 0.0001523 0 0.247051 0.000592963 0 0.229606 0.000548108 0 + 0.165496 0.000468604 0 0.207054 -0.0011338 0 0.217077 0.000485236 0 0.190687 5.40158e-05 0 + 0.116196 -0.000273901 0 0.234524 0.000388571 0 0.261292 0.000476767 0 0.281701 -0.00101137 0 + 0.14546 -0.000228781 0 0.270945 0.00036253 0 0.195853 7.58445e-05 0 0.250117 -0.00143917 0 + 0.148407 -0.000225537 0 0.21737 0.000216385 0 0.0339176 -1.35606e-05 0 0.120136 0.000215071 0 + 0.206382 -0.000287675 0 0.153274 -0.000491184 0 0.266439 -0.000561448 0 0.273553 -0.00153145 0 + 0.238489 0.000283988 0 0.284944 -0.00102802 0 0.283081 -0.00107262 0 0.288968 -0.000901612 0 + 0.143643 0.000260736 0 0.034585 -3.10089e-05 0 0.269262 0.000417609 0 0.224183 0.000719771 0 + 0.177422 0.000268627 0 0.0338243 -1.31308e-05 0 0.287649 -0.000113143 0 0.276571 -0.00112204 0 + 0.15967 -0.000263588 0 0.261111 -0.00209867 0 0.225582 0.000528144 0 0.174432 -0.000577842 0 + 0.190859 -0.000463686 0 0.0360179 2.72193e-05 0 0.296365 -0.000323992 0 0.283323 -0.00097605 0 + 0.214892 -0.000316836 0 0.249399 0.00114386 0 0.289042 -0.000115195 0 0.269928 -4.49553e-05 0 + 0.280593 -0.000504244 0 0.290553 -0.000698352 0 0.159259 9.79877e-05 0 0.255398 0.000855021 0 + 0.158468 -0.000623609 0 0.281847 -0.0010701 0 0.219578 0.000379516 0 0.260133 1.62139e-05 0 + 0.225528 0.000390705 0 0.170063 0.000108234 0 0.268782 0.000367316 0 0.294104 -0.000510815 0 + 0.275999 0.000274456 0 0.296509 -0.000230327 0 0.159926 -0.000449165 0 0.233534 0.000417838 0 + 0.223458 0.000445947 0 0.285465 5.73919e-05 0 0.2152 -0.00064491 0 0.267968 0.000405088 0 + 0.253042 3.85774e-05 0 0.136345 7.52005e-05 0 0.296558 -0.000236355 0 0.206998 6.92692e-05 0 + 0.167378 -0.000459565 0 0.263526 -0.00132647 0 0.222325 0.000818266 0 0.184703 -0.000650262 0 + 0.265712 0.00194576 0 0.220301 -0.000448219 0 0.27402 0.000340004 0 0.271315 -0.00132215 0 + 0.232925 0.000536972 0 0.082781 -0.000128954 0 0.234291 -0.000495388 0 0.247225 0.000354618 0 + 0.199718 -0.000534834 0 0.130774 -0.000375961 0 0.0347467 2.27059e-05 0 0.11667 -0.0228133 0 + 0.170615 -0.000770491 0 0.16036 -0.000529005 0 0.14626 -0.000368328 0 0.24119 0.000315081 0 + 0.253634 -0.00143656 0 0.138483 -0.000414029 0 0.180889 -0.000610604 0 0.225131 0.000674787 0 + 0.272497 0.000350064 0 0.033911 -1.37476e-05 0 0.0153795 -8.44772e-06 0 0.00678674 8.05357e-06 0 + 0.0722737 -0.000164612 0 0.174025 -0.000487645 0 0.185118 0.000290274 0 0.137852 -0.000430593 0 + 0.1666 -0.00101261 0 0.170843 0.00034598 0 0.2733 0.000333722 0 0.264006 0.000387368 0 + 0.167695 0.000288831 0 0.266471 0.000376954 0 0.25173 5.1237e-05 0 0.145983 -0.000452214 0 + 0.0178123 8.98821e-06 0 0.21225 -0.000904022 0 0.160535 -0.000430339 0 0.277685 -0.00127903 0 + 0.237708 0.00020064 0 0.276863 0.000241091 0 0.245743 -5.36777e-05 0 0.216032 0.000516552 0 + 0.253856 -0.00136598 0 0.231769 0.00024364 0 0.214672 0.000697814 0 0.254915 0.00042914 0 + 0.231562 0.000479042 0 0.260454 -0.00134425 0 0.233114 0.000281808 0 0.155616 0.000488682 0 + 0.291378 -0.00072976 0 0.240459 0.0002346 0 0.161158 -0.000411549 0 0.250596 -4.2114e-05 0 + 0.270063 0.000379272 0 0.153496 -0.00039974 0 0.282603 -0.00149537 0 0.160069 0.000309297 0 + 0.293891 -0.000517056 0 0.200248 -0.000510556 0 0.0420801 -2.11313e-05 0 0.208932 5.87999e-05 0 + 0.244444 0.000448862 0 0.275401 -6.85511e-05 0 0.221933 -0.000676075 0 0.161779 0.000265387 0 + 0.0173901 5.71909e-06 0 0.146933 -0.000354475 0 0.261091 8.45235e-05 0 0.192294 -0.000591791 0 + 0.150766 0.000379992 0 0.267036 0.000427555 0 0.20914 0.000702872 0 0.22609 0.000632268 0 + 0.288712 -0.000844654 0 0.166037 0.000338308 0 0.228034 0.000554448 0 0.267851 0.000389134 0 + 0.279669 -0.0010083 0 0.119317 -0.000605759 0 0.282659 -0.000975244 0 0.171779 -0.000746664 0 + 0.157618 0.000304616 0 0.294205 -0.000471203 0 0.285317 -0.000400484 0 0.284859 -0.000938017 0 + 0.273303 0.000312694 0 0.286268 -0.000978372 0 0.248695 0.000422492 0 0.228125 -0.000478806 0 + 0.221305 0.000375752 0 0.162674 -0.000446436 0 0.238574 0.000481033 0 0.179013 -0.000402405 0 + 0.264569 0.000559845 0 0.222429 0.000475518 0 0.148503 -0.000384012 0 0.109771 -0.000163312 0 + 0.185342 -0.000767247 0 0.266267 -4.63145e-05 0 0.296634 -0.00029534 0 0.223948 0.000533368 0 + 0.0336248 9.87287e-06 0 0.272403 -3.36416e-05 0 0.228635 0.000585537 0 0.293686 -0.000351407 0 + 0.276085 0.000263175 0 0.202743 -0.000913053 0 0.289864 -0.000767812 0 0.294243 -0.000163841 0 + 0.266239 -0.00231236 0 0.258276 -0.00116133 0 0.265041 7.90379e-05 0 0.168888 -0.000497601 0 + 0.263475 -6.34023e-05 0 0.159663 -0.000320562 0 0.194175 -0.000609853 0 0.182192 -0.000448938 0 + 0.2629 0.000667564 0 0.287576 -0.000819153 0 0.235982 0.000314294 0 0.188972 -0.000449639 0 + 0.149163 -0.000369119 0 0.274602 0.000269241 0 0.262967 0.000400303 0 0.258943 2.91889e-05 0 + 0.232546 0.000447712 0 0.180478 -0.000514619 0 0.208947 -0.000690615 0 0.292365 -0.000356098 0 + 0.258161 -0.000730547 0 0.223503 0.000223579 0 0.221728 0.000330315 0 0.288734 -0.000951947 0 + 0.254237 -0.00129644 0 0.275302 0.00022703 0 0.232983 0.000395034 0 0.161797 -0.000394121 0 + 0.146243 0.000266398 0 0.0579946 -4.62253e-05 0 0.230002 0.000485352 0 0.170041 0.000292238 0 + 0.273819 0.000290717 0 0.117268 0.000208294 0 0.286308 4.54352e-05 0 0.0328515 1.04625e-05 0 + 0.256683 -4.54374e-05 0 0.265479 0.000393971 0 0.2696 0.000331445 0 0.293222 -0.000348993 0 + 0.260317 0.000405515 0 0.182457 -0.000531616 0 0.285444 -0.000781155 0 0.259162 -0.000742973 0 + 0.215659 0.000656255 0 0.284679 -0.000857145 0 0.147617 -0.00033953 0 0.0412365 2.39403e-05 0 + 0.14096 -0.000298316 0 0.21916 0.000212104 0 0.250621 0.00043771 0 0.243337 0.000328846 0 + 0.10217 -9.57882e-05 0 0.276901 -0.00103672 0 0.149834 -0.000353415 0 0.249603 0.000389145 0 + 0.286168 -0.00082054 0 0.274515 -5.64997e-05 0 0.238284 0.000399069 0 0.00858935 1.05993e-06 0 + 0.252766 0.000393102 0 0.189713 -0.000240079 0 0.159357 0.000170557 0 0.2763 1.71748e-05 0 + 0.282886 0.000118353 0 0.296203 -0.000213747 0 0.25063 0.000770146 0 0.209811 -0.000782799 0 + 0.2052 -0.000688237 0 0.283079 -0.000892523 0 0.088423 6.42912e-05 0 0.276769 0.000175755 0 + 0.289446 -0.000770985 0 0.142178 0.000273001 0 0.289021 -0.000887065 0 0.277302 -0.000940943 0 + 0.232244 0.000197957 0 0.218697 -0.000435057 0 0.293155 -0.000589599 0 0.243071 0.000458017 0 + 0.239523 0.000448208 0 0.175213 -0.000446014 0 0.216658 0.000616966 0 0.287545 -0.000783102 0 + 0.187855 -0.000493742 0 0.131665 0.000222046 0 0.286074 -0.000783133 0 0.245325 -0.00113524 0 + 0.198188 -0.000615693 0 0.215148 0.000363086 0 0.198456 -0.00136845 0 0.228769 0.000209015 0 + 0.159466 0.000427031 0 0.167241 -0.000566293 0 0.203892 -0.000637773 0 0.169464 -0.000476152 0 + 0.287561 -0.00109091 0 0.143214 -0.000311524 0 0.00870594 1.52727e-06 0 0.276173 0.000208629 0 + 0.28704 -0.000819041 0 0.257811 0.000428495 0 0.267239 0.000319662 0 0.274105 0.000224434 0 + 0.0339712 -1.5129e-05 0 0.283642 -0.00080359 0 0.249079 -0.000555507 0 0.292733 -0.000529361 0 + 0.270983 4.9601e-05 0 0.217667 0.000579718 0 0.288808 -0.000778129 0 0.274359 0.000394433 0 + 0.125523 0.000257215 0 0.0580655 -4.65201e-05 0 0.191975 0.000170344 0 0.0562427 2.86069e-05 0 + 0.253206 0.000610037 0 0.155504 -0.000352725 0 0.167368 0.00032154 0 0.162509 -0.00037765 0 + 0.175831 -0.000427638 0 0.169298 -0.000403197 0 0.275435 2.91553e-05 0 0.295137 -0.000185278 0 + 0.159289 -0.000576199 0 0.290475 -0.000727559 0 0.271159 0.000267303 0 0.244935 0.000393318 0 + 0.241214 0.000529338 0 0.170492 -0.000368809 0 0.203495 -0.000831641 0 0.267687 0.000915231 0 + 0.265514 4.95689e-06 0 0.28565 -0.000858013 0 0.17766 -0.000369387 0 0.189359 9.80125e-05 0 + 0.200014 -0.000633625 0 0.274548 -0.00087144 0 0.294543 -0.000332854 0 0.0337537 -1.86448e-05 0 + 0.288813 -0.000744852 0 0.0916457 -0.000144946 0 0.247789 0.000456122 0 0.0181338 -9.14612e-06 0 + 0.00974458 -7.85106e-07 0 0.229974 -3.85653e-05 0 0.153521 0.000214908 0 0.289491 -0.000739096 0 + 0.266272 0.000467613 0 0.232804 0.000218751 0 0.081042 -9.46675e-05 0 0.0887854 -7.17678e-05 0 + 0.2386 0.00121243 0 0.227997 0.000410158 0 0.289569 -5.74663e-05 0 0.293709 -0.000545322 0 + 0.12403 0.000267464 0 0.170052 -0.000455017 0 0.152062 0.00022487 0 0.204878 -0.000580683 0 + 0.289931 -0.00073674 0 0.175746 0.000316076 0 0.157536 -0.000309014 0 0.284298 -0.000980998 0 + 0.269762 0.000494633 0 0.273274 0.000240362 0 0.231012 0.000614337 0 0.262733 -0.00103128 0 + 0.0655783 -6.00724e-05 0 0.247923 -0.00111593 0 0.272017 0.000237782 0 0.267321 -5.91616e-05 0 + 0.253894 -0.00102915 0 0.278404 1.64577e-05 0 0.266584 -8.02688e-06 0 0.285713 -0.00108346 0 + 0.177845 -0.000441801 0 0.222805 0.00030697 0 0.28402 -0.000853997 0 0.276158 -0.000655363 0 + 0.274198 -0.000957619 0 0.282369 -0.000888026 0 0.183583 -0.000485483 0 0.256663 0.000442464 0 + 0.140464 0.000313653 0 0.291787 -0.000690972 0 0.248297 0.000399306 0 0.230618 0.000376924 0 + 0.278432 0.000319796 0 0.136299 0.000199054 0 0.288103 -0.000393518 0 0.188664 -0.000557359 0 + 0.25791 -5.91673e-05 0 0.104185 0.000168132 0 0.164576 -0.000391404 0 0.139038 0.000326294 0 + 0.295921 -0.000205915 0 0.0339718 2.23609e-05 0 0.291853 -0.000652919 0 0.144687 0.000191217 0 + 0.272711 0.000212206 0 0.285559 -0.000818743 0 0.21971 0.000511263 0 0.260465 0.000523877 0 + 0.23468 0.000276204 0 0.264174 0.00111101 0 0.280308 -0.0015647 0 0.291119 -0.000160326 0 + 0.0979425 8.61963e-05 0 0.280249 -5.60693e-06 0 0.286987 -0.000782482 0 0.262842 -0.000982495 0 + 0.271037 0.000253054 0 0.226567 0.000364252 0 0.292919 -0.00059661 0 0.278732 -0.00122076 0 + 0.27669 -0.000848589 0 0.27697 -0.000662551 0 0.199109 -0.000271632 0 0.280727 -0.00157154 0 + 0.254112 -0.000976098 0 0.16149 -0.000488012 0 0.102471 -0.000142015 0 0.159002 0.000290142 0 + 0.0423246 -3.03996e-05 0 0.0413244 1.57864e-05 0 0.222949 0.000568765 0 0.102578 -0.000141554 0 + 0.23889 -5.3905e-05 0 0.229107 0.000272406 0 0.154454 -0.000453333 0 0.109647 -0.000160246 0 + 0.0634634 3.45135e-05 0 0.233982 0.000367087 0 0.0658199 -6.00303e-05 0 0.167171 -0.000325495 0 + 0.217461 5.94138e-05 0 0.276216 0.000198307 0 0.277481 0.000161297 0 0.270381 0.000223071 0 + 0.269814 0.000248056 0 0.0578386 -4.29828e-05 0 0.290149 -0.000379636 0 0.225964 0.000468206 0 + 0.167978 -0.000439257 0 0.262865 0.000306836 0 0.22865 0.000313948 0 0.210776 0.000464937 0 + 0.0422154 -2.23003e-05 0 0.195731 -0.00053069 0 0.00867329 -3.96554e-08 0 0.0175493 -8.18767e-06 0 + 0.269242 -0.000672288 0 0.245985 0.000186741 0 0.171765 0.000248289 0 0.282854 -0.00134405 0 + 0.210321 -0.000402462 0 0.137462 -0.000366017 0 0.244014 -0.00111349 0 0.224507 0.000302819 0 + 0.102561 -0.00013332 0 0.170658 -0.000435283 0 0.283273 2.24535e-05 0 0.142504 -0.000324695 0 + 0.228178 0.000187146 0 0.216936 0.000360065 0 0.294498 -0.000172138 0 0.273593 -0.00086222 0 + 0.292904 -0.000597789 0 0.0329287 1.32394e-05 0 0.245489 -0.000639132 0 0.251988 -0.0010666 0 + 0.176626 -0.000481935 0 0.192683 -0.00125187 0 0.255846 1.36511e-05 0 0.161039 0.000223386 0 + 0.205364 -4.18966e-05 0 0.265499 0.000241486 0 0.267961 0.000232292 0 0.266819 0.00100483 0 + 0.0173405 6.20944e-06 0 0.256299 0.0002766 0 0.232651 0.000324213 0 0.249494 -0.000639026 0 + 0.0164631 -1.31128e-06 0 0.29131 -0.000565469 0 0.280036 -0.00139858 0 0.292121 -0.000560014 0 + 0.271276 -0.000734944 0 0.249578 0.000256649 0 0.281 -1.75637e-05 0 0.294915 -0.00031405 0 + 0.158587 0.000220717 0 0.260935 -3.89626e-05 0 0.252495 -0.00101313 0 0.245683 0.000295545 0 + 0.229428 0.000950724 0 0.209696 0.000494027 0 0.0340609 -1.58195e-05 0 0.284511 -0.000391508 0 + 0.248226 -0.000626641 0 0.294128 -0.000331042 0 0.28383 -0.000600711 0 0.20079 -0.000484663 0 + 0.226979 0.000438533 0 0.290693 -0.000153186 0 0.236171 0.000207459 0 0.154802 -0.000366898 0 + 0.0880615 -0.000103111 0 0.271876 0.000224283 0 0.141806 -0.000338646 0 0.183386 -0.000408695 0 + 0.00863903 -2.85998e-07 0 0.0907655 -8.91972e-05 0 0.152862 0.000263464 0 0.229018 0.000382457 0 + 0.22241 0.000246807 0 0.268813 0.000261315 0 0.295943 -0.000209848 0 0.266297 0.000358209 0 + 0.156883 -0.000155604 0 0.29352 -0.000326152 0 0.224088 -5.59675e-05 0 0.280829 4.53247e-05 0 + 0.221181 -0.000326702 0 0.269484 0.000235667 0 0.251202 -0.000835254 0 0.23973 0.000322088 0 + 0.0849246 5.86955e-05 0 0.163652 0.000333961 0 0.166955 0.000244 0 0.29165 -0.000702386 0 + 0.274607 0.000187528 0 0.292889 -0.000566888 0 0.224908 0.000368969 0 0.229604 0.000404799 0 + 0.290517 -0.00059475 0 0.26465 0.000430851 0 0.291093 -0.000736692 0 0.244168 -0.000626338 0 + 0.233667 0.000299944 0 0.129832 0.000113812 0 0.280395 -0.000757211 0 0.0172078 -3.75791e-06 0 + 0.29634 -0.000235647 0 0.0171311 -6.90422e-07 0 0.256592 -0.000669635 0 0.292341 -0.000559846 0 + 0.165277 -0.000129701 0 0.134251 -0.000307231 0 0.0164226 1.98582e-06 0 0.25723 -0.0016946 0 + 0.287091 -0.000102965 0 0.14112 -0.000352973 0 0.284371 -0.00102537 0 0.232092 0.000305393 0 + 0.13648 -0.000274306 0 0.185315 -0.000422147 0 0.0360123 -1.72701e-05 0 0.216237 0.000238927 0 + 0.0715164 -7.34746e-05 0 0.215668 -0.000614669 0 0.295778 -0.000199139 0 0.134978 -0.000296375 0 + 0.285817 -0.000712261 0 0.289869 -0.000847363 0 0.164429 -0.000330368 0 0.216377 0.000458938 0 + 0.147282 0.000194595 0 0.251937 0.000284565 0 0.285089 -5.37334e-05 0 0.243119 0.000265637 0 + 0.267447 -0.000741116 0 0.18081 5.06169e-05 0 0.261786 0.000256714 0 0.133598 0.000191571 0 + 0.0413354 -2.14522e-05 0 0.278909 0.000115855 0 0.0420262 -2.13467e-05 0 0.270234 0.000209505 0 + 0.0832669 -7.22644e-05 0 0.288142 -1.30568e-05 0 0.0678413 -9.19512e-05 0 0.263434 0.000144285 0 + 0.132802 0.000164732 0 0.240705 0.00029723 0 0.277037 0.000130415 0 0.0914839 -0.000157894 0 + 0.248459 0.000702282 0 0.128801 -0.000245242 0 0.289495 -0.000593093 0 0.262653 -0.000734091 0 + 0.252794 -0.000958384 0 0.0857643 -7.57477e-05 0 0.123644 -0.000167272 0 0.294362 -0.000302624 0 + 0.274969 0.000140841 0 0.17294 3.73492e-05 0 0.223748 -0.000440411 0 0.272097 -0.000658099 0 + 0.286697 -0.000618521 0 0.264434 0.000253153 0 0.246622 0.000270612 0 0.295982 -0.000228579 0 + 0.255794 -0.00266443 0 0.259416 0.000153063 0 0.270555 -0.000792093 0 0.150603 0.000234205 0 + 0.143174 0.000199499 0 0.285955 -0.000481218 0 0.258793 -0.00240485 0 0.267436 5.74574e-05 0 + 0.26699 0.000244111 0 0.284663 -0.000673067 0 0.237361 -3.82227e-05 0 0.208214 7.13964e-06 0 + 0.28332 -0.000635227 0 0.254591 0.000406671 0 0.0743545 -5.6152e-05 0 0.21744 0.00043133 0 + 0.212066 -0.00061425 0 0.0834609 -0.000129918 0 0.165108 -0.000313558 0 0.257039 -0.000507083 0 + 0.230731 0.000267351 0 0.233838 0.000191306 0 0.277596 -6.01036e-05 0 0.2509 0.000248274 0 + 0.287999 -0.000624574 0 0.2434 -0.000834792 0 0.286347 -0.000653181 0 0.289022 -0.000589923 0 + 0.276406 0.000235463 0 0.237976 0.000265869 0 0.288673 -0.000626773 0 0.034337 -2.63065e-05 0 + 0.2375 0.000308119 0 0.277501 -0.000775633 0 0.28116 -0.00106467 0 0.22983 0.000180618 0 + 0.288374 -4.46017e-05 0 0.288268 -0.000847633 0 0.28271 -0.000809438 0 0.191433 -0.000440484 0 + 0.275697 0.00011992 0 0.290097 -0.000591182 0 0.244288 0.000303028 0 0.138893 -0.000200783 0 + 0.284451 -4.21615e-05 0 0.286128 -0.000616246 0 0.0333856 8.22501e-06 0 0.242384 0.000357095 0 + 0.115289 4.7965e-05 0 0.292771 -0.000608707 0 0.272686 0.000151585 0 0.261982 -0.000682954 0 + 0.158591 -0.000352553 0 0.0741959 -0.000103594 0 0.263434 -0.000656054 0 0.270814 -0.000688066 0 + 0.280764 9.27023e-05 0 0.151346 -0.00032415 0 0.296093 -0.000236202 0 0.17316 -0.000362972 0 + 0.279358 -0.00064427 0 0.218507 0.000405082 0 0.282653 -0.000629988 0 0.252494 -0.000712144 0 + 0.251251 0.000127465 0 0.144447 0.000136918 0 0.199196 6.32401e-06 0 0.0330286 -1.52213e-05 0 + 0.0171509 -3.45246e-06 0 0.155264 0.000117709 0 0.144005 -0.000302147 0 0.165399 -0.000378044 0 + 0.296855 -0.000282652 0 0.114501 9.1044e-05 0 0.0185203 -4.76275e-07 0 0.24865 -0.000591455 0 + 0.187574 1.83912e-05 0 0.161441 0.00029436 0 0.251178 -0.000490141 0 0.278083 0.000130791 0 + 0.0559476 -3.3527e-05 0 0.0338128 1.6528e-05 0 0.221316 0.000268969 0 0.140472 -0.000172608 0 + 0.0413939 1.46671e-05 0 0.143837 0.000104146 0 0.294726 -0.000375431 0 0.273475 0.000127352 0 + 0.158286 7.57532e-05 0 0.265195 -0.000322136 0 0.0768441 -6.25384e-05 0 0.271649 0.000301157 0 + 0.276173 0.000141834 0 0.274115 0.000153046 0 0.267932 0.000292325 0 0.0410174 8.28833e-06 0 + 0.296743 -0.000286597 0 0.28976 -0.000432632 0 0.273788 -0.000783406 0 0.279608 8.60434e-05 0 + 0.117394 9.32447e-05 0 0.207125 -0.000568742 0 0.171501 7.8851e-05 0 0.0815711 5.80956e-05 0 + 0.274099 0.000104066 0 0.229147 -0.000524261 0 0.296267 -0.000261256 0 0.259239 0.00027421 0 + 0.26828 -0.000662508 0 0.170053 0.000115109 0 0.135714 -0.000284781 0 0.235155 0.000233514 0 + 0.28109 0.000158779 0 0.230067 0.000657104 0 0.293887 -0.000152157 0 0.288464 -0.000363388 0 + 0.291686 -0.000109596 0 0.246131 -0.000820389 0 0.220652 0.000354586 0 0.225301 -0.000453692 0 + 0.294345 -0.000375019 0 0.290808 -8.37036e-05 0 0.127889 3.48602e-05 0 0.171553 0.000177281 0 + 0.270437 -0.000727227 0 0.227706 0.000234112 0 0.197143 1.98079e-05 0 0.269493 0.000112685 0 + 0.0645164 -3.58494e-05 0 0.271802 0.000163015 0 0.26059 0.000142896 0 0.290301 -0.000577344 0 + 0.164682 -0.000190012 0 0.247943 -0.000753074 0 0.275532 -0.00111542 0 0.249509 -0.000516827 0 + 0.224491 0.000417913 0 0.179951 3.40091e-06 0 0.279265 -0.000407782 0 0.274768 0.000131535 0 + 0.211703 0.000323752 0 0.271878 0.000109685 0 0.150119 0.000118168 0 0.161297 0.000132655 0 + 0.286056 -4.75251e-05 0 0.241676 0.000272632 0 0.250763 -0.000528839 0 0.250338 0.000161947 0 + 0.160815 0.000160142 0 0.0664701 -5.5407e-05 0 0.281433 -0.000796669 0 0.228317 -2.25739e-05 0 + 0.162261 3.39028e-05 0 0.249068 0.000298885 0 0.214076 -4.05513e-05 0 0.292991 -0.00013448 0 + 0.290595 -9.71139e-05 0 0.0175324 1.13e-05 0 0.00966284 3.61604e-06 0 0.26201 0.000336877 0 + 0.141199 0.000103891 0 0.00863555 -1.41e-06 0 0.286413 -1.46176e-05 0 0.158353 0.000158437 0 + 0.292654 -0.00012453 0 0.292069 -0.000119753 0 0.287009 -2.53716e-05 0 0.156784 0.000257357 0 + 0.261596 -0.000721163 0 0.164332 -0.000264081 0 0.218029 0.000336226 0 0.285752 -0.000979354 0 + 0.271073 0.000135729 0 0.291174 -9.42334e-05 0 0.235745 0.000592803 0 0.289626 -0.000562887 0 + 0.227634 -0.000511201 0 0.243087 -0.000496039 0 0.295963 -0.000331892 0 0.227008 0.000318822 0 + 0.296576 -0.000270585 0 0.223861 0.00039524 0 0.278255 -0.00039862 0 0.277024 7.25625e-05 0 + 0.287476 -0.000622088 0 0.287758 -0.000356347 0 0.24935 -0.00108644 0 0.29641 -0.000311607 0 + 0.167597 0.000161308 0 0.101446 7.4402e-05 0 0.290807 -0.000356431 0 0.281874 -0.00052986 0 + 0.203386 -2.48795e-05 0 0.233818 -0.000529375 0 0.253609 0.000167384 0 0.278151 -0.000552464 0 + 0.106379 -0.000258537 0 0.295655 -0.000207328 0 0.295399 -0.000352768 0 0.251012 -0.00154126 0 + 0.294102 -0.000163138 0 0.228058 0.000295425 0 0.293793 -0.000151104 0 0.0409423 -1.00951e-05 0 + 0.175225 -0.000220509 0 0.00824473 -3.60693e-06 0 0.016302 -5.66323e-06 0 0.284249 -0.000937099 0 + 0.217655 -0.000495251 0 0.271185 -0.000649598 0 0.292408 -0.000534936 0 0.28272 -3.94628e-05 0 + 0.296741 -0.000292719 0 0.15319 8.27885e-05 0 0.285785 -0.000651389 0 0.23871 0.000170191 0 + 0.272593 0.000138991 0 0.26237 -0.000645429 0 0.283921 -0.000670829 0 0.280677 -0.000343649 0 + 0.253328 -0.000636909 0 0.281606 3.3223e-05 0 0.279722 -0.000332846 0 0.278594 -0.000638713 0 + 0.218038 0.000235306 0 0.22039 -2.29616e-05 0 0.171887 -0.000398223 0 0.265618 -0.00172214 0 + 0.00886533 3.30395e-06 0 0.0780562 -6.35141e-05 0 0.292876 -0.00039744 0 0.291026 -0.000107561 0 + 0.182869 -0.000271331 0 0.297091 -0.000243625 0 0.24207 -0.000818357 0 0.280523 -0.000652125 0 + 0.258068 0.000283854 0 0.25002 -0.000820932 0 0.282828 -2.05262e-05 0 0.192814 4.39309e-05 0 + 0.225574 0.000280227 0 0.276134 8.38916e-05 0 0.210572 0.000346063 0 0.0982971 -0.000123871 0 + 0.289383 -8.70424e-05 0 0.214766 2.18244e-05 0 0.147049 0.000139588 0 0.251292 -0.000699233 0 + 0.291391 -0.000361119 0 0.246181 0.000252805 0 0.260178 -0.000539238 0 0.129209 8.89505e-05 0 + 0.241734 -0.000483213 0 0.296182 -0.000313599 0 0.24899 0.000171034 0 0.295686 -0.000333161 0 + 0.251242 0.00323249 0 0.139215 -0.000209959 0 0.295074 -0.000354225 0 0.273174 0.00011522 0 + 0.224958 0.000262029 0 0.249782 0.00083199 0 0.232357 -0.00051647 0 0.250712 -0.000739841 0 + 0.281199 -0.000392248 0 0.253309 -0.000861164 0 0.173836 7.3146e-05 0 0.28832 -0.000779318 0 + 0.146219 -0.000215748 0 0.270912 0.000120314 0 0.144376 7.02306e-05 0 0.219564 0.000272673 0 + 0.246755 -0.000739808 0 0.268487 0.000123762 0 0.174349 0.000145353 0 0.288047 -7.95125e-05 0 + 0.228622 -0.000443764 0 0.160758 7.14866e-05 0 0.289861 -9.76758e-05 0 0.130863 7.62812e-05 0 + 0.166503 -0.000342732 0 0.283108 -0.000374504 0 0.132576 0.000116927 0 0.270162 0.000146743 0 + 0.246785 -0.000532414 0 0.21592 -5.81127e-05 0 0.146986 6.73755e-05 0 0.0333728 -8.02462e-06 0 + 0.297148 -0.000241099 0 0.296955 -0.000275021 0 0.0769373 -9.70221e-05 0 0.256384 0.000149729 0 + 0.180944 -0.000258849 0 0.150778 -0.000221004 0 0.274036 8.88431e-05 0 0.278887 -0.00100517 0 + 0.265877 0.000124772 0 0.00858929 -1.45664e-06 0 0.29198 -0.000339049 0 0.273465 -0.000339025 0 + 0.129994 -0.000242503 0 0.270096 0.000578327 0 0.274238 -0.000392789 0 0.0331138 1.76609e-05 0 + 0.214014 -0.000396188 0 0.0566154 -2.14827e-05 0 0.296561 -0.000295022 0 0.149184 -7.55864e-05 0 + 0.189062 -0.000278436 0 0.291506 -0.000657349 0 0.165719 6.03719e-05 0 0.24219 -0.000568705 0 + 0.12248 7.70821e-05 0 0.269401 -0.000548837 0 0.283209 -0.000588627 0 0.217354 0.000316479 0 + 0.296668 -0.000303118 0 0.226034 0.000239048 0 0.171137 -0.000350286 0 0.0324979 -3.33501e-06 0 + 0.245527 0.000163697 0 0.252112 -0.000625038 0 0.237317 0.000429583 0 0.188228 6.57829e-05 0 + 0.232836 -0.000482261 0 0.218459 0.000294359 0 0.27641 -0.000931831 0 0.262241 7.30917e-05 0 + 0.293518 -0.000553366 0 0.288303 -0.000745387 0 0.284895 -0.000357708 0 0.277194 -0.000544256 0 + 0.266347 0.000271335 0 0.0329525 1.01212e-05 0 0.204384 -0.000270494 0 0.258981 -0.000652735 0 + 0.295788 -0.000215079 0 0.29503 -0.000188692 0 0.29416 -0.000161086 0 0.187849 -0.000225513 0 + 0.153317 -0.0002629 0 0.175263 2.77407e-05 0 0.212828 0.000203786 0 0.0338809 -1.95852e-06 0 + 0.295282 -0.000315367 0 0.235828 0.000436761 0 0.289857 -0.000345992 0 0.234431 0.000529369 0 + 0.280265 -0.000381414 0 0.120923 5.78681e-06 0 0.221772 0.000228149 0 0.215104 0.000260145 0 + 0.154729 5.40717e-05 0 0.137417 8.86766e-05 0 0.296558 -0.00027723 0 0.172487 -0.000223949 0 + 0.146138 -0.000265073 0 0.187186 -0.000265183 0 0.287668 -0.000593577 0 0.132517 6.10826e-05 0 + 0.296926 -0.000263965 0 0.294598 -0.000471999 0 0.296508 -0.000306161 0 0.282226 -0.000364329 0 + 0.296157 -0.000327361 0 0.270748 -0.000400622 0 0.194125 -2.56323e-05 0 0.11923 -0.000146616 0 + 0.228921 3.36474e-05 0 0.267715 -0.000308138 0 0.134719 8.89653e-05 0 0.169374 -0.000178856 0 + 0.286194 -0.000373912 0 0.296124 -0.000344286 0 0.289476 -0.000649097 0 0.211665 0.000226339 0 + 0.124173 6.37855e-05 0 0.0328261 1.49544e-06 0 0.179631 -0.00038231 0 0.241674 3.97572e-05 0 + 0.185387 3.00697e-05 0 0.209221 -0.000459058 0 0.117625 -0.00021806 0 0.222874 0.000203416 0 + 0.284921 5.12722e-07 0 0.182199 -1.04457e-05 0 0.248341 3.41837e-05 0 0.289385 -7.71308e-05 0 + 0.194679 -0.00058159 0 0.0339319 -1.20007e-05 0 0.288573 -9.03709e-05 0 0.249902 -0.000477513 0 + 0.0812113 4.21702e-05 0 0.100343 -0.000167816 0 0.224595 0.000198063 0 0.296861 -0.000268192 0 + 0.284908 -0.00064639 0 0.263842 -0.000304744 0 0.0413734 -7.63586e-06 0 0.192013 -9.89579e-06 0 + 0.148566 3.64976e-05 0 0.254571 -0.000524513 0 0.230042 0.000355788 0 0.283407 -5.11818e-05 0 + 0.296299 -0.000220263 0 0.0637762 -4.90446e-05 0 0.289622 -6.39281e-05 0 0.29575 -0.00020231 0 + 0.126157 -0.00013428 0 0.169583 2.58404e-06 0 0.275799 -0.000322997 0 0.167915 -0.000240214 0 + 0.0780606 4.93949e-05 0 0.274067 1.52061e-05 0 0.289412 -0.000152089 0 0.192612 -0.000394351 0 + 0.261302 -0.000269328 0 0.184146 -0.000463548 0 0.28889 -6.60469e-05 0 0.153335 -0.000285413 0 + 0.155367 0.000267981 0 0.0651783 -2.65526e-05 0 0.126979 -0.000169294 0 0.285154 -0.000708525 0 + 0.272139 -6.76816e-05 0 0.220825 -0.0004146 0 0.23698 0.000290157 0 0.195402 -0.000240574 0 + 0.213258 -0.000289483 0 0.238314 -0.000532558 0 0.008416 2.88801e-06 0 0.0172402 7.4785e-06 0 + 0.268468 4.55451e-05 0 0.0878389 -0.000100564 0 0.273181 0.000175707 0 0.19355 9.75087e-05 0 + 0.159368 -0.000188053 0 0.222994 2.15906e-05 0 0.178549 5.88387e-05 0 0.292489 -0.000374161 0 + 0.296745 -0.000236165 0 0.293082 -0.000131948 0 0.177893 -0.000194747 0 0.285167 -0.000608853 0 + 0.195112 -0.000853013 0 0.167198 1.4086e-05 0 0.281449 -7.56688e-05 0 0.218502 0.000191209 0 + 0.152195 5.88438e-05 0 0.136064 -0.00015432 0 0.294416 -0.000478539 0 0.280118 -0.000833248 0 + 0.159802 4.13456e-05 0 0.00851225 2.57255e-06 0 0.0977282 1.33038e-05 0 0.292384 -0.000394869 0 + 0.0160772 1.97873e-06 0 0.0166377 -3.60286e-06 0 0.281236 -0.00065847 0 0.293412 -0.000514086 0 + 0.296822 -0.000277835 0 0.238931 0.000944145 0 0.163733 0.000132311 0 0.226861 -0.000230954 0 + 0.286105 -3.43268e-05 0 0.255861 0.000198556 0 0.280803 -0.000624877 0 0.164568 0.000241427 0 + 0.205236 -0.000177521 0 0.23477 -0.000458625 0 0.105172 3.31333e-05 0 0.128099 7.55182e-05 0 + 0.234136 0.000257961 0 0.235516 0.000360702 0 0.272335 -0.000324035 0 0.290569 -9.00775e-05 0 + 0.180209 -0.000442642 0 0.263826 -2.19042e-05 0 0.105948 -0.00112887 0 0.198509 -0.000310773 0 + 0.0336706 7.48596e-06 0 0.246931 0.00015475 0 0.286646 -5.89297e-05 0 0.11964 7.57929e-05 0 + 0.295424 -0.000193551 0 0.105463 -0.00102624 0 0.117809 -0.000848177 0 0.245479 -0.00051965 0 + 0.236802 0.000406556 0 0.230992 0.000453922 0 0.0334981 -6.66615e-06 0 0.269379 0.0001714 0 + 0.236364 3.12094e-05 0 0.108975 -0.000100389 0 0.0162562 4.92903e-06 0 0.292932 -0.000477041 0 + 0.240143 -0.000274275 0 0.108053 1.65753e-05 0 0.223974 0.000175081 0 0.112435 7.41185e-05 0 + 0.121622 -0.000119689 0 0.162629 -0.000177138 0 0.175825 0.000161688 0 0.145558 -0.000146679 0 + 0.198423 -6.20267e-05 0 0.264598 -0.000542331 0 0.233284 0.000167321 0 0.134404 -0.000179187 0 + 0.290802 -0.000563129 0 0.0163967 -1.40791e-06 0 0.25347 -6.86963e-05 0 0.17072 -0.000505576 0 + 0.254818 -0.000482709 0 0.154056 -0.000271304 0 0.266606 -0.000646092 0 0.292556 -0.000570667 0 + 0.0171612 3.82827e-06 0 0.00791933 1.1631e-05 0 0.297032 -0.000230938 0 0.186748 -4.41329e-05 0 + 0.274791 -0.000644131 0 0.190234 -0.000183701 0 0.239475 0.000259443 0 0.251727 -0.000752918 0 + 0.273067 -0.000379987 0 0.185943 0.000107027 0 0.256193 -0.000707846 0 0.293707 -0.000459068 0 + 0.233428 -7.03815e-05 0 0.129768 6.2306e-05 0 0.288077 -6.67991e-05 0 0.292227 -0.000163479 0 + 0.29306 -0.000138012 0 0.151756 -9.81263e-05 0 0.193024 -0.000221882 0 0.161047 -0.000290383 0 + 0.289201 -0.000339726 0 0.102162 -0.00014384 0 0.121349 6.30591e-05 0 0.145969 4.18775e-05 0 + 0.0420516 -1.0245e-05 0 0.278243 -5.18733e-06 0 0.295184 -0.000186789 0 0.256993 -0.000632822 0 + 0.266227 -0.000684281 0 0.223564 3.2874e-05 0 0.284065 -0.000348103 0 0.0696894 -4.52985e-05 0 + 0.0883277 -0.000104033 0 0.273179 -0.000547289 0 0.078383 -7.2401e-05 0 0.220773 -0.000266307 0 + 0.293034 -0.000322679 0 0.253217 0.000144484 0 0.244571 0.000194829 0 0.242156 0.000290408 0 + 0.197473 -0.000352149 0 0.249707 2.08972e-05 0 0.262523 -0.00116948 0 0.275792 -0.000840445 0 + 0.182711 -0.0002188 0 0.293645 -0.000495914 0 0.237184 0.000177987 0 0.225008 -0.000207559 0 + 0.0167892 -1.06132e-05 0 0.161283 -0.000542593 0 0.209412 -7.91693e-05 0 0.196014 -0.000147438 0 + 0.205604 -0.000326036 0 0.0162697 5.36308e-07 0 0.00807067 2.59708e-06 0 0.11097 -0.000137114 0 + 0.266449 -0.000290986 0 0.0881451 -9.92396e-05 0 0.139113 0.000131641 0 0.201903 -0.000433503 0 + 0.265849 -0.000722522 0 0.295495 -0.000192642 0 0.105453 -9.42614e-05 0 0.11787 -0.000990959 0 + 0.29482 -0.000177145 0 0.0327324 -1.91495e-05 0 0.00834547 -3.67342e-07 0 0.0161325 -2.23437e-06 0 + 0.00843591 -3.31258e-06 0 0.273151 2.73685e-05 0 0.274718 -0.000309581 0 0.0340316 -6.45351e-06 0 + 0.0777249 4.13329e-05 0 0.268925 -3.21398e-05 0 0.253365 -0.000513045 0 0.226641 0.000257502 0 + 0.283947 -7.02401e-07 0 0.174382 -2.68929e-05 0 0.240777 -0.000158133 0 0.214678 0.00019972 0 + 0.233482 -0.000120416 0 0.170294 -0.000531771 0 0.0169975 -4.95287e-06 0 0.0415808 -1.2063e-05 0 + 0.105954 -7.62368e-05 0 0.157034 -0.000207061 0 0.259843 -0.000250473 0 0.291041 -0.000116657 0 + 0.114778 -0.000172165 0 0.200504 -0.000604238 0 0.14688 -0.000251142 0 0.0423293 -4.20587e-05 0 + 0.0991852 -0.000109252 0 0.210133 -7.73268e-06 0 0.259608 0.000565622 0 0.254452 -0.00153544 0 + 0.0165678 -1.02037e-07 0 0.267621 0.000151235 0 0.0080472 6.51012e-07 0 0.0164274 -4.39427e-07 0 + 0.115819 -6.95537e-05 0 0.178401 -0.000109808 0 0.191351 0.00013732 0 0.234704 -0.000222234 0 + 0.24127 -0.000202103 0 0.295018 -0.000264954 0 0.293505 -0.000272075 0 0.140021 -0.00076171 0 + 0.173356 0.000211946 0 0.172522 -0.000381831 0 0.00842146 -1.01826e-06 0 0.282305 -0.000666925 0 + 0.0164939 9.81425e-07 0 0.100246 -0.000112103 0 0.144525 -0.000307848 0 0.257961 -0.00017047 0 + 0.168116 5.38886e-05 0 0.213526 0.000223064 0 0.296057 -0.000217467 0 0.136537 -0.000170605 0 + 0.00864396 -9.74143e-07 0 0.295356 -0.000334689 0 0.141877 -0.00019726 0 0.252508 -0.000200132 0 + 0.229152 -0.000193734 0 0.0917438 4.29786e-05 0 0.0843164 1.06782e-05 0 0.297023 -0.000266749 0 + 0.0161034 9.5909e-07 0 0.231846 -9.39803e-05 0 0.278966 5.26765e-05 0 0.142629 -0.000101171 0 + 0.286587 -7.45784e-05 0 0.24705 -0.000184313 0 0.277969 -0.00162301 0 0.00837981 -3.78786e-06 0 + 0.0168632 1.09278e-06 0 0.229691 0.000290592 0 0.0602538 -4.19727e-05 0 0.262309 0.000154727 0 + 0.23842 -0.000253085 0 0.262893 0.000244912 0 0.18844 -0.000141961 0 0.296487 -0.000249523 0 + 0.216915 0.000256951 0 0.179706 -0.000474532 0 0.140826 -0.000683076 0 0.272492 -0.00169954 0 + 0.129176 -0.000859608 0 0.154015 0.000272851 0 0.0325305 0.000169816 0 0.0992694 7.6462e-05 0 + 0.183169 -0.000190603 0 0.279621 -0.000749811 0 0.107767 -0.000246817 0 0.00790201 1.03947e-06 0 + 0.161323 -1.16703e-05 0 0.0166981 -7.98319e-06 0 0.00844482 -4.22378e-06 0 0.016016 7.17376e-06 0 + 0.00819811 4.06986e-06 0 0.0866738 -7.8009e-05 0 0.295652 -0.000316186 0 0.158581 -0.000149726 0 + 0.255496 -0.000748309 0 0.113592 -0.000106333 0 0.240954 0.000439987 0 0.294448 -0.00031503 0 + 0.282126 -8.67315e-06 0 0.0725938 -4.0553e-05 0 0.272805 -0.000112119 0 0.289531 -0.000313235 0 + 0.131004 -7.85656e-05 0 0.238192 0.000143858 0 0.260096 -0.000663865 0 0.247146 -6.85485e-05 0 + 0.17719 -0.000233457 0 0.231071 -0.000218149 0 0.2258 -7.33216e-05 0 0.00827942 -1.06559e-06 0 + 0.0183517 -2.90171e-05 0 0.0101769 1.4675e-05 0 0.153752 2.15474e-05 0 0.00810663 -1.45002e-07 0 + 0.252912 -0.000173938 0 0.261178 0.00037064 0 0.295906 -0.000206443 0 0.293521 -0.000179006 0 + 0.296566 -0.000311562 0 0.280927 -0.000839188 0 0.150926 -0.000632368 0 0.289879 -0.000158773 0 + 0.295882 -0.000346965 0 0.254129 -0.000221235 0 0.150492 -0.000670271 0 0.0169548 -7.16219e-07 0 + 0.296917 -0.000227795 0 0.0179585 2.84917e-06 0 0.00839436 -6.19397e-07 0 0.0160575 2.91863e-06 0 + 0.0164901 4.79483e-06 0 0.0173948 6.23089e-06 0 0.008495 -4.8046e-07 0 0.296493 -0.00021403 0 + 0.0168776 -8.82804e-07 0 0.0168364 -2.11319e-06 0 0.0185025 1.02612e-05 0 0.0100051 -2.34536e-06 0 + 0.00864772 3.04898e-06 0 0.0165645 3.35834e-07 0 0.0165215 6.26543e-06 0 0.0169845 -3.03606e-06 0 + 0.0168796 3.62804e-06 0 0.016955 -6.26906e-07 0 0.00787473 3.63735e-06 0 0.00853693 2.12647e-06 0 + 0.00878489 5.67028e-06 0 0.00856922 1.87775e-06 0 0.00870646 6.78779e-07 0 0.294342 -0.000183791 0 + 0.295442 -0.000199627 0 0.0089079 2.11591e-06 0 0.00859514 -3.38031e-06 0 0.017859 -2.66998e-06 0 + 0.00830314 7.59998e-07 0 0.00781933 1.21172e-06 0 0.00900816 1.94069e-06 0 0.0170244 8.90322e-06 0 + 0.00871892 6.13007e-06 0 0.0173627 7.65345e-06 0 0.0100115 1.74746e-05 0 0.00849783 1.89533e-06 0 + 0.283995 -0.000256895 0 0.00849225 -4.87453e-06 0 0.297301 -0.00023421 0 0.0169347 -2.13266e-06 0 + 0.0102488 9.98996e-06 0 0.00828628 1.18568e-06 0 0.0191994 3.70482e-06 0 0.00851651 -2.83436e-07 0 + 0.018603 -1.05064e-05 0 0.0199953 1.13291e-05 0 0.00896444 6.51902e-06 0 0.0177301 -6.71885e-06 0 + 0.00938504 -1.05796e-05 0 0.0096269 4.44118e-06 0 0.0104021 -9.69525e-06 0 0.0090401 -1.85026e-06 0 + 0.291822 -0.000273972 0 0.00811439 -1.53498e-06 0 0.01742 -1.38304e-06 0 0.0173264 -7.17775e-06 0 + 0.287166 -0.000266709 0 0.00853712 2.41568e-06 0 0.0184161 -6.25692e-06 0 0.00865619 9.96398e-07 0 + 0.007952 5.87648e-06 0 0.254803 -0.000135202 0 0.0082457 1.71494e-06 0 0.00877864 3.46462e-06 0 + 0.279776 -0.000150534 0 0.00920366 -7.23714e-06 0 0.00990881 5.24571e-06 0 0.00882465 -4.5779e-06 0 + 0.0100567 3.85467e-06 0 0.00873074 -4.04984e-07 0 0.00901236 -5.34762e-06 0 0.00888318 -2.46403e-06 0 + 0.00894346 -2.89038e-06 0 0.00897265 6.27579e-07 0 0.00831821 4.44917e-06 0 0.0169057 3.62512e-06 0 + 0.017667 -6.97409e-06 0 0.00795663 3.76966e-06 0 0.0089135 -5.54204e-06 0 0.205473 -0.000339336 0 + 0.0186982 -1.85102e-05 0 0.00876117 -2.36358e-06 0 0.0093425 -2.4697e-06 0 0.0171261 7.24536e-06 0 + 0.0100109 -1.44258e-05 0 0.0104011 1.60527e-05 0 0.00842181 -4.15458e-06 0 0.00868018 2.85855e-07 0 + 0.197308 -0.000377309 0 0.0178985 -8.55409e-06 0 0.0161614 1.6679e-05 0 0.0180547 -8.29935e-06 0 + 0.00836451 4.46309e-06 0 0.0165337 4.08292e-06 0 0.0101245 -7.73368e-06 0 0.00854 2.30343e-07 0 + 0.0102696 -3.1745e-06 0 0.0193152 -2.01347e-06 0 0.0181759 -1.65881e-05 0 0.00857532 2.52375e-06 0 + 0.010579 6.14401e-06 0 0.0194769 8.69231e-06 0 0.0103093 1.82738e-05 0 0.0171393 5.1119e-06 0 + 0.00927181 5.55476e-06 0 0.0172686 -2.57979e-06 0 0.0206566 -1.20634e-05 0 0.0174318 2.44564e-06 0 + 0.00872588 1.95056e-06 0 0.0088348 -3.0338e-06 0 0.0087177 -8.29243e-06 0 0.00932483 -4.83365e-06 0 + 0.00835676 -4.64168e-08 0 0.00925604 -8.76408e-07 0 0.00963257 -3.1558e-06 0 0.0172368 2.39721e-06 0 + 0.00815436 -5.26387e-05 0 0.0217615 -4.04555e-05 0 0.289527 -0.000270559 0 0.0177128 -7.76594e-06 0 + 0.043095 -0.0023003 0 0.0178101 -7.45238e-06 0 0.0169079 -3.07196e-06 0 0.199152 0.000197522 0 + 0.00818683 2.14906e-06 0 0.00853069 5.0503e-06 0 0.00895829 -3.17139e-06 0 0.020438 -1.26777e-05 0 + 0.0181533 -8.65365e-06 0 0.00864098 -7.5208e-07 0 0.00998742 2.02267e-06 0 0.0103531 -7.04358e-06 0 + 0.0178828 -9.40178e-06 0 0.0088871 5.16711e-06 0 0.00844319 -1.18438e-06 0 0.0170435 5.31696e-06 0 + 0.00936223 -8.71354e-06 0 0.0204094 5.88155e-06 0 0.0103698 -4.54658e-06 0 0.16057 -0.000596336 0 + 0.213439 -0.000303867 0 0.00888108 -5.27258e-06 0 0.00899514 -3.18942e-06 0 0.00831467 4.75864e-06 0 + 0.0222684 -5.24995e-05 0 0.0112585 -1.39762e-05 0 0.0197961 -3.2388e-05 0 0.0114443 -2.34109e-05 0 + 0.0198935 8.68655e-06 0 0.0166549 -2.68374e-06 0 0.0091042 -3.6186e-06 0 0.0186351 -1.30437e-05 0 + 0.0104004 -1.24656e-06 0 0.010353 -3.67376e-06 0 0.0162546 -2.65822e-06 0 0.00996145 1.73639e-06 0 + 0.0939156 -0.00130755 0 0.020154 -1.03676e-05 0 0.0108055 -1.34592e-05 0 0.00986838 -1.24588e-05 0 + 0.0100466 5.19802e-06 0 0.0203738 -1.05892e-05 0 0.0101733 -4.28291e-06 0 0.010831 -1.3521e-05 0 + 0.0166125 -1.14782e-06 0 0.0108356 8.40692e-06 0 0.00938684 1.02548e-05 0 0.220822 -0.000274901 0 + 0.0109491 -1.05511e-05 0 0.0170994 -1.00022e-05 0 0.0174895 -6.7391e-06 0 0.01845 -1.20645e-05 0 + 0.0101557 4.15577e-06 0 0.0102165 -2.63477e-06 0 0.00942716 1.98919e-06 0 0.018616 2.07863e-06 0 + 0.0205926 -2.92501e-06 0 0.00886604 -8.8191e-06 0 0.0192633 9.47699e-06 0 0.228076 -0.000245601 0 + 0.00911361 -1.11322e-06 0 0.00853585 7.33947e-06 0 0.00899275 -2.61126e-06 0 0.00928713 -2.70895e-06 0 + 0.236513 -3.66597e-05 0 0.00900466 -4.3724e-06 0 0.0108213 -7.26367e-06 0 0.00863908 -3.6695e-06 0 + 0.190522 0.00025638 0 0.0201573 1.34578e-05 0 0.0108275 -1.54603e-05 0 0.0179267 -8.30662e-06 0 + 0.00920565 9.46256e-06 0 0.0203162 -1.31485e-05 0 0.00831352 -2.93094e-06 0 0.0193409 8.48716e-06 0 + 0.00865629 -1.05632e-05 0 0.00817926 -1.34446e-06 0 0.00895079 -3.62463e-06 0 0.00971748 4.8091e-06 0 + 0.0092484 -3.30901e-06 0 0.248993 -0.000102673 0 0.00922276 4.91292e-07 0 0.00886781 2.07704e-06 0 + 0.0206119 -2.63096e-05 0 0.00846811 -1.47053e-06 0 0.00928713 -4.1638e-06 0 0.00895336 -1.89103e-06 0 + 0.00828647 -1.36951e-06 0 0.00970414 -7.86619e-06 0 0.00900126 1.28303e-06 0 0.0119688 -2.88801e-05 0 + 0.00966473 3.20403e-06 0 0.0163129 5.06033e-06 0 0.0180431 -1.10867e-05 0 0.0200551 1.41343e-05 0 + 0.0210876 -2.73238e-05 0 0.00967153 5.08076e-06 0 0.0078388 -3.59967e-06 0 0.0102841 -4.54073e-06 0 + 0.00991327 -1.60242e-05 0 0.222679 4.67587e-05 0 0.00855091 1.03973e-05 0 0.0087642 -5.79419e-06 0 + 0.00990133 5.76653e-06 0 0.0208759 -8.44664e-06 0 0.0182386 6.84417e-06 0 0.161164 0.000486166 0 + 0.0105279 5.4839e-06 0 0.0184897 -1.09879e-05 0 0.0104773 -6.15521e-06 0 0.00852585 8.01883e-06 0 + 0.0105328 -1.67794e-06 0 0.00782539 8.55076e-07 0 0.0105825 -3.93598e-06 0 0.0096331 3.03982e-06 0 + 0.0098797 -3.54986e-06 0 0.008647 -1.45993e-05 0 0.0203181 1.45778e-05 0 0.0089308 -9.14576e-06 0 + 0.00869053 -9.77899e-06 0 0.0103153 -8.69581e-06 0 0.0103563 -1.46503e-05 0 0.00869025 7.89307e-06 0 + 0.00804809 3.48825e-06 0 0.0082242 3.13573e-07 0 0.00800618 9.93478e-07 0 0.00988546 1.47588e-05 0 + 0.00979137 -6.62318e-06 0 0.00926698 -1.01037e-06 0 0.00813355 -1.62616e-06 0 0.281018 -0.000253398 0 + 0.00926755 -4.97508e-06 0 0.00959713 4.09009e-07 0 0.00894785 3.54471e-06 0 0.00874482 2.35202e-06 0 + 0.00875777 3.6429e-06 0 0.00866159 -1.9372e-07 0 0.0103402 -4.04898e-06 0 0.0203048 1.51e-05 0 + 0.00948654 1.02893e-05 0 0.00995999 6.00622e-06 0 0.0166789 5.42363e-06 0 0.229816 1.93019e-06 0 + 0.00941901 4.63747e-06 0 0.0206262 -1.18953e-05 0 0.207528 0.000142337 0 0.00916012 4.98721e-06 0 + 0.0101918 5.38552e-06 0 0.243048 -7.36391e-05 0 0.00929319 -7.441e-06 0 0.00799385 -2.64152e-06 0 + 0.0160824 5.53854e-06 0 0.00955985 2.74731e-06 0 0.0102648 5.32911e-06 0 0.010238 -6.1849e-06 0 + 0.00862886 -1.33975e-06 0 0.0171278 3.72451e-06 0 0.0097886 8.57542e-06 0 0.00861718 -1.24805e-06 0 + 0.00895177 -2.60475e-06 0 0.00852852 7.93981e-07 0 0.00816839 1.31558e-05 0 0.00860529 -1.33794e-06 0 + 0.21521 9.2381e-05 0 0.043779 0.00223266 0 0.0084225 1.05637e-06 0 0.00810812 -2.88413e-06 0 + 0.00934328 -2.7477e-06 0 0.00825491 -3.62548e-07 0 0.171073 0.000407714 0 0.263241 -0.000158202 0 + 0.181183 0.000328956 0 0.0165362 -1.63777e-06 0 0.00843792 2.94065e-06 0 0.0946324 0.00126023 0 + 0.008774 -6.13146e-06 0 0.016616 3.88499e-06 0 0.00828117 2.6008e-06 0 0.0700046 0.00172655 0 + 0.0574926 0.00194522 0 0.00849229 9.22215e-07 0 0.016513 1.93835e-06 0 0.0825727 0.00145823 0 + 0.124452 -0.000152218 0 0.288853 -0.000306843 0 0.239852 0.000644168 0 0.279044 -1.72953e-05 0 + 0.147789 -0.000185297 0 0.0170357 -8.46466e-06 0 0.137976 5.50273e-05 0 0.161619 0.000109931 0 + 0.223438 0.000326187 0 0.296425 -0.000298139 0 0.296355 -0.000214931 0 0.188919 -6.27944e-05 0 + 0.296432 -0.00021728 0 0.200458 -8.16955e-05 0 0.295011 -0.000334557 0 0.295234 -0.000186455 0 + 0.15664 0.000212691 0 0.244817 1.3776e-05 0 0.251402 0.000205105 0 0.0918282 -0.000154069 0 + 0.291691 -0.000562515 0 0.273075 -7.95524e-05 0 0.15154 -0.000148459 0 0.129642 -0.000800031 0 + 0.29704 -0.000255321 0 0.233162 0.00267889 0 0.291895 -0.000551388 0 0.280251 -9.23015e-05 0 + 0.297018 -0.00023414 0 0.295949 -0.000315896 0 0.27642 -0.00037599 0 0.276028 -0.000109614 0 + 0.242903 0.000116723 0 0.292198 -0.000367907 0 0.264581 -7.60915e-05 0 0.258202 -0.000519111 0 + 0.29382 -0.000375256 0 0.170654 -0.000226667 0 0.0349119 -3.85316e-05 0 0.177031 -0.000388701 0 + 0.132721 -0.000295705 0 0.170526 -0.000104021 0 0.188909 -0.000405172 0 0.0642329 -4.16714e-05 0 + 0.0332148 -2.76205e-06 0 0.205377 -0.000363741 0 0.181398 0.000199953 0 0.250829 9.82776e-05 0 + 0.162589 0.000279668 0 0.29687 -0.000268473 0 0.150389 0.000148693 0 0.297051 -0.000258873 0 + 0.188642 -0.000424049 0 0.267311 -0.00132353 0 0.222371 0.000350629 0 0.239375 -0.000412568 0 + 0.292478 -0.000135737 0 0.270255 -0.000294322 0 0.291131 -0.000329963 0 0.239242 -0.000458241 0 + 0.293335 -0.000468693 0 0.28613 -0.000113402 0 0.088721 5.90829e-05 0 0.162848 -0.000104041 0 + 0.198747 0.000116769 0 0.252613 -5.23652e-06 0 0.199691 -0.000355572 0 0.0946085 -0.000208364 0 + 0.171379 -0.000192884 0 0.243509 -0.000456613 0 0.176691 -4.36502e-05 0 0.258105 7.62175e-05 0 + 0.246148 -0.000166165 0 0.264738 5.09226e-05 0 0.156273 1.24908e-05 0 0.0812601 2.64988e-05 0 + 0.0585451 -2.18161e-05 0 0.173141 -0.000294848 0 0.249175 -0.00113688 0 0.0731739 -0.000857703 0 + 0.220281 0.000185983 0 0.210569 -0.000187945 0 0.0338034 -4.83612e-06 0 0.247393 -0.000836109 0 + 0.292515 -0.000343077 0 0.184913 -0.000249021 0 0.14705 -0.000359822 0 0.0807141 -0.000497387 0 + 0.259761 -2.53927e-05 0 0.235059 -0.000205799 0 0.213543 0.000321188 0 0.286561 -0.000341453 0 + 0.0173171 2.43179e-06 0 0.166711 -0.000303807 0 0.294815 -0.000388329 0 0.294905 -0.000435008 0 + 0.0702799 -0.000599921 0 0.139609 2.53829e-05 0 0.295639 -0.000350554 0 0.225684 0.000168593 0 + 0.281956 -0.000804674 0 0.248082 -0.000136784 0 0.0853381 -8.00128e-05 0 0.123058 4.9978e-05 0 + 0.135999 0.000240699 0 0.103717 -0.000467772 0 0.228593 0.000433314 0 0.0580279 -1.84606e-05 0 + 0.268609 -0.00037114 0 0.0728607 8.33134e-06 0 0.254749 -8.24125e-05 0 0.295097 -0.000381364 0 + 0.20305 -0.000380727 0 0.0906746 -1.21926e-05 0 0.0631079 0.000148587 0 0.22022 0.000290843 0 + 0.0939222 -0.000566451 0 0.266746 -0.00123904 0 0.255377 9.74004e-05 0 0.235223 -0.000418871 0 + 0.0848537 3.29185e-05 0 0.263151 -0.00093236 0 0.0926739 -6.08711e-05 0 0.270737 2.28183e-05 0 + 0.0168945 -3.3834e-06 0 0.110728 -0.000313954 0 0.16377 -2.58452e-05 0 0.127818 -6.30852e-05 0 + 0.285589 -0.0011448 0 0.290409 -0.000411158 0 0.293379 -0.000147379 0 0.272256 -0.000533911 0 + 0.295899 -0.000359356 0 0.1007 -0.000364445 0 0.252851 -0.00113514 0 0.175466 -0.000178601 0 + 0.14253 0.00033325 0 0.242135 -0.000442715 0 0.264763 -0.00372232 0 0.197615 1.76263e-05 0 + 0.193826 -0.000345637 0 0.119549 0.000130169 0 0.164114 6.97142e-05 0 0.0428866 -1.51981e-05 0 + 0.253714 0.00044165 0 0.0798543 0.000129638 0 0.234867 0.000159561 0 0.235011 -8.68256e-05 0 + 0.138024 -0.000419423 0 0.273117 -0.000773943 0 0.158293 -0.000355548 0 0.281512 1.9443e-05 0 + 0.19261 -0.000304421 0 0.290847 -0.000723307 0 0.2048 -0.000393558 0 0.123314 -0.00034454 0 + 0.23791 1.75375e-05 0 0.0963095 0.000102627 0 0.242416 0.000179241 0 0.0650932 0.000108362 0 + 0.121168 0.000351264 0 0.133315 0.00030661 0 0.211313 -9.88489e-05 0 0.296715 -0.000231097 0 + 0.276109 -7.552e-06 0 0.0873156 -0.00030617 0 0.0770746 -0.000347145 0 0.243387 0.000145763 0 + 0.0841454 -0.000223652 0 0.112714 6.37434e-05 0 0.295129 -0.000371047 0 0.254861 -0.000832439 0 + 0.269949 -0.000340639 0 0.126502 0.000210865 0 0.177173 -0.00029188 0 0.139283 0.00041659 0 + 0.0956067 1.31194e-05 0 0.182785 -0.000429535 0 0.181295 0.000139673 0 0.12606 -0.000418225 0 + 0.0818055 -6.05439e-05 0 0.280862 -3.9511e-05 0 0.116479 -0.000499567 0 0.295126 -0.000192503 0 + 0.149148 2.35035e-05 0 0.292187 -0.00017013 0 0.28797 -0.000152615 0 0.224797 -0.000486417 0 + 0.193833 -0.000122625 0 0.255076 0.000285331 0 0.188086 -0.000157189 0 0.267719 -0.000531357 0 + 0.274926 7.83055e-05 0 0.295825 -0.000357721 0 0.10666 0.000140167 0 0.296792 -0.000224512 0 + 0.212758 -0.000206054 0 0.103858 5.88218e-05 0 0.178721 0.000250928 0 0.219125 0.000313078 0 + 0.269631 -8.1361e-05 0 0.290867 -0.000565082 0 0.292509 -0.000143667 0 0.289849 -0.000109618 0 + 0.156969 -0.000381234 0 0.0828131 9.64014e-05 0 0.114462 5.17577e-05 0 0.297145 -0.000253209 0 + 0.216887 -0.00017286 0 0.204081 0.000196567 0 0.257611 0.000139749 0 0.268647 0.000139895 0 + 0.237622 -0.000107986 0 0.277384 -8.92297e-05 0 0.270313 -0.00012624 0 0.0667219 3.5586e-05 0 + 0.26055 -8.3188e-05 0 0.129259 0.000158818 0 0.291918 -0.00051309 0 0.149401 -0.000136096 0 + 0.147785 0.000198798 0 0.264257 -0.000114902 0 0.176047 -8.65185e-05 0 0.246237 -2.43242e-07 0 + 0.294569 -0.000175846 0 0.239708 0.000134875 0 0.0806805 -1.51415e-05 0 0.217037 -0.000158336 0 + 0.291456 -0.000126509 0 0.257252 -0.00101766 0 0.28383 -0.000105937 0 0.181348 -8.43147e-05 0 + 0.20461 -0.000124037 0 0.264037 -0.000257702 0 0.257135 -0.000211518 0 0.194587 -0.000237024 0 + 0.247384 0.000432541 0 0.17969 -0.000326433 0 0.295613 -0.000364593 0 0.257494 -0.000967297 0 + 0.293437 -0.000152615 0 0.206567 -0.000145905 0 0.230123 -0.000457128 0 0.219721 -9.43629e-05 0 + 0.243187 -0.000155327 0 0.208873 0.000210135 0 0.114502 -4.44594e-05 0 0.277606 -0.000347518 0 + 0.140648 5.10911e-05 0 0.24435 0.000106498 0 0.0741762 2.57395e-05 0 0.193323 -0.000105593 0 + 0.113994 0.000109059 0 0.25391 -1.9213e-05 0 0.292877 -0.00016075 0 0.199669 -0.000176019 0 + 0.295903 -0.00029905 0 0.16864 -0.000214794 0 0.208622 -0.000389376 0 0.24482 -0.000330409 0 + 0.143903 -3.709e-05 0 0.29688 -0.000246644 0 0.294407 -0.000310331 0 0.27802 -0.000309705 0 + 0.148585 0.000130505 0 0.265321 0.000169918 0 0.141316 0.000131822 0 0.142269 1.90897e-05 0 + 0.138022 0.000123151 0 0.201679 -0.000200163 0 0.296363 -0.000267625 0 0.117026 -0.000137831 0 + 0.103028 -8.80122e-05 0 0.242103 -8.33992e-05 0 0.296782 -0.000281735 0 0.226258 -0.000284887 0 + 0.182785 3.18655e-05 0 0.221311 -0.000155149 0 0.183578 -0.000106685 0 0.282618 -0.000329242 0 + 0.259308 6.44819e-05 0 0.229356 -0.000107002 0 0.245921 -0.000481246 0 0.295363 -0.000194833 0 + 0.104972 -3.82381e-05 0 0.252153 8.72011e-05 0 0.138243 0.000171065 0 0.261407 0.000391211 0 + 0.265822 3.87324e-05 0 0.244623 -0.000167463 0 0.219784 -0.000479025 0 0.252317 -0.000412779 0 + 0.241139 -9.74774e-05 0 0.288571 -0.000951818 0 0.244406 -0.000142944 0 0.156238 -0.000136098 0 + 0.180071 0.000239006 0 0.159854 -7.73019e-05 0 0.266428 -0.000433781 0 0.181726 -6.3469e-05 0 + 0.296176 -0.000298917 0 0.278612 -0.000359051 0 0.249727 0.000473049 0 0.288404 -0.000158738 0 + 0.18404 -9.07953e-05 0 0.153272 0.000154528 0 0.210986 -8.94603e-05 0 0.155317 -4.11217e-05 0 + 0.0337332 -1.25365e-05 0 0.221489 -0.000113073 0 0.090769 5.80033e-05 0 0.0689009 -6.9706e-05 0 + 0.113993 0.000234577 0 0.147569 3.62232e-07 0 0.12587 4.78455e-05 0 0.266829 -0.000247201 0 + 0.0873832 4.05648e-05 0 0.23332 -0.000445203 0 0.152244 0.000143646 0 0.265999 -0.000471351 0 + 0.111326 0.000299204 0 0.252344 0.00066018 0 0.235839 -8.21776e-05 0 0.256688 -0.00107411 0 + 0.168935 -1.88883e-06 0 0.0905075 0.000183128 0 0.220242 0.000401578 0 0.0813307 -1.93126e-05 0 + 0.281518 -0.000627406 0 0.270369 0.000159688 0 0.155463 6.28982e-05 0 0.247223 -0.000493842 0 + 0.0946575 -7.52615e-05 0 0.271704 1.04258e-05 0 0.0723187 6.22384e-05 0 0.272735 -0.000240809 0 + 0.0752074 4.77569e-05 0 0.269493 -0.000238191 0 0.294929 -0.000177186 0 0.246645 -0.000123962 0 + 0.284438 -0.00031575 0 0.269048 -0.000278701 0 0.144895 -0.000112671 0 0.265992 -0.000597935 0 + 0.197899 -0.000342728 0 0.143967 9.15556e-05 0 0.158004 2.88758e-05 0 0.274128 0.000163233 0 + 0.0875425 -3.18687e-06 0 0.103857 0.000185222 0 0.171364 -3.19877e-05 0 0.158233 -0.000294024 0 + 0.0742847 4.63903e-06 0 0.269644 0.000182934 0 0.286137 -0.000303748 0 0.273048 -0.000580062 0 + 0.103947 9.23423e-05 0 0.132135 -0.00016835 0 0.20875 -5.90452e-05 0 0.285623 4.65635e-05 0 + 0.287535 -5.55379e-05 0 0.237843 -0.000444881 0 0.287714 -0.000294742 0 0.245917 -0.000604102 0 + 0.262702 -0.000239456 0 0.0845877 6.36526e-06 0 0.233723 -0.000403812 0 0.257489 -0.000105338 0 + 0.0702863 3.01637e-05 0 0.121062 -6.96062e-05 0 0.289171 -0.000284633 0 0.107458 7.63992e-05 0 + 0.286071 -0.000471175 0 0.254377 -0.000130118 0 0.27696 -1.98478e-05 0 0.241928 0.000154673 0 + 0.294252 -0.000354003 0 0.265342 -0.000125557 0 0.296406 -0.000284077 0 0.248656 0.000282218 0 + 0.195415 -0.000128418 0 0.281903 -0.000578107 0 0.210056 0.000186475 0 0.271545 -0.000134184 0 + 0.277319 -0.000624747 0 0.261708 -9.54204e-05 0 0.0910911 -2.24809e-05 0 0.0739787 4.32614e-05 0 + 0.097951 3.42067e-06 0 0.292859 -0.000152434 0 0.212421 0.000343733 0 0.135546 -9.99155e-05 0 + 0.290311 -0.000119631 0 0.123093 0.000100111 0 0.291869 -0.000444071 0 0.291459 -0.000136983 0 + 0.219319 -0.000128361 0 0.296792 -0.000270352 0 0.297059 -0.000257328 0 0.122353 9.334e-05 0 + 0.297208 -0.000247513 0 0.276975 -0.000501385 0 0.214912 -0.000146993 0 0.277643 -0.000468473 0 + 0.25725 0.000115684 0 0.112865 -6.47683e-05 0 0.284292 -0.000641796 0 0.288988 -0.000130326 0 + 0.268492 -0.000224773 0 0.285782 -0.000332858 0 0.292112 -0.000126157 0 0.241157 -1.02604e-05 0 + 0.290286 -0.000132566 0 0.278204 -9.99432e-05 0 0.279715 -0.000606132 0 0.265549 -0.000229999 0 + 0.287161 -8.55887e-05 0 0.285448 -0.00050023 0 0.0637614 3.8964e-05 0 0.296136 -0.000267777 0 + 0.281714 -0.000318715 0 0.295585 -0.000298332 0 0.0670318 -1.19247e-05 0 0.201196 -0.000129043 0 + 0.134818 -4.96911e-05 0 0.27974 4.12363e-05 0 0.190183 0.000126067 0 0.175814 -0.000132314 0 + 0.137382 4.63865e-05 0 0.296582 -0.00028301 0 0.296857 -0.000229148 0 0.11104 6.88002e-08 0 + 0.213596 8.07003e-05 0 0.215215 -0.000138349 0 0.247819 -0.000139342 0 0.11735 5.19302e-05 0 + 0.143923 -0.00025453 0 0.08027 -5.23087e-05 0 0.202865 0.000217512 0 0.276992 -0.000297171 0 + 0.124638 -0.000159028 0 0.215829 0.000172818 0 0.190155 -0.000303957 0 0.164705 -0.000148162 0 + 0.25874 -0.000116817 0 0.247806 -0.00066239 0 0.285335 -0.000295462 0 0.191983 -0.000333178 0 + 0.250122 -9.5033e-05 0 0.268191 1.53943e-05 0 0.197182 -0.000260172 0 0.108352 -4.71374e-05 0 + 0.150154 -1.0828e-05 0 0.189555 -0.000426732 0 0.286963 -0.000286473 0 0.241748 -0.000602843 0 + 0.133119 8.5477e-06 0 0.283586 -0.000306215 0 0.222515 0.000117803 0 0.218124 0.000100281 0 + 0.0614424 -3.36958e-05 0 0.238776 -0.000496701 0 0.0978532 5.31635e-05 0 0.210155 -0.000164032 0 + 0.220668 0.000250845 0 0.296966 -0.000262093 0 0.188868 0.000152534 0 0.152464 0.000200371 0 + 0.287307 -0.000418505 0 0.108807 -0.000127193 0 0.243561 -9.84241e-05 0 0.28732 -0.000680031 0 + 0.267337 0.000258867 0 0.267709 8.2398e-05 0 0.275364 -0.000364326 0 0.268036 -0.000107917 0 + 0.262583 0.000172437 0 0.212185 -0.000187192 0 0.235892 0.000122015 0 0.195358 0.000142176 0 + 0.291481 -0.000468372 0 0.151776 -3.41735e-06 0 0.119758 0.000114478 0 0.291856 -0.000145883 0 + 0.293325 -0.000454311 0 0.296137 -0.000283885 0 0.0956522 -7.61605e-05 0 0.203635 -0.000350541 0 + 0.296571 -0.000270516 0 0.296887 -0.00025793 0 0.289482 -0.000139139 0 0.290731 -0.000141485 0 + 0.25894 0.000259648 0 0.120833 7.93083e-06 0 0.220571 -0.000221674 0 0.284116 -0.00127988 0 + 0.135842 2.43543e-07 0 0.137769 -0.000110507 0 0.206609 -0.000236298 0 0.230887 0.000147331 0 + 0.247416 8.582e-05 0 0.115619 6.07154e-05 0 0.207478 -0.000200986 0 0.295305 -0.000387556 0 + 0.1557 -0.000173219 0 0.134674 -0.000129101 0 0.224724 7.40543e-06 0 0.131048 -0.00010515 0 + 0.263537 -0.000532868 0 0.207722 0.000107013 0 0.158944 -0.000279362 0 0.179669 0.000270088 0 + 0.293377 -0.000374204 0 0.0534664 2.20022e-05 0 0.165454 -5.69147e-05 0 0.290086 -7.39975e-05 0 + 0.222478 -0.000243694 0 0.140235 -0.000311154 0 0.151904 -0.000260498 0 0.142129 -0.000134154 0 + 0.255151 -0.00111303 0 0.106839 6.30283e-05 0 0.283877 -1.43799e-05 0 0.151171 -0.000273852 0 + 0.0581874 -3.73503e-05 0 0.168338 0.000230679 0 0.245031 0.000214751 0 0.258043 -0.00145233 0 + 0.263135 0.000123858 0 0.12337 -7.90252e-05 0 0.292339 -0.000527221 0 0.292576 -0.000614612 0 + 0.230293 -0.000274474 0 0.134681 7.68117e-05 0 0.116216 3.60301e-05 0 0.288252 -0.000593277 0 + 0.295656 -0.000200292 0 0.0863981 -0.000123383 0 0.212373 0.000244317 0 0.192609 -9.76343e-06 0 + 0.232081 -0.000294218 0 0.180449 6.93318e-05 0 0.231986 0.000424045 0 0.283881 -0.00141137 0 + 0.092591 2.15882e-05 0 0.23432 0.000131201 0 0.101484 4.20393e-05 0 0.103306 3.21232e-05 0 + 0.266994 -0.000608775 0 0.0617676 3.73066e-05 0 0.296274 -0.000228751 0 0.263944 9.02149e-05 0 + 0.236904 -0.000519794 0 0.157037 -5.33309e-05 0 0.268898 0.000278977 0 0.178102 -0.000159439 0 + 0.249526 -0.000158706 0 0.261459 0.000181994 0 0.264518 0.000195208 0 0.224646 -0.000361653 0 + 0.13754 0.00014132 0 0.144678 -0.000240661 0 0.154922 -0.000196711 0 0.234425 -0.000263498 0 + 0.170989 0.00012843 0 0.239324 -0.000321672 0 0.141255 -2.294e-05 0 0.262038 0.000269996 0 + 0.247599 -0.000363999 0 0.0788762 2.48532e-05 0 0.056823 1.28578e-05 0 0.245065 -0.000675361 0 + 0.157801 -0.00018447 0 0.255656 -0.000191203 0 0.241025 -0.000339345 0 0.249171 -0.000379595 0 + 0.162973 -3.14176e-05 0 0.218332 -0.000255518 0 0.27276 -0.000282462 0 0.20769 0.000231145 0 + 0.0171372 -3.45988e-06 0 0.148049 0.000229339 0 0.226828 -0.000688789 0 0.109161 2.21517e-05 0 + 0.211721 9.02092e-05 0 0.255182 -0.000401533 0 0.115221 -7.38581e-05 0 0.251455 -0.000108349 0 + 0.23031 0.000116592 0 0.280119 -0.000297527 0 0.253212 0.00027594 0 0.206506 0.000250803 0 + 0.0664414 1.68864e-05 0 0.104642 -0.000102362 0 0.0911268 3.18929e-05 0 0.204551 0.00014877 0 + 0.2021 0.000199367 0 0.26887 -0.000710928 0 0.229246 0.000155138 0 0.1015 -0.000194953 0 + 0.271605 -0.000268105 0 0.216308 0.000109089 0 0.134165 3.57537e-05 0 0.103982 -1.39547e-05 0 + 0.226253 -0.000377373 0 0.256724 -0.000416204 0 0.161872 -0.000206718 0 0.208147 0.000190405 0 + 0.0874729 7.06338e-05 0 0.294595 -0.000168527 0 0.243215 -0.000312329 0 0.294069 -0.000174741 0 + 0.110393 4.14796e-05 0 0.21666 -0.00033336 0 0.180366 0.000321469 0 0.296506 -0.000256187 0 + 0.262252 -0.000430973 0 0.189517 -6.71528e-05 0 0.0734765 2.64768e-05 0 0.282968 -0.000670854 0 + 0.229124 -0.000405257 0 0.294807 -0.000183154 0 0.294646 -0.000354791 0 0.289796 -0.000407178 0 + 0.263639 -0.000445134 0 0.294978 -0.000435359 0 0.0339976 -1.43643e-05 0 0.137128 0.000233194 0 + 0.133817 -0.000145637 0 0.271728 -0.000697185 0 0.230619 -0.000418916 0 0.291729 -0.000310594 0 + 0.293715 -0.0004461 0 0.21399 0.00017799 0 0.144316 -0.000145196 0 0.21122 0.000264706 0 + 0.0905048 4.41322e-05 0 0.110308 -0.000109478 0 0.0703274 -3.57632e-05 0 0.286573 -0.00041283 0 + 0.26861 -0.000457345 0 0.219182 0.00042804 0 0.199797 -1.68275e-05 0 0.295563 -0.000395717 0 + 0.274209 -0.000472436 0 0.0714539 -4.60786e-05 0 0.042122 -2.2162e-05 0 0.296389 -0.000306014 0 + 0.206953 0.000213134 0 0.0757336 -6.87934e-05 0 0.186531 -0.00029608 0 0.218173 -0.000465921 0 + 0.17878 0.000378003 0 0.232409 6.31631e-06 0 0.077464 2.6135e-05 0 0.294369 -0.000438114 0 + 0.29364 -0.000527464 0 0.136909 -0.000138099 0 0.295202 -0.000415244 0 0.269779 -0.000469445 0 + 0.200396 0.000157626 0 0.275254 -0.00048355 0 0.146999 -0.000201052 0 0.174521 -0.000250374 0 + 0.235348 8.6986e-05 0 0.241311 -0.000637465 0 0.122679 -0.000105096 0 0.290524 -0.000324433 0 + 0.199048 -0.000103145 0 0.188031 0.000130203 0 0.174776 3.25467e-05 0 0.20934 0.000163828 0 + 0.295511 -0.000232687 0 0.204101 -8.16017e-05 0 0.188415 -0.000308504 0 0.13143 3.97096e-05 0 + 0.240876 -0.00067364 0 0.163281 -0.000363513 0 0.111215 -0.000100243 0 0.126989 0.000173481 0 + 0.279161 -0.000482396 0 0.139612 0.000114536 0 0.292753 -0.000130528 0 0.225071 0.00014143 0 + 0.213468 -0.000427778 0 0.270619 -9.28287e-05 0 0.107441 4.16902e-05 0 0.141659 0.00020822 0 + 0.239194 0.000103073 0 0.291096 -0.000616448 0 0.082146 -5.81352e-05 0 0.258888 0.000199013 0 + 0.0168561 1.09448e-06 0 0.216144 -0.000233239 0 0.219374 0.000575735 0 0.0462605 -1.72761e-05 0 + 0.286951 -0.00038121 0 0.260201 -0.000203393 0 0.210882 -0.000369976 0 0.263436 0.000205192 0 + 0.237406 -0.000599657 0 0.291619 -0.00039056 0 0.206211 -0.000110373 0 0.22785 8.98064e-05 0 + 0.218603 -7.23524e-06 0 0.287378 -0.000319026 0 0.0673914 -4.32461e-05 0 0.084559 -2.8442e-05 0 + 0.27562 5.00253e-05 0 0.223238 -0.000473328 0 0.0601489 -6.92238e-05 0 0.240426 -0.000712834 0 + 0.18725 -3.76298e-05 0 0.14244 0.000167333 0 0.0565552 2.3494e-05 0 0.170144 -0.000191051 0 + 0.0560352 2.99069e-05 0 0.294412 -0.000427107 0 0.280079 -0.00048997 0 0.107624 0.000112952 0 + 0.255829 -0.000621318 0 0.267453 -0.000355091 0 0.123297 0.000142161 0 0.273926 -0.000636422 0 + 0.284522 -0.00060283 0 0.296509 -0.000222699 0 0.273722 -0.000122148 0 0.187675 0.000257279 0 + 0.140688 0.000125922 0 0.249246 -2.76399e-05 0 0.295491 -0.000257099 0 0.0712889 5.05771e-05 0 + 0.215791 0.000278096 0 0.176772 0.000222219 0 0.223882 0.000284474 0 0.219229 -0.000401039 0 + 0.266991 -9.71488e-05 0 0.143493 -0.000165888 0 0.271394 -0.000448334 0 0.28711 -0.00047877 0 + 0.283457 -0.000483094 0 0.29009 -0.000462018 0 0.236164 -0.000282945 0 0.284251 -0.000489926 0 + 0.287759 -0.000482064 0 0.272438 6.25839e-05 0 0.171049 -8.26706e-05 0 0.23401 -8.43159e-06 0 + 0.275157 -9.9336e-05 0 0.24038 -0.000590018 0 0.183519 0.000136963 0 0.294749 -0.000447479 0 + 0.203326 0.000176288 0 0.108608 4.97283e-05 0 0.0981076 -7.96508e-05 0 0.121549 -0.000118863 0 + 0.252704 0.000196606 0 0.296992 -0.000247893 0 0.288106 -0.000326544 0 0.17947 0.000193097 0 + 0.0999305 -4.93624e-05 0 0.284529 -2.61513e-05 0 0.0870682 -0.000179087 0 0.290642 -0.000463866 0 + 0.282906 -0.000850077 0 0.22677 0.000133445 0 0.193268 0.000146114 0 0.210502 0.000247044 0 + 0.29603 -0.000205322 0 0.163935 -0.000217749 0 0.293784 -0.000167284 0 0.176495 -0.000262212 0 + 0.1259 0.000103851 0 0.194829 -4.20802e-05 0 0.179605 -0.000309368 0 0.043068 1.6664e-05 0 + 0.242632 -2.5095e-05 0 0.162769 0.000114565 0 0.27409 -0.00122068 0 0.119079 3.23939e-05 0 + 0.226164 9.98947e-05 0 0.207507 -0.00044592 0 0.175135 -0.000306517 0 0.292506 -0.000445906 0 + 0.238328 -0.000116309 0 0.100027 5.72e-05 0 0.293739 -0.000161204 0 0.081366 -5.64198e-05 0 + 0.278972 -0.000599237 0 0.156595 -0.000340829 0 0.220758 0.000126113 0 0.192796 0.000188988 0 + 0.231939 0.000107041 0 0.282337 -0.00072812 0 0.277745 4.66203e-05 0 0.0977405 -4.16468e-05 0 + 0.142681 -0.00018181 0 0.098446 4.06312e-05 0 0.0801778 3.22436e-05 0 0.160021 0.000209292 0 + 0.0969767 5.56236e-05 0 0.276919 5.80842e-05 0 0.185885 -0.000321853 0 0.194445 -0.000317349 0 + 0.130642 1.19709e-05 0 0.294476 -0.000186999 0 0.225811 -0.000417713 0 0.285417 -0.000467681 0 + 0.295568 -0.00037612 0 0.294346 -0.000417409 0 0.190752 -0.000381636 0 0.218127 0.000455715 0 + 0.296169 -0.000336902 0 0.276771 -0.000463493 0 0.14878 0.000184595 0 0.258541 0.000182421 0 + 0.166723 0.000175234 0 0.283281 1.13309e-05 0 0.274743 6.14163e-05 0 0.29298 -0.000445797 0 + 0.294698 -0.000413269 0 0.0172202 -3.55073e-06 0 0.204131 3.42009e-05 0 0.29703 -0.00024428 0 + 0.295789 -0.000369899 0 0.27404 -0.000258345 0 0.240697 9.24477e-05 0 0.0942189 3.15204e-05 0 + 0.276518 -0.000613268 0 0.200873 0.000219509 0 0.195848 0.000205198 0 0.157825 -5.88668e-05 0 + 0.0486618 -2.42918e-05 0 0.289316 -4.9894e-05 0 0.239848 -0.000130837 0 0.281423 -0.000468141 0 + 0.0939136 5.68661e-05 0 0.293109 -0.000149095 0 0.148326 -0.000326112 0 0.288764 -0.000456497 0 + 0.295182 -0.000254701 0 0.258694 -0.00130865 0 0.29033 -0.000561616 0 0.248055 0.000200795 0 + 0.229632 -0.000491905 0 0.294958 -0.000212884 0 0.296272 -0.000331564 0 0.187946 0.000346553 0 + 0.252896 -0.00015419 0 0.137534 -6.83253e-05 0 0.288069 -3.02459e-05 0 0.0805247 -8.1582e-05 0 + 0.291442 -0.000442065 0 0.0769425 4.88082e-05 0 0.100289 3.41684e-05 0 0.160391 -0.000247492 0 + 0.205295 0.000172422 0 0.127932 -9.80152e-05 0 0.133408 -0.000271973 0 0.182204 -0.000297918 0 + 0.271109 -0.00035528 0 0.296251 -0.00021035 0 0.292285 -0.000315194 0 0.295143 -0.000206598 0 + 0.150279 0.00017646 0 0.29397 -0.000307612 0 0.0760196 6.22993e-05 0 0.145575 -2.78888e-05 0 + 0.285541 -1.18625e-05 0 0.197297 -0.000370309 0 0.284505 2.39301e-05 0 0.110406 8.00258e-05 0 + 0.266935 0.000113845 0 0.296188 -0.00029207 0 0.236442 -0.000553416 0 0.282388 -0.000509206 0 + 0.13966 -0.000188823 0 0.252316 0.000176542 0 0.276315 -0.000762381 0 0.295175 -0.000295899 0 + 0.274459 -0.00130224 0 0.127559 9.82494e-05 0 0.124749 2.54352e-05 0 0.277939 -0.00050904 0 + 0.294624 -0.000208083 0 0.160346 -0.000305734 0 0.261248 0.000297906 0 0.0477668 -1.7271e-05 0 + 0.296186 -0.000284487 0 0.212597 0.000462718 0 0.295969 -0.000315458 0 0.210066 0.000285066 0 + 0.292723 -0.000147068 0 0.191515 0.000207341 0 0.266135 0.000143205 0 0.272477 -0.000456904 0 + 0.230995 -0.000123973 0 0.214667 0.000299352 0 0.145996 0.000129054 0 0.242598 0.000519643 0 + 0.205758 0.00023347 0 0.24374 -0.000662041 0 0.105647 4.84353e-05 0 0.294851 -0.000263869 0 + 0.219631 0.000161782 0 0.142717 -4.79379e-06 0 0.130203 -0.000108608 0 0.116218 8.92923e-05 0 + 0.275187 -0.000605252 0 0.269081 -0.000586531 0 0.258877 -0.000184979 0 0.225147 -0.000147715 0 + 0.126463 -0.000234582 0 0.149362 -0.000311979 0 0.295623 -0.000242102 0 0.141827 -0.000288819 0 + 0.0805835 -8.17391e-05 0 0.264832 -0.000711672 0 0.112086 1.98344e-05 0 0.244639 -0.000714934 0 + 0.211238 0.000158642 0 0.165758 0.000162082 0 0.294267 -0.000176582 0 0.205959 -0.000329125 0 + 0.148588 -0.000165901 0 0.267144 0.000189974 0 0.254988 0.000224669 0 0.279142 -0.000285683 0 + 0.28221 -0.000473529 0 0.293116 -0.000513829 0 0.153396 -0.000231711 0 0.289977 -6.20815e-05 0 + 0.20806 -0.000418615 0 0.244601 -0.000591677 0 0.257088 1.91158e-07 0 0.241899 0.000408463 0 + 0.187778 -0.000334079 0 0.288718 -3.61703e-05 0 0.149171 -0.000211664 0 0.209767 -0.000431579 0 + 0.111154 -0.000114992 0 0.127593 -0.000152757 0 0.0739086 -4.66639e-05 0 0.154769 0.000145141 0 + 0.129283 -1.96593e-05 0 0.204564 0.000252733 0 0.274356 -0.000595852 0 0.27004 -0.000596034 0 + 0.296862 -0.000251373 0 0.169235 -0.000272388 0 0.25103 0.000310001 0 0.29153 -9.49627e-05 0 + 0.275064 -0.00277576 0 0.0832311 4.33644e-05 0 0.253705 -0.000818425 0 0.117958 1.27522e-05 0 + 0.296198 -0.000311131 0 0.126497 -9.3356e-06 0 0.294277 -0.000202792 0 0.29571 -0.000325368 0 + 0.18405 0.000193065 0 0.168681 -6.21348e-05 0 0.217145 -0.000524364 0 0.26866 0.000194428 0 + 0.0896302 -6.2225e-05 0 0.112693 -0.000116818 0 0.256661 -0.000545018 0 0.272155 -0.000568552 0 + 0.0601426 2.02954e-05 0 0.275141 -0.000272225 0 0.169939 -0.000251447 0 0.295203 -0.000227907 0 + 0.178949 -0.000330259 0 0.173877 0.000177827 0 0.295564 -0.000268184 0 0.288372 -4.66793e-05 0 + 0.224265 -0.000403883 0 0.295377 -0.000395614 0 0.277652 0.000211216 0 0.197901 0.000203436 0 + 0.118313 -0.000120554 0 0.16854 -0.000291485 0 0.199647 0.000238015 0 0.106936 9.54609e-05 0 + 0.264253 0.000179916 0 0.285417 2.18752e-05 0 0.105695 8.2846e-05 0 0.259824 0.000598052 0 + 0.080985 -8.3889e-05 0 0.177153 -1.33676e-06 0 0.113966 -7.72441e-06 0 0.198366 0.000161496 0 + 0.0808827 -8.82378e-05 0 0.29465 -0.000439115 0 0.244132 -0.000753722 0 0.112889 -5.06361e-05 0 + 0.279485 -0.000960596 0 0.150738 -0.000176026 0 0.289329 -0.000459651 0 0.240827 -0.000556111 0 + 0.196653 0.000222032 0 0.294796 -0.000201563 0 0.21293 -0.000456771 0 0.263513 -0.00019629 0 + 0.295734 -0.000373249 0 0.293063 -0.000485536 0 0.257698 0.000208592 0 0.202956 0.00030967 0 + 0.183732 -0.000910248 0 0.120362 -9.68665e-05 0 0.131219 0.000170423 0 0.209338 0.000267126 0 + 0.227002 -0.000163697 0 0.199098 -0.000382929 0 0.237372 -0.000483572 0 0.246162 0.000639019 0 + 0.271997 0.000174742 0 0.287526 -1.7683e-05 0 0.28155 -0.00050381 0 0.0837114 3.67132e-05 0 + 0.235985 -0.000586462 0 0.208913 0.000305688 0 0.199625 0.000132818 0 0.127557 2.10441e-05 0 + 0.2214 0.000155265 0 0.239938 -0.000624108 0 0.139525 -0.000324828 0 0.2939 -0.000208846 0 + 0.294101 -0.000180213 0 0.282094 -0.000285887 0 0.18027 -0.000285972 0 0.29229 -0.000140988 0 + 0.178121 0.000207336 0 0.215662 -0.000409509 0 0.27171 9.2565e-05 0 0.151436 0.000276292 0 + 0.278737 -0.000823845 0 0.276856 -0.000253323 0 0.295322 -0.000238438 0 0.267904 -0.000701669 0 + 0.195406 0.000239599 0 0.087121 -5.87436e-05 0 0.286096 1.32117e-06 0 0.215124 -0.000440822 0 + 0.239501 -0.000659559 0 0.081329 3.66995e-06 0 0.234572 -0.000151635 0 0.28997 -0.00070605 0 + 0.21397 0.000281037 0 0.292498 -0.000493157 0 0.0906 7.2643e-05 0 0.14293 -0.000117504 0 + 0.134227 -0.000263979 0 0.294353 -0.00044774 0 0.294831 -0.000377502 0 0.282319 -0.000755175 0 + 0.222734 -0.000504108 0 0.29663 -0.000220019 0 0.272528 0.000282107 0 0.295262 -0.000267718 0 + 0.294878 -0.000225865 0 0.266911 0.000175905 0 0.295492 -0.00028056 0 0.260631 0.000207826 0 + 0.219273 -0.00050862 0 0.263088 0.000324334 0 0.0833314 -6.81337e-05 0 0.289517 -5.07056e-05 0 + 0.198512 -0.000408233 0 0.267938 0.000165333 0 0.26728 0.000343899 0 0.235254 -0.000782109 0 + 0.294498 -0.000265814 0 0.233351 -0.000561965 0 0.221881 8.0923e-05 0 0.292651 -0.000610932 0 + 0.265595 -0.00063669 0 0.294453 -0.000198499 0 0.159825 0.000146943 0 0.277492 -0.000262394 0 + 0.265052 0.000153634 0 0.08697 2.80137e-05 0 0.141295 -0.000156634 0 0.186237 0.000192501 0 + 0.188098 0.000224328 0 0.279283 -0.000911825 0 0.247868 0.000118116 0 0.295009 -0.000238275 0 + 0.292022 -0.000109822 0 0.180901 -0.000342152 0 0.137264 -0.000220124 0 0.252946 -0.000551175 0 + 0.136491 -0.000232762 0 0.0838153 2.37949e-05 0 0.215319 0.000488399 0 0.254479 -0.000735551 0 + 0.0947042 -9.30433e-05 0 0.0896302 8.28224e-05 0 0.105019 9.33666e-06 0 0.214592 -0.000469898 0 + 0.265648 0.000413132 0 0.0788197 -5.10032e-05 0 0.0610728 -4.41915e-05 0 0.249913 -0.000603506 0 + 0.247366 -0.000699374 0 0.140902 0.000174136 0 0.293599 -0.000531952 0 0.20165 0.000236535 0 + 0.246816 -0.00114605 0 0.294788 -0.000293985 0 0.29545 -0.00033347 0 0.149225 0.000162987 0 + 0.294947 -0.000274702 0 0.293279 -0.00054635 0 0.231883 -0.000548834 0 0.288108 -0.000138687 0 + 0.19922 0.000273685 0 0.266117 0.000200439 0 0.193876 -0.000515178 0 0.24571 0.00120143 0 + 0.251701 -0.00066113 0 0.294526 -0.000231587 0 0.29185 -0.000131255 0 0.28829 -2.42687e-05 0 + 0.247122 0.000227405 0 0.106411 -8.71435e-05 0 0.190682 0.000190576 0 0.207761 0.000326889 0 + 0.182294 0.000239749 0 0.21625 0.000339467 0 0.080453 2.9233e-05 0 0.156277 -0.00022596 0 + 0.294088 -0.000196973 0 0.212836 0.000302099 0 0.205378 -0.000553685 0 0.262281 0.000355681 0 + 0.289768 -0.000798301 0 0.251482 -0.000792515 0 0.288489 -2.4424e-05 0 0.271039 0.000185884 0 + 0.294678 -0.000243074 0 0.289184 -4.15995e-05 0 0.291955 -0.000627663 0 0.135804 0.000101715 0 + 0.224299 -0.000517333 0 0.208175 0.000287233 0 0.163882 0.000200429 0 0.272651 8.18532e-05 0 + 0.258466 0.000105086 0 0.269979 -0.00195473 0 0.211524 0.000491954 0 0.221256 -0.000190259 0 + 0.290592 -0.000619089 0 0.294851 -0.000442079 0 0.0742373 5.8194e-05 0 0.236352 0.000460851 0 + 0.278096 -0.00121098 0 0.0605246 4.50486e-05 0 0.173827 -0.000274325 0 0.284679 4.97386e-05 0 + 0.137822 0.000190742 0 0.186738 -0.000540327 0 0.292501 -0.000639125 0 0.281247 -0.000276444 0 + 0.260489 -0.000626623 0 0.139795 0.000163214 0 0.155411 0.000180643 0 0.112801 9.75909e-05 0 + 0.175811 -0.000285894 0 0.291565 -9.89874e-05 0 0.294156 -0.00023151 0 0.290208 -0.00029691 0 + 0.249078 -0.000675501 0 0.269617 -0.000635623 0 0.20337 0.000271933 0 0.18939 0.000208115 0 + 0.259727 0.000172799 0 0.295151 -0.000335964 0 0.172729 0.000264746 0 0.260563 0.000427561 0 + 0.174486 0.000221226 0 0.236959 -0.000633943 0 0.143979 0.000158608 0 0.192072 0.000257706 0 + 0.295396 -0.000365961 0 0.294611 -0.000278085 0 0.077614 2.48313e-06 0 0.124767 9.66177e-05 0 + 0.0947873 5.84975e-06 0 0.0697709 1.22189e-05 0 0.128269 -8.15653e-05 0 0.168759 0.000203486 0 + 0.291232 -9.47019e-05 0 0.190235 0.000224005 0 0.139516 -0.000230991 0 0.266664 9.34237e-05 0 + 0.2969 -0.000235285 0 0.267202 0.000444842 0 0.132766 -0.000200388 0 0.255024 -0.000695105 0 + 0.125014 -0.000300896 0 0.294314 -0.000243924 0 0.0802233 5.99164e-05 0 0.294155 -0.000501905 0 + 0.247796 -0.000795007 0 0.0762173 2.38374e-05 0 0.293213 -0.000174131 0 0.208682 -0.000486166 0 + 0.134845 0.00013868 0 0.293698 -0.00019814 0 0.278526 -0.00219331 0 0.295937 -0.000322714 0 + 0.280229 -0.00124139 0 0.295172 -0.000408764 0 0.0890418 8.89034e-05 0 0.295934 -0.000285846 0 + 0.261773 0.000198063 0 0.239062 -0.00069825 0 0.127038 -0.000119674 0 0.232889 -0.000594686 0 + 0.134191 0.000111708 0 0.239226 -0.000829381 0 0.101953 1.07177e-05 0 0.237858 -0.000566251 0 + 0.122594 0.000116347 0 0.289515 -0.000374868 0 0.292348 -0.000543427 0 0.243829 -0.000792512 0 + 0.202175 0.000291183 0 0.0911291 3.50304e-05 0 0.126103 0.000145828 0 0.292055 -0.000290806 0 + 0.243314 -0.000700343 0 0.220787 -0.00062947 0 0.211434 -0.000331943 0 0.293085 -0.000575593 0 + 0.294834 -0.000338486 0 0.131462 0.000109728 0 0.150474 -0.000286878 0 0.254618 0.000207506 0 + 0.206509 0.000143459 0 0.293322 -0.000302108 0 0.263044 2.90085e-05 0 0.0883783 3.78638e-05 0 + 0.289982 -0.000676357 0 0.295689 -0.000293267 0 0.28181 -0.000720583 0 0.231416 -0.000581067 0 + 0.264245 0.000113252 0 0.235534 -0.000620194 0 0.250852 0.0014298 0 0.201775 0.000330107 0 + 0.284027 -0.000279968 0 0.207011 0.000307612 0 0.167201 -0.000261346 0 0.23627 -0.000165213 0 + 0.296724 -0.000289163 0 0.271451 -2.09609e-05 0 0.295661 -0.000284185 0 0.291384 -0.000126072 0 + 0.191667 0.000292359 0 0.194589 0.000223105 0 0.293636 -0.000152707 0 0.295693 -0.000331413 0 + 0.296042 -0.000358562 0 0.119089 9.37305e-05 0 0.240947 0.000187197 0 0.291156 -9.48212e-05 0 + 0.127731 0.000138183 0 0.017178 -3.35146e-06 0 0.0171897 -3.44635e-06 0 0.291991 -0.000130757 0 + 0.102042 6.67734e-05 0 0.186806 0.000240732 0 0.273845 -1.27809e-05 0 0.206612 0.000348641 0 + 0.293925 -0.00016435 0 0.288788 -0.000398536 0 0.248795 7.43211e-05 0 0.17705 0.00030092 0 + 0.206863 -0.000877066 0 0.295876 -0.000366482 0 0.21515 0.000147273 0 0.166496 -0.000279994 0 + 0.296154 -0.000211005 0 0.205776 0.000114424 0 0.252997 -0.00108505 0 0.29209 -0.000679871 0 + 0.129321 -0.000127851 0 0.29568 -0.000201069 0 0.292711 -0.000370914 0 0.288791 -0.000712528 0 + 0.211302 0.000366809 0 0.272568 -0.000941027 0 0.21837 0.000613151 0 0.243048 -0.000877642 0 + 0.0943757 8.85122e-05 0 0.287407 -0.000714479 0 0.200983 0.000310757 0 0.291856 -0.000531515 0 + 0.290551 -7.31258e-05 0 0.076595 6.93525e-05 0 0.292929 -0.000560081 0 0.285032 8.58038e-05 0 + 0.181626 -0.000223739 0 0.0880514 5.43623e-06 0 0.0916601 -6.10385e-05 0 0.295057 -0.000299825 0 + 0.250246 -0.000777697 0 0.251009 0.000986164 0 0.204138 0.000289837 0 0.110576 0.000117329 0 + 0.287449 1.32675e-06 0 0.293507 -0.000206247 0 0.242801 -0.000739576 0 0.292819 -0.000137718 0 + 0.23066 0.00135071 0 0.205322 0.000270277 0 0.0711823 5.84496e-06 0 0.259705 -0.000701255 0 + 0.188397 -0.000470905 0 0.223808 -0.000547912 0 0.103428 7.03082e-05 0 0.23963 -0.000788819 0 + 0.202472 -0.000407833 0 0.288532 -0.000105049 0 0.248638 -0.000713396 0 0.293896 -0.000168822 0 + 0.295998 -0.000346424 0 0.194159 0.000257282 0 0.216978 0.000140606 0 0.224954 0.000499792 0 + 0.149949 -0.000195086 0 0.017403 3.15602e-06 0 0.215845 0.000384503 0 0.28458 -0.00140313 0 + 0.296435 -0.000315197 0 0.295371 -0.000287429 0 0.295407 -0.00029421 0 0.295116 -0.000310659 0 + 0.293763 -0.000226235 0 0.29193 -0.000107048 0 0.17857 0.000177937 0 0.271561 -0.000613409 0 + 0.20423 -0.000420726 0 0.251423 0.000328807 0 0.291847 -0.000156129 0 0.0868281 4.71849e-05 0 + 0.289786 -0.00088489 0 0.294242 -0.000291362 0 0.263025 0.000704184 0 0.290798 -0.000546232 0 + 0.291602 -0.000151068 0 0.11922 -0.000111145 0 0.235086 -0.000656549 0 0.180819 0.000177468 0 + 0.295826 -0.000282474 0 0.228195 -0.000587931 0 0.100418 6.44325e-05 0 0.192807 -0.000564599 0 + 0.18715 -0.000356984 0 0.219753 -0.00036225 0 0.0932801 0.000100951 0 0.20585 0.000328579 0 + 0.060302 -8.88888e-05 0 0.291056 -0.000387223 0 0.124226 -0.000192526 0 0.231067 0.000329857 0 + 0.198686 -0.000587374 0 0.272463 -0.000620392 0 0.1462 0.000181013 0 0.283024 -0.0015451 0 + 0.100271 0.000105613 0 0.174075 0.000250137 0 0.294118 -0.000179198 0 0.157899 0.000182601 0 + 0.249914 0.000137321 0 0.274156 -0.000827225 0 0.221956 0.000606394 0 0.263682 0.000277996 0 + 0.288075 -1.29866e-05 0 0.132659 -0.000282863 0 0.184224 0.000272674 0 0.128962 -0.000212042 0 + 0.15498 0.000203457 0 0.163779 -0.00034621 0 0.296889 -0.000231336 0 0.104346 -8.07247e-05 0 + 0.116395 0.000122694 0 0.152239 -0.000436471 0 0.236517 -0.000671509 0 0.294121 -0.000264255 0 + 0.122068 0.000190062 0 0.234626 -0.000693641 0 0.292438 -0.000132267 0 0.241439 0.000208433 0 + 0.29105 -8.42404e-05 0 0.165964 0.000228376 0 0.295161 -0.000346287 0 0.295425 -0.000338305 0 + 0.210186 0.000390274 0 0.247111 -0.000880839 0 0.178746 0.000253532 0 0.167853 0.000529987 0 + 0.291479 -0.000285676 0 0.29584 -0.000267631 0 0.287488 -0.000748222 0 0.290693 -8.52731e-05 0 + 0.141291 0.000228299 0 0.196703 -0.000395422 0 0.197195 0.000274534 0 0.295508 -0.000195195 0 + 0.138774 -0.000243314 0 0.269253 9.41781e-05 0 0.20919 -0.000356371 0 0.178431 0.000472251 0 + 0.0837468 7.01476e-05 0 0.228668 -0.000555819 0 0.284389 -0.000778603 0 0.138826 -0.000337185 0 + 0.2895 -0.000677588 0 0.227728 -0.000622398 0 0.260932 0.000281141 0 0.286273 -0.000897384 0 + 0.21877 -0.000538279 0 0.293513 -0.000164449 0 0.194748 0.000311525 0 0.28669 2.29613e-05 0 + 0.265213 -0.000673943 0 0.287351 -0.00102534 0 0.0421782 -2.35987e-05 0 0.178877 -0.000591133 0 + 0.176408 -0.00040929 0 0.214758 0.00040945 0 0.168145 0.000162669 0 0.277868 -0.000817299 0 + 0.268656 -0.000625961 0 0.292353 -0.000120477 0 0.257233 0.000311328 0 0.0584426 3.26163e-05 0 + 0.246505 -0.000780566 0 0.169846 -0.000384727 0 0.294249 -0.000276646 0 0.281554 -0.000973172 0 + 0.256741 0.000170901 0 0.210854 -0.000571078 0 0.291082 -0.000138163 0 0.245051 0.000945105 0 + 0.242493 -0.000777086 0 0.227148 -0.000542436 0 0.242682 -0.000921933 0 0.181548 -0.000321102 0 + 0.236064 -0.000708879 0 0.0937129 0.000132989 0 0.270245 8.33805e-05 0 0.291537 -0.000116795 0 + 0.231543 -0.000700003 0 0.106255 0.000146765 0 0.195971 0.000292766 0 0.290837 -0.000302098 0 + 0.29372 -0.000263015 0 0.28826 -0.000712635 0 0.293742 -0.00017679 0 0.261907 4.15577e-05 0 + 0.295252 -0.000400538 0 0.275391 -0.00102457 0 0.200293 -0.000324264 0 0.086192 -6.27083e-05 0 + 0.212547 -0.00058589 0 0.264721 0.00026538 0 0.196259 -0.000506356 0 0.289441 -0.000638942 0 + 0.262704 -8.6075e-06 0 0.0658104 -5.44428e-05 0 0.069667 4.64166e-05 0 0.293936 -0.000240087 0 + 0.198006 0.000292257 0 0.195584 0.000330681 0 0.129744 0.000177776 0 0.199793 0.000330866 0 + 0.288552 -3.26017e-05 0 0.294861 -0.000349521 0 0.296093 -0.000338259 0 0.114869 -9.56122e-05 0 + 0.292424 -0.000119061 0 0.158171 -0.000509278 0 0.193215 -0.000370702 0 0.287566 -0.000130115 0 + 0.226669 -0.000573933 0 0.296688 -0.000224207 0 0.128465 0.000165172 0 0.204691 0.000349996 0 + 0.216208 -0.000374243 0 0.292905 -0.000461577 0 0.282008 -0.000110696 0 0.288882 -5.8555e-05 0 + 0.246477 0.000128098 0 0.254985 6.51822e-05 0 0.0999648 -3.62512e-05 0 0.295947 -0.000294277 0 + 0.293119 -0.000161835 0 0.292816 -0.000298818 0 0.152664 -0.000300122 0 0.201643 0.000127261 0 + 0.0581465 -4.52162e-05 0 0.238238 -0.000772566 0 0.196794 0.000311297 0 0.255425 -0.000658028 0 + 0.293292 -0.000191903 0 0.240184 5.25345e-05 0 0.293801 -0.000288782 0 0.289509 -0.000707827 0 + 0.286908 -0.000747238 0 0.26921 2.72188e-06 0 0.222817 0.000422242 0 0.295084 -0.000192809 0 + 0.151467 -0.000308143 0 0.284551 -0.00081695 0 0.140714 0.000283266 0 0.209443 0.000368824 0 + 0.227266 -0.000656937 0 0.131919 -0.000294149 0 0.214049 0.000387231 0 0.238634 -0.000735191 0 + 0.222236 -0.00053425 0 0.106976 -2.2643e-05 0 0.259715 0.000465115 0 0.253657 0.000360532 0 + 0.2555 0.000180427 0 0.256242 5.30347e-05 0 0.169899 -0.000689859 0 0.27676 -4.8026e-05 0 + 0.257817 -0.000556663 0 0.147695 0.000254372 0 0.291874 -0.000111252 0 0.0597692 -5.32115e-05 0 + 0.209073 0.000414369 0 0.233808 -0.000765338 0 0.293372 -0.000173601 0 0.286998 -3.34377e-05 0 + 0.0646476 -7.82747e-05 0 0.185247 -0.000344791 0 0.282713 -0.000120159 0 0.258142 0.000909763 0 + 0.293977 -0.00030382 0 0.295782 -0.000258381 0 0.213675 0.000435277 0 0.16586 -0.000359209 0 + 0.115119 0.000147712 0 0.261422 0.000110314 0 0.193331 0.000240352 0 0.0746708 7.77019e-05 0 + 0.240023 -0.000750428 0 0.162474 -0.00025805 0 0.292493 -0.000634039 0 0.292959 -0.000174904 0 + 0.178398 -0.000422209 0 0.258405 0.000300559 0 0.110147 0.000178413 0 0.0658315 -5.64304e-05 0 + 0.294078 -0.000317291 0 0.28396 -8.38744e-05 0 0.286291 3.00558e-05 0 0.245792 -0.00086456 0 + 0.222381 -0.000644465 0 0.119748 -2.7998e-05 0 0.164324 0.000173827 0 0.285001 -7.2283e-05 0 + 0.112731 -9.00588e-05 0 0.202138 4.59598e-05 0 0.214565 -0.000360157 0 0.199424 0.000371651 0 + 0.204224 -0.000314952 0 0.189558 0.000292073 0 0.227248 4.65829e-05 0 0.239958 0.000215497 0 + 0.135229 -0.000168203 0 0.0821068 6.68529e-05 0 0.283435 -0.0010257 0 0.293088 -0.000200483 0 + 0.25292 -0.000673345 0 0.171856 0.000368063 0 0.294008 -0.000510867 0 0.221353 -0.000376436 0 + 0.258959 -0.0025196 0 0.290199 -7.52886e-05 0 0.231979 -0.00066564 0 0.294722 -0.000300865 0 + 0.124945 0.00013351 0 0.115926 0.000134959 0 0.218824 0.000825805 0 0.0895898 -4.08792e-05 0 + 0.288176 -0.000694912 0 0.242316 -0.000970365 0 0.193242 -0.000269239 0 0.240763 0.000599581 0 + 0.293209 -0.000168242 0 0.202889 8.78603e-05 0 0.246703 -0.000928146 0 0.290585 -0.000129591 0 + 0.217377 0.000652632 0 0.203669 -0.000446654 0 0.212905 3.49945e-05 0 0.294507 -0.000384203 0 + 0.282529 -0.000933275 0 0.230049 -0.00068499 0 0.293534 -0.000239198 0 0.105892 0.000112847 0 + 0.292861 -0.000187592 0 0.29091 -0.000782981 0 0.130127 0.000232448 0 0.293863 -0.000276549 0 + 0.293217 -0.000142486 0 0.135317 0.000268523 0 0.291513 -0.000104492 0 0.292699 -0.000159533 0 + 0.151032 -0.000471989 0 0.13166 0.000151432 0 0.0672339 4.61e-05 0 0.2933 -0.000261536 0 + 0.186395 0.000273458 0 0.282575 -0.000801205 0 0.295165 -0.000278421 0 0.122605 -4.16812e-05 0 + 0.125805 0.000230411 0 0.210532 0.000131508 0 0.134383 0.000155173 0 0.198421 0.000256273 0 + 0.282178 -0.000845418 0 0.0968984 -2.56052e-05 0 0.138538 -0.000266778 0 0.0858498 -0.000110811 0 + 0.287396 2.65348e-06 0 0.294794 -0.000312841 0 0.208318 0.000391948 0 0.258587 -0.000690092 0 + 0.237758 -0.0010164 0 0.128451 -0.000142176 0 0.291388 -9.57129e-05 0 0.293348 -0.000223592 0 + 0.216394 0.000694373 0 0.0925371 8.51157e-05 0 0.294153 -0.000390028 0 0.219837 -0.000865503 0 + 0.237824 -0.000812745 0 0.275946 0.000231025 0 0.293773 -0.000397444 0 0.263048 -0.000693893 0 + 0.195071 -0.000283404 0 0.0343225 1.98762e-05 0 0.275155 0.000379519 0 0.16807 0.000723637 0 + 0.203536 0.00037165 0 0.267144 -0.000929269 0 0.259247 0.00034055 0 0.293562 -0.0003015 0 + 0.29495 -0.000423229 0 0.288779 -3.17132e-05 0 0.254107 0.000108193 0 0.144284 0.000213191 0 + 0.192311 0.000349409 0 0.182571 0.000323628 0 0.135133 0.000186688 0 0.294367 -0.000185953 0 + 0.294919 -0.000417857 0 0.26026 0.000120872 0 0.149518 0.000220889 0 0.0335903 1.65355e-05 0 + 0.212953 0.000411895 0 0.212419 0.00012455 0 0.119265 0.000125311 0 0.24172 -0.000860665 0 + 0.131191 -0.000307587 0 0.191363 -0.000358315 0 0.15572 0.00024288 0 0.249414 0.000192552 0 + 0.0784032 6.81754e-05 0 0.183609 0.00022398 0 0.198254 0.000393099 0 0.282719 -0.00119658 0 + 0.289086 -3.65747e-05 0 0.200435 0.000255084 0 0.143686 -0.000433433 0 0.245712 0.00163688 0 + 0.237419 -0.00106627 0 0.254499 0.000134608 0 0.246354 -0.000977617 0 0.295341 -0.000375061 0 + 0.286264 -0.00123056 0 0.188955 0.000240666 0 0.207966 0.000439742 0 0.164192 0.000269362 0 + 0.15553 -0.000241513 0 0.278133 -0.00109571 0 0.0769786 -9.45637e-05 0 0.271767 -0.00112332 0 + 0.290562 -9.46961e-05 0 0.296153 -0.000320235 0 0.261519 0.000506966 0 0.122269 -0.000216725 0 + 0.288774 -0.000811773 0 0.293684 -0.000318773 0 0.139796 0.000238539 0 0.202384 0.000393768 0 + 0.132025 0.000197765 0 0.169048 0.000275785 0 0.290604 -0.000669785 0 0.245038 -0.000556872 0 + 0.280367 -0.000876016 0 0.120655 -0.000128608 0 0.294628 -0.000456108 0 0.225729 -0.000641548 0 + 0.285305 -0.00074464 0 0.283871 -0.000813899 0 0.194973 -0.000467956 0 0.186076 0.000512712 0 + 0.270606 0.000468578 0 0.221405 0.000507101 0 0.286895 1.93873e-05 0 0.291058 -0.000100101 0 + 0.17478 0.000298383 0 0.293109 -0.000234573 0 0.265525 0.0005379 0 0.287528 3.03133e-06 0 + 0.209403 -0.000820441 0 0.128012 -0.000257491 0 0.0547112 -4.8835e-05 0 0.226396 -0.000723625 0 + 0.229198 -0.000755141 0 0.200882 -0.000286121 0 0.280661 -0.000798253 0 0.264691 0.00150977 0 + 0.26603 -0.000917646 0 0.207198 0.000415795 0 0.0742429 -8.75413e-05 0 0.0639743 4.74513e-05 0 + 0.190814 0.000274757 0 0.293828 -0.000460256 0 0.117473 -0.000133029 0 0.124887 0.000196419 0 + 0.271544 -0.000930997 0 0.285513 5.31962e-05 0 0.293486 -0.000154719 0 0.292839 -0.000259364 0 + 0.230498 -0.000650547 0 0.275054 0.000247307 0 0.187053 0.000327298 0 0.232982 5.63049e-05 0 + 0.116159 -0.000170369 0 0.283688 -0.000775135 0 0.142898 0.000145911 0 0.258979 0.000650098 0 + 0.233405 -0.00080361 0 0.290039 -0.000118201 0 0.0797707 7.62432e-05 0 0.293124 -0.000306384 0 + 0.291826 -0.000646837 0 0.293452 -0.000276004 0 0.292908 -0.000221403 0 0.294996 -0.0004085 0 + 0.211862 0.000437575 0 0.262188 0.000770204 0 0.264687 0.000328382 0 0.292216 -0.000632059 0 + 0.283514 -0.00142188 0 0.244002 0.00042554 0 0.202052 0.000441483 0 0.0933076 -0.000133801 0 + 0.108598 -0.000112246 0 0.189196 -0.000532243 0 0.258869 -0.00228273 0 0.262763 -0.000608717 0 + 0.294865 -0.000186857 0 0.132971 -0.000159594 0 0.11368 -0.000161465 0 0.0868599 7.67636e-05 0 + 0.25374 -0.000600889 0 0.278446 -0.0009047 0 0.288935 -3.74023e-05 0 0.103423 0.000100893 0 + 0.217787 -0.000600872 0 0.29235 -0.000616357 0 0.259378 -0.00061607 0 0.266487 0.000287283 0 + 0.205465 0.000370684 0 0.135488 -0.000412757 0 0.0768127 9.74951e-05 0 0.1632 -0.000239213 0 + 0.0086174 -1.06359e-06 0 0.284485 -0.000115821 0 0.245384 -0.000911014 0 0.149322 -0.000297494 0 + 0.194377 0.000350056 0 0.285956 -0.000746868 0 0.294534 -0.000354903 0 0.181397 0.000223687 0 + 0.204323 0.000393117 0 0.211589 -0.000644322 0 0.0172386 3.50623e-06 0 0.175847 0.00020671 0 + 0.281152 -0.000881778 0 0.294491 -0.000342748 0 0.136808 0.000261128 0 0.0657556 -5.43397e-05 0 + 0.245992 -0.0010334 0 0.235345 0.000671249 0 0.056435 -6.15929e-05 0 0.138638 0.000223001 0 + 0.26066 0.000548446 0 0.0632407 6.38326e-05 0 0.290783 -0.000121243 0 0.287961 -1.01921e-05 0 + 0.159193 -0.000339168 0 0.100405 9.80098e-05 0 0.163909 -0.000408609 0 0.234855 -0.00082109 0 + 0.254936 0.000520831 0 0.206864 0.000466876 0 0.0625532 4.66655e-05 0 0.214068 -0.000498222 0 + 0.183541 -0.00023785 0 0.184923 0.000208452 0 0.154155 -0.000215714 0 0.286627 -0.00069092 0 + 0.263799 0.000366039 0 0.241332 -0.000905081 0 0.256071 -0.0010007 0 0.230703 -0.000772114 0 + 0.161127 -0.000228341 0 0.209738 -0.000317624 0 0.210933 0.000701019 0 0.180981 0.000254816 0 + 0.0764349 -0.000157915 0 0.28172 -0.000765074 0 0.201237 0.00041694 0 0.286605 -0.000140063 0 + 0.184723 -0.000443687 0 0.22319 -0.000862634 0 0.127253 -0.000268587 0 0.29549 -0.000393348 0 + 0.295675 -0.000390767 0 0.202039 -0.000525163 0 0.212398 -0.000484706 0 0.292362 -0.000257867 0 + 0.287506 -0.0009053 0 0.293366 -0.000403354 0 0.185514 0.00025684 0 0.293255 -0.000321466 0 + 0.292529 -0.000163165 0 0.208068 -0.000762118 0 0.182723 0.000208376 0 0.129609 0.000281438 0 + 0.119597 0.000163625 0 0.263858 0.000644541 0 0.294507 -0.000395912 0 0.197421 0.000371597 0 + 0.142473 -0.000468958 0 0.292668 -0.000227264 0 0.291018 -0.000666927 0 0.177208 0.00019269 0 + 0.286921 1.81757e-05 0 0.290551 -7.71569e-05 0 0.290202 -8.03477e-05 0 0.103706 0.000127801 0 + 0.170358 -0.000663099 0 0.0711149 -0.000115236 0 0.291962 -0.000178284 0 0.237421 -0.000853285 0 + 0.291297 -0.000135904 0 0.157084 -0.000327003 0 0.286017 -0.000131862 0 0.109801 0.000196274 0 + 0.0857364 8.29641e-05 0 0.256349 0.00034191 0 0.29334 -0.000569236 0 0.0971527 -8.02204e-05 0 + 0.158198 0.000246729 0 0.278987 0.000292632 0 0.289467 -0.000103828 0 0.0580249 -4.18895e-05 0 + 0.289516 -0.000662672 0 0.24587 0.000363483 0 0.153937 0.000191068 0 0.109646 0.000136272 0 + 0.125286 -0.000144469 0 0.241962 -0.00102632 0 0.29185 -0.000687954 0 0.251877 0.000426579 0 + 0.270329 -0.00101298 0 0.114579 -0.00024862 0 0.221418 0.000871253 0 0.292253 -0.000149698 0 + 0.293012 -0.000272537 0 0.083942 -1.9935e-05 0 0.194416 -0.000492089 0 0.263822 -0.000619505 0 + 0.292441 -0.000208638 0 0.249069 -0.000955865 0 0.126471 0.000187986 0 0.241298 -0.00113005 0 + 0.292929 -0.000407597 0 0.192912 0.000274767 0 0.290171 -6.23437e-05 0 0.200883 9.59125e-05 0 + 0.129345 0.000134276 0 0.109584 -0.000191753 0 0.0625896 -6.16304e-05 0 0.200925 0.000468075 0 + 0.146884 0.000578519 0 0.128373 -0.000357989 0 0.111088 0.000105145 0 0.203185 0.000416476 0 + 0.0603791 -9.13532e-05 0 0.287916 -0.00100543 0 0.112855 -0.000196213 0 0.284332 -0.00013511 0 + 0.238828 -0.000872238 0 0.289863 -8.37008e-05 0 0.218787 0.00117199 0 0.290917 -0.000667851 0 + 0.206082 0.000441056 0 0.292659 -0.000305735 0 0.0963677 0.000105905 0 0.281598 -5.13898e-05 0 + 0.285711 -0.000897483 0 0.206961 -0.000472538 0 0.190783 0.000412872 0 0.290573 -8.97513e-05 0 + 0.176277 0.000419546 0 0.12411 -0.000262338 0 0.294172 -0.000402709 0 0.255726 -0.00105562 0 + 0.0928143 0.000111629 0 0.293201 -0.000580736 0 0.0580114 -4.157e-05 0 0.274479 -0.0010132 0 + 0.205767 0.000495574 0 0.289804 -6.17394e-05 0 0.291588 -0.000631525 0 0.113185 0.000130559 0 + 0.245047 -0.000957177 0 0.0339814 2.54016e-05 0 0.116983 0.000228437 0 0.136134 -0.000395268 0 + 0.171108 0.000204714 0 0.240963 -0.000953733 0 0.123011 0.000156922 0 0.147712 0.000173598 0 + 0.139031 7.42162e-05 0 0.210457 0.000522782 0 0.172492 0.000191028 0 0.274829 -0.000918405 0 + 0.293807 -0.000411332 0 0.290262 -0.00011457 0 0.289519 -7.13798e-05 0 0.217911 0.000877917 0 + 0.089329 -0.000152543 0 0.204542 -0.0012599 0 0.196242 0.000392769 0 0.294124 -0.000346043 0 + 0.0871383 8.75642e-05 0 0.29038 -0.000693548 0 0.287776 -1.22705e-05 0 0.283289 -7.26557e-05 0 + 0.109226 0.000153393 0 0.120285 0.000152437 0 0.125656 -0.000245861 0 0.257399 -0.000596525 0 + 0.292649 -0.000195787 0 0.284933 -0.000142602 0 0.292806 -0.00032261 0 0.11425 -0.000189051 0 + 0.0579779 -4.04908e-05 0 0.292548 -0.00027465 0 0.173148 0.000349459 0 0.241627 -0.00107494 0 + 0.29219 -0.00019526 0 0.278107 0.000393283 0 0.170156 0.000189994 0 0.294491 -0.000459443 0 + 0.289492 -0.000139382 0 0.252528 -0.00058945 0 0.287358 6.58656e-06 0 0.245006 -0.00119457 0 + 0.0847065 -0.000113009 0 0.292181 -0.000229164 0 0.154794 -0.000257686 0 0.117714 -0.000217737 0 + 0.237065 -0.000897905 0 0.145109 0.00024905 0 0.291857 -0.000252522 0 0.163173 0.000253671 0 + 0.292408 -0.000180223 0 0.0793217 -0.000100672 0 0.209398 0.00055517 0 0.214993 0.000549548 0 + 0.153955 0.000281319 0 0.0798754 -0.000118586 0 0.270317 -0.00123036 0 0.291954 -0.000211118 0 + 0.174605 -0.000465995 0 0.290374 -0.000809284 0 0.285885 5.92603e-05 0 0.254243 -0.00161837 0 + 0.229015 0.000518943 0 0.213044 -0.000556962 0 0.115081 0.00016472 0 0.200095 0.000441804 0 + 0.22477 -0.000883821 0 0.120127 -0.00022895 0 0.178034 0.000121191 0 0.244368 -0.00105977 0 + 0.124236 0.000109558 0 0.294181 -0.000360119 0 0.248791 -0.00100416 0 0.204972 0.000468041 0 + 0.195068 0.000415497 0 0.0910772 -0.0002528 0 0.165192 0.000113033 0 0.289682 -6.30846e-05 0 + 0.164996 0.000317665 0 0.0655961 -5.246e-05 0 0.278875 -4.2357e-05 0 0.254156 -0.000563678 0 + 0.290899 -0.000112803 0 0.183325 0.000383391 0 0.286515 -0.00117419 0 0.28631 3.98122e-05 0 + 0.119826 -0.00014021 0 0.243868 7.06435e-05 0 0.0714831 -9.54026e-05 0 0.238475 -0.000917809 0 + 0.262131 0.000437191 0 0.227671 0.000625765 0 0.193528 0.000330452 0 0.0820474 8.55036e-05 0 + 0.0958924 -0.000143356 0 0.244684 -0.00101107 0 0.250309 -0.00097439 0 0.291061 -0.00011079 0 + 0.287512 5.61275e-06 0 0.292165 -0.000303268 0 0.112294 -0.000180536 0 0.293725 -0.000350964 0 + 0.251809 0.000222983 0 0.161456 0.000198552 0 0.202961 -0.000702833 0 0.0564427 3.6109e-05 0 + 0.124884 -0.000255986 0 0.279661 -5.43584e-05 0 0.257525 0.000407398 0 0.289487 -0.000863025 0 + 0.259468 0.000441463 0 0.177812 0.000355754 0 0.229903 -0.000852819 0 0.2406 -0.00100532 0 + 0.290183 -0.000102327 0 0.287495 -0.000930011 0 0.216144 0.000989185 0 0.274846 -0.00123316 0 + 0.10874 -0.000196946 0 0.111205 -0.000207746 0 0.193899 0.000439726 0 0.150522 -0.000339092 0 + 0.0604081 4.02851e-05 0 0.292327 -0.000321306 0 0.288945 -5.77087e-05 0 0.223323 -0.000579509 0 + 0.116728 0.000158881 0 0.293799 -0.0003639 0 0.255798 0.000479701 0 0.236338 -0.00099733 0 + 0.128588 0.000238766 0 0.183007 -0.000507709 0 0.29168 -0.000223305 0 0.28533 8.33473e-05 0 + 0.293416 -0.000418319 0 0.182935 0.000289156 0 0.289559 -5.82759e-05 0 0.0674248 5.36102e-05 0 + 0.280059 -0.000117276 0 0.144948 -0.000401561 0 0.0840172 -0.000117551 0 0.191098 0.000368735 0 + 0.275668 -0.000920623 0 0.193174 0.000369771 0 0.198605 0.000351109 0 0.251211 0.00182193 0 + 0.261054 0.00108007 0 0.234222 -0.000728225 0 0.291788 -0.000141717 0 0.120929 -0.000221964 0 + 0.12736 0.00022584 0 0.145458 -0.000958433 0 0.108652 8.58963e-05 0 0.185806 0.000344912 0 + 0.198959 0.000468134 0 0.292058 -0.000270769 0 0.279984 0.000375071 0 0.247296 0.00104003 0 + 0.213962 0.000584388 0 0.236693 -0.000944484 0 0.0623496 -7.31679e-05 0 0.0968216 0.000136244 0 + 0.263176 0.000424468 0 0.0172453 6.36333e-06 0 0.119329 -0.000238161 0 0.261569 -0.00115303 0 + 0.11691 -0.000227476 0 0.190424 0.00031048 0 0.286728 2.59425e-05 0 0.156439 0.000193987 0 + 0.280803 -0.000126281 0 0.291439 -0.000203224 0 0.255422 0.000301527 0 0.217017 0.000932299 0 + 0.107071 -0.000214617 0 0.203867 0.000496486 0 0.248935 0.00129962 0 0.107663 0.000251175 0 + 0.145513 0.000148225 0 0.218274 -0.000569373 0 0.293299 -0.000354073 0 0.294077 -0.000437269 0 + 0.257537 0.00033077 0 0.260379 0.000328236 0 0.245302 5.85872e-05 0 0.29164 -0.00029926 0 + 0.221262 -0.000597752 0 0.194776 0.000466205 0 0.175423 0.000236476 0 0.250031 -0.00102574 0 + 0.236267 0.000626059 0 0.238105 -0.00096781 0 0.27712 -0.00108758 0 0.197089 0.000415958 0 + 0.28893 -0.000128 0 0.265453 0.000300835 0 0.257296 0.000766439 0 0.246806 0.000334465 0 + 0.258138 0.000706338 0 0.215114 -0.000804743 0 0.185486 0.000385484 0 0.173124 0.000234828 0 + 0.289705 -0.0001 0 0.0716162 5.51545e-05 0 0.213428 -0.000784263 0 0.290669 -0.0007913 0 + 0.133251 0.000146844 0 0.244698 -0.0012573 0 0.283164 0.000159722 0 0.195929 0.000440451 0 + 0.275488 -0.0014878 0 0.285624 -8.34357e-05 0 0.250496 0.000231285 0 0.292996 -0.000423898 0 + 0.155064 -0.000644406 0 0.140174 0.000388126 0 0.251005 -0.00123556 0 0.275446 -0.00188817 0 + 0.208622 0.000524625 0 0.254197 0.000311391 0 0.0699779 -7.9253e-05 0 0.213222 0.00055242 0 + 0.127692 -0.000371412 0 0.26639 -0.00291949 0 0.290056 -7.94498e-05 0 0.258667 0.000394031 0 + 0.217831 -0.00114953 0 0.252299 0.000545752 0 0.291851 -0.000354257 0 0.287028 -0.000931687 0 + 0.200598 0.000350766 0 0.196639 0.000109959 0 0.235995 -0.00104417 0 0.0954545 -0.000148204 0 + 0.0544134 5.53872e-05 0 0.250338 -0.000567738 0 0.289159 -4.32715e-05 0 0.29203 -0.000603272 0 + 0.126494 -0.00027597 0 0.0686757 5.39694e-05 0 0.189183 0.000328499 0 0.208347 0.000589238 0 + 0.289135 -0.000868142 0 0.0908704 0.000180838 0 0.282012 -0.00119034 0 0.18487 0.000109264 0 + 0.29339 -0.000369268 0 0.110415 -0.000186413 0 0.2935 -0.000508204 0 0.183843 0.000307012 0 + 0.0801915 9.70256e-05 0 0.237626 0.000516111 0 0.204751 -0.00072283 0 0.113083 0.000186317 0 + 0.0350937 3.19771e-05 0 0.151777 0.000165021 0 0.277967 -0.000125358 0 0.290214 -0.000554772 0 + 0.108359 0.000207436 0 0.102064 -0.00016259 0 0.282124 -0.00113553 0 0.291961 -0.000472661 0 + 0.104555 0.000155269 0 0.229519 -0.000898494 0 0.114701 0.000186449 0 0.19869 0.000524911 0 + 0.130109 -0.000388073 0 0.235667 -0.00074349 0 0.28366 -0.00113723 0 0.240261 -0.0010535 0 + 0.0848282 5.25659e-05 0 0.123669 0.000182459 0 0.29115 -0.000215559 0 0.286695 1.51095e-05 0 + 0.080149 0.000103769 0 0.188687 0.00041143 0 0.256952 0.000465037 0 0.274746 -2.52728e-05 0 + 0.284673 0.00010905 0 0.224843 -0.000706905 0 0.13047 0.0002067 0 0.288356 -3.91564e-05 0 + 0.244413 -0.00132291 0 0.291991 -0.000374696 0 0.290368 -0.00075676 0 0.292451 -0.000468212 0 + 0.104567 -0.000170946 0 0.276116 -0.000885463 0 0.182658 0.000113761 0 0.115664 0.000215258 0 + 0.289644 -0.000829741 0 0.272705 -0.00151691 0 0.133204 0.00021246 0 0.291709 -0.000184169 0 + 0.0659501 6.98477e-05 0 0.0910282 0.000120734 0 0.0696115 -0.000182337 0 0.248151 0.000325443 0 + 0.112039 -0.000203752 0 0.293188 -0.000558025 0 0.125124 0.00031267 0 0.210826 0.000992516 0 + 0.275253 -0.000852666 0 0.246349 -0.000569208 0 0.290896 -0.000194187 0 0.292848 -0.000355656 0 + 0.161571 -0.000691531 0 0.158741 -0.000489084 0 0.177157 0.000689723 0 0.199149 0.000182424 0 + 0.231121 -0.000734755 0 0.292698 -0.000630111 0 0.212941 0.000621157 0 0.207555 0.000556737 0 + 0.194561 0.000115928 0 0.188651 -0.00122486 0 0.291817 -0.000319498 0 0.260897 -0.000589523 0 + 0.207633 -0.000542347 0 0.231893 -0.000983036 0 0.288216 -0.000104442 0 0.140442 -0.000368972 0 + 0.131389 -0.000181512 0 0.291439 -0.000166899 0 0.256442 0.00136892 0 0.102953 0.000152237 0 + 0.102207 8.84458e-05 0 0.234085 -0.000908472 0 0.285783 5.78962e-05 0 0.141349 0.000156141 0 + 0.291079 -0.000290904 0 0.27049 0.000295593 0 0.291537 -0.000265381 0 0.162459 0.000212036 0 + 0.171839 -0.000582293 0 0.106132 -0.000221021 0 0.181039 -0.000491691 0 0.294657 -0.000428153 0 + 0.122644 0.000272013 0 0.188304 0.000309779 0 0.181835 0.000452516 0 0.117937 8.27911e-05 0 + 0.122599 -0.000287935 0 0.257776 0.000523228 0 0.117967 0.000170714 0 0.156546 -0.000575571 0 + 0.248539 -0.00125951 0 0.115448 0.00023644 0 0.289972 -0.000647768 0 0.191581 0.000491276 0 + 0.287122 2.03867e-05 0 0.289895 -9.02052e-05 0 0.231221 0.0019153 0 0.239929 -0.00110728 0 + 0.240148 -0.0013779 0 0.217443 -0.000928136 0 0.291297 -0.00035145 0 0.134109 0.000253912 0 + 0.291321 -0.000246005 0 0.292075 -0.000157415 0 0.181649 0.000305378 0 0.13618 0.000354534 0 + 0.132481 -0.000486075 0 0.148591 0.00030334 0 0.292955 -0.000372231 0 0.132827 -0.000334735 0 + 0.206632 -0.000596538 0 0.197587 0.000555253 0 0.290628 -0.000642114 0 0.115695 0.000100272 0 + 0.248229 -0.00132649 0 0.229624 -0.000718355 0 0.169723 0.00021844 0 0.290866 -0.000476086 0 + 0.293148 -0.000520222 0 0.205895 -0.000527504 0 0.224399 -0.000927 0 0.143344 0.000290766 0 + 0.288514 -6.52902e-05 0 0.154858 0.000334445 0 0.264849 0.000350484 0 0.163386 0.000372643 0 + 0.288455 -0.00100068 0 0.212185 0.000587044 0 0.280659 -0.00117642 0 0.109298 0.000237706 0 + 0.125924 -0.000175375 0 0.251668 -0.00111726 0 0.286806 -0.000713163 0 0.291187 -0.000178477 0 + 0.282082 -0.00134585 0 0.0989036 -0.000184695 0 0.276981 -0.00119882 0 0.174017 0.000415376 0 + 0.268392 0.000747059 0 0.201676 -0.000808674 0 0.291416 -0.000470432 0 0.289513 -0.000898023 0 + 0.263569 0.000831124 0 0.234812 0.000635333 0 0.229153 -0.000944136 0 0.0680393 6.80728e-05 0 + 0.266401 -0.0013066 0 0.175747 0.000123993 0 0.153754 0.000131978 0 0.156882 0.000168802 0 + 0.29355 -0.000495779 0 0.243692 -0.00117147 0 0.230582 0.00051252 0 0.273036 0.00061494 0 + 0.129526 0.000312999 0 0.16824 0.000382715 0 0.126571 0.000130975 0 0.256459 0.000831644 0 + 0.269772 -0.000912977 0 0.0970383 -0.000143631 0 0.23337 -0.00100463 0 0.144481 0.000621806 0 + 0.253312 0.00034124 0 0.284431 -0.00109272 0 0.290987 -0.000258164 0 0.15689 0.000468506 0 + 0.184231 -0.000679241 0 0.0918098 -9.35928e-05 0 0.285358 8.20264e-05 0 0.285332 7.27488e-05 0 + 0.207308 0.000625154 0 0.167361 0.000216556 0 0.269473 0.000313349 0 0.200545 -0.000928433 0 + 0.248078 -0.00106959 0 0.211931 0.000659938 0 0.279652 -0.00123275 0 0.290909 -0.000158016 0 + 0.166344 0.000302199 0 0.172152 0.000328639 0 0.150642 8.49135e-05 0 0.291458 -0.000373495 0 + 0.165107 -0.000546358 0 0.0883998 -0.000118948 0 0.226272 -0.00112079 0 0.292857 -0.000572861 0 + 0.290484 -0.000284034 0 0.147217 -0.000417907 0 0.292122 -0.000644872 0 0.231547 -0.00103158 0 + 0.230954 -0.000614381 0 0.287534 -8.59686e-05 0 0.200904 -0.000887758 0 0.268133 -0.00576408 0 + 0.180634 0.00047623 0 0.226197 -0.000607092 0 0.106836 0.000187657 0 0.186298 0.000458788 0 + 0.290757 -0.000235648 0 0.292545 -0.0004287 0 0.27625 -0.00119051 0 0.227997 -0.000877521 0 + 0.11388 7.13511e-05 0 0.225981 -0.001175 0 0.232622 -0.00088891 0 0.109568 -0.000224863 0 + 0.207248 -0.000836767 0 0.272554 0.000424516 0 0.222847 -0.000612932 0 0.291275 -0.000313552 0 + 0.169287 0.000405956 0 0.135961 0.000150522 0 0.216149 -0.000585709 0 0.0855567 -0.000139465 0 + 0.284165 0.000126837 0 0.291368 -0.000736171 0 0.102034 0.00013214 0 0.289317 -7.63164e-05 0 + 0.283181 -0.00113343 0 0.20277 0.000526225 0 0.281483 -0.00118379 0 0.0852946 9.56601e-05 0 + 0.204678 0.000525649 0 0.236908 7.57989e-05 0 0.0877939 -0.00012558 0 0.17973 0.000859113 0 + 0.245672 -0.00107888 0 0.287194 2.58956e-07 0 0.206499 0.000590505 0 0.162071 0.000389638 0 + 0.117758 -0.000259115 0 0.25624 -0.000585192 0 0.165303 0.000187494 0 0.0989958 0.000125826 0 + 0.0997652 0.000163289 0 0.118093 0.000118916 0 0.260881 -0.00340605 0 0.114105 0.000224209 0 + 0.257319 0.00098625 0 0.118539 -0.000211149 0 0.196709 0.000524156 0 0.259275 -0.00165449 0 + 0.288612 -0.00010166 0 0.162274 0.000147452 0 0.290708 -0.000346753 0 0.235664 -0.0010975 0 + 0.171383 0.000278739 0 0.292724 -0.000618049 0 0.222812 -0.00090544 0 0.130468 -0.000319386 0 + 0.190435 0.000518513 0 0.29246 -0.000411202 0 0.231366 6.82527e-05 0 0.291966 -0.000680985 0 + 0.28652 4.05753e-05 0 0.172765 0.000435917 0 0.250108 0.000878599 0 0.293179 -0.000506597 0 + 0.220229 -0.00082373 0 0.228458 -0.00103943 0 0.289045 -4.60166e-05 0 0.20628 0.000663103 0 + 0.147764 -0.00059554 0 0.256456 -0.00113365 0 0.254042 0.000464792 0 0.28949 -0.000787736 0 + 0.23458 0.000977128 0 0.247962 -0.00139316 0 0.146593 -0.000433614 0 0.291566 -0.000726155 0 + 0.211158 0.000623558 0 0.258041 0.0011678 0 0.286241 -0.00113641 0 0.183339 -0.00074337 0 + 0.0883033 -0.000165717 0 0.292498 -0.000485183 0 0.262159 0.000562952 0 0.280012 -0.00117083 0 + 0.196494 0.000587298 0 0.162891 0.000185975 0 0.29065 -0.00016718 0 0.247281 -0.00123612 0 + 0.158778 -0.00059753 0 0.160917 -0.000507497 0 0.280692 -0.00133642 0 0.292025 -0.000490811 0 + 0.223625 7.00822e-05 0 0.262248 0.00117606 0 0.244652 0.000541048 0 0.232706 -0.00110853 0 + 0.183997 -0.00038742 0 0.171796 -0.00033237 0 0.112261 0.000108214 0 0.173919 -0.000602455 0 + 0.264826 0.000451897 0 0.11369 -0.000258928 0 0.290357 -0.000145627 0 0.259787 -0.000578389 0 + 0.237093 -0.00112113 0 0.209009 -0.000859482 0 0.256092 0.000505189 0 0.293048 -0.000590591 0 + 0.249212 0.000368184 0 0.29439 -0.000487395 0 0.23303 -0.00105462 0 0.18656 -0.00118659 0 + 0.289868 -0.000277457 0 0.290885 -0.000369003 0 0.277 -0.000893299 0 0.228798 -0.000989725 0 + 0.224041 -0.0009722 0 0.289184 -0.000115905 0 0.294388 -0.000469047 0 0.294224 -0.000495341 0 + 0.242843 0.000625243 0 0.243661 -0.00153361 0 0.284615 0.000109054 0 0.0789534 6.47942e-05 0 + 0.200605 0.000590072 0 0.192304 -0.000734249 0 0.244147 -0.00138799 0 0.18989 0.000389281 0 + 0.290694 -0.00030758 0 0.290273 -0.000481509 0 0.0749536 0.000128099 0 0.157336 0.000340516 0 + 0.239907 -0.0014488 0 0.261887 0.000991673 0 0.117595 0.000133763 0 0.120938 0.000124104 0 + 0.23961 -0.00116467 0 0.289725 -0.000167408 0 0.25055 0.000635791 0 0.252836 0.000477744 0 + 0.102833 -0.000179498 0 0.2904 -0.00024537 0 0.102806 0.000173234 0 0.290102 -0.000342109 0 + 0.291724 -0.000678711 0 0.128202 0.000121718 0 0.294717 -0.000418002 0 0.122714 -0.000171433 0 + 0.124508 -0.000436209 0 0.288741 -5.91638e-05 0 0.243383 -0.00123279 0 0.158177 0.000447196 0 + 0.118518 -0.000248325 0 0.275041 0.000678626 0 0.20042 0.000661976 0 0.0840482 8.26768e-05 0 + 0.286819 -6.21848e-05 0 0.144799 -0.000488414 0 0.294051 -0.000448304 0 0.122854 -0.000337539 0 + 0.286037 3.61897e-05 0 0.0821433 -8.69918e-05 0 0.273888 -0.000908531 0 0.193629 0.000492885 0 + 0.121414 0.0001065 0 0.111792 0.000179113 0 0.290154 -0.000223898 0 0.288617 -3.04135e-05 0 + 0.17593 0.000583897 0 0.268263 0.00104412 0 0.136432 0.000129415 0 0.29392 -0.000527995 0 + 0.168703 0.00030594 0 0.291957 -0.000412356 0 0.142791 0.000218484 0 0.139362 0.000183945 0 + 0.104628 -0.000239778 0 0.205453 0.000626106 0 0.0745426 8.5903e-05 0 0.13309 0.000100231 0 + 0.259354 -0.00117906 0 0.081318 0.000111433 0 0.0920446 0.000140743 0 0.246968 -0.00130169 0 + 0.23372 -0.000958283 0 0.118876 0.000203625 0 0.0599384 9.13687e-05 0 0.286925 -0.00102921 0 + 0.162816 0.000280958 0 0.131448 -0.000359362 0 0.110915 0.000148661 0 0.121728 0.000212361 0 + 0.132115 -0.000343844 0 0.179789 -0.00124828 0 0.0979155 0.000173225 0 0.232247 -0.000938603 0 + 0.240984 -0.0011888 0 0.165573 0.000256833 0 0.205266 0.000703168 0 0.256923 -0.00142881 0 + 0.210143 0.000662081 0 0.203597 0.000557081 0 0.29029 -0.000366813 0 0.160644 -0.000810777 0 + 0.201682 0.000557294 0 0.293498 -0.000549477 0 0.243091 -0.001297 0 0.149734 0.000321717 0 + 0.112107 8.06554e-05 0 0.100834 0.0001844 0 0.29206 -0.000431857 0 0.288543 -4.41592e-05 0 + 0.140233 -0.000542172 0 0.287979 -4.78513e-05 0 0.0986594 0.00014289 0 0.216642 -0.000554579 0 + 0.196808 -0.000482259 0 0.08065 -9.97574e-05 0 0.121874 -0.0001828 0 0.225157 -0.000839303 0 + 0.202526 0.000590199 0 0.157615 -0.000531831 0 0.288148 -0.00104146 0 0.214469 0.000785335 0 + 0.257612 -0.001288 0 0.0356116 -3.44442e-05 0 0.287223 -2.61921e-05 0 0.184873 0.000753419 0 + 0.243892 -0.00145845 0 0.116082 -0.000234238 0 0.0984104 7.11392e-05 0 0.129663 -0.000200806 0 + 0.267659 -0.00125568 0 0.16039 0.000276648 0 0.290592 -0.000205413 0 0.162312 0.000350844 0 + 0.184391 0.000974621 0 0.290007 -0.000190361 0 0.105957 0.000162216 0 0.264226 -0.000578796 0 + 0.218424 -0.00104816 0 0.199539 0.000624578 0 0.107961 0.000141654 0 0.28506 -0.00108974 0 + 0.291519 -0.000489693 0 0.105366 0.000193916 0 0.287873 -8.01531e-05 0 0.258408 0.000372383 0 + 0.241827 0.000920456 0 0.0178581 -7.14975e-06 0 0.290325 -0.000183753 0 0.222447 -0.000949298 0 + 0.29009 -0.000301222 0 0.292547 -0.000573859 0 0.18004 0.000358438 0 0.231217 -0.00108408 0 + 0.28921 -0.000265261 0 0.227036 0.00090416 0 0.195598 0.000554149 0 0.197107 0.000185087 0 + 0.290963 -0.000494352 0 0.273719 -0.00128887 0 0.17437 -0.000935899 0 0.122197 0.000437659 0 + 0.286573 -9.81416e-05 0 0.263175 -0.000566691 0 0.191976 0.000390461 0 0.250351 -0.00137055 0 + 0.283865 0.000152313 0 0.252203 -0.00125769 0 0.191877 -0.000768561 0 0.226915 -0.00101571 0 + 0.218599 -0.000802974 0 0.20442 0.000663707 0 0.0798083 -0.000141703 0 0.285554 -0.000795177 0 + 0.206495 -0.000919598 0 0.289787 -0.000238956 0 0.257076 0.000726581 0 0.115473 -0.000285501 0 + 0.170406 0.000262383 0 0.267374 -0.00452943 0 0.216754 -0.00102224 0 0.29371 -0.000535219 0 + 0.267457 -0.000567311 0 0.239305 -0.00122524 0 0.112652 0.000226636 0 0.273992 0.000765653 0 + 0.166947 0.000400695 0 0.19783 0.000495651 0 0.219096 -0.000951533 0 0.209949 0.000744383 0 + 0.286815 -0.000857398 0 0.288871 -9.11046e-05 0 0.0725151 -0.00010417 0 0.140194 0.000517615 0 + 0.192736 0.000465124 0 0.287752 -1.95321e-05 0 0.248819 0.000740766 0 0.0956679 0.000133008 0 + 0.2921 -0.000603275 0 0.208981 0.000789697 0 0.288129 -2.10939e-05 0 0.187552 0.000174222 0 + 0.123941 -0.000449313 0 0.227623 -0.000922886 0 0.28953 -0.000213145 0 0.109319 0.000103479 0 + 0.257919 0.000669884 0 0.287549 -0.000890296 0 0.185377 0.00017569 0 0.100695 0.000120894 0 + 0.240684 -0.00125098 0 0.0861087 0.000126439 0 0.210235 -0.000745405 0 0.0780465 -0.0001419 0 + 0.191467 -0.000804516 0 0.291405 -0.000410803 0 0.279038 -0.00138995 0 0.0958041 7.72492e-05 0 + 0.0931251 -0.000141385 0 0.156265 0.000132538 0 0.119881 0.000264669 0 0.288225 -0.000970734 0 + 0.285909 6.32747e-05 0 0.246698 -0.00136732 0 0.260484 0.000670732 0 0.1761 0.000283719 0 + 0.289447 -0.000333261 0 0.193733 -0.0010169 0 0.260856 -0.00307512 0 0.275414 -0.00141276 0 + 0.293224 -0.00055512 0 0.25606 0.000614189 0 0.275706 -0.00261236 0 0.232431 -0.000628915 0 + 0.28733 -0.00111553 0 0.213529 0.000834021 0 0.192491 0.000520512 0 0.289123 -8.42063e-05 0 + 0.213961 -0.000927855 0 0.208276 -0.000944893 0 0.285667 -0.00121043 0 0.261844 -0.0012949 0 + 0.0909015 -0.000183079 0 0.201467 0.000625115 0 0.182091 0.000404663 0 0.227263 -0.000967693 0 + 0.192018 -0.000417279 0 0.218117 -0.00109791 0 0.139784 -0.000381173 0 0.282988 -0.00128191 0 + 0.285934 6.48112e-05 0 0.232398 -0.00116538 0 0.24343 -0.00161126 0 0.283415 -0.000761266 0 + 0.175262 0.000162389 0 0.289143 -0.000227276 0 0.107501 0.00027364 0 0.269973 -0.00129789 0 + 0.043747 -4.72566e-05 0 0.120401 -0.000321174 0 0.291764 -0.00066234 0 0.21433 -0.000884737 0 + 0.275979 -0.00125159 0 0.286524 1.33192e-06 0 0.253355 -0.00150881 0 0.279668 -0.0015574 0 + 0.288745 -0.000681348 0 0.24282 -0.0013613 0 0.259645 0.000728095 0 0.282493 -0.000769926 0 + 0.141126 -0.000209024 0 0.153858 -0.000470993 0 0.251834 0.000913583 0 0.0927574 7.85798e-05 0 + 0.174445 0.000331856 0 0.254357 0.000721336 0 0.208153 -0.000513984 0 0.291538 -0.000431776 0 + 0.144311 -0.000415531 0 0.23876 -0.00134977 0 0.120789 8.368e-05 0 0.288304 -7.43644e-05 0 + 0.180395 -0.000637549 0 0.247961 0.000799272 0 0.126732 0.000303985 0 0.172951 0.000162745 0 + 0.276666 -0.00126335 0 0.103972 -0.000179387 0 0.194346 0.000656414 0 0.127921 0.000326784 0 + 0.133646 -0.000190001 0 0.289654 -0.000360888 0 0.188414 0.000461119 0 0.250513 0.00035857 0 + 0.283123 0.000188542 0 0.0686304 5.70838e-05 0 0.121978 -0.000587112 0 0.269377 0.00133117 0 + 0.194498 0.000585711 0 0.198485 0.000660973 0 0.287955 -2.40192e-05 0 0.244864 0.00270836 0 + 0.288871 -0.000200359 0 0.189595 0.000436523 0 0.287182 -5.58034e-05 0 0.281532 -0.00134234 0 + 0.103824 -0.000245427 0 0.130959 0.000124689 0 0.173234 -0.00339293 0 0.105496 -0.000169935 0 + 0.223586 -0.00081967 0 0.28945 -0.000292299 0 0.261493 0.000649715 0 0.249615 -0.00159202 0 + 0.291644 -0.000606697 0 0.140298 -0.000220893 0 0.224413 -0.000742342 0 0.101471 -0.000170493 0 + 0.28875 -0.000323381 0 0.246431 -0.00143652 0 0.099171 0.00017207 0 0.290393 -0.000504604 0 + 0.283955 0.000123477 0 0.0888895 0.000136352 0 0.260134 -0.00351658 0 0.289782 -0.000132903 0 + 0.247224 -0.00161849 0 0.119027 -0.000338443 0 0.285789 -7.17938e-05 0 0.129747 -0.000328603 0 + 0.125215 0.000412962 0 0.121656 0.000146404 0 0.147545 0.000117413 0 0.136688 0.000179402 0 + 0.0180602 -6.58698e-06 0 0.278404 -0.00138103 0 0.290829 -0.000407958 0 0.292128 -0.0005872 0 + 0.157153 0.000232154 0 0.274744 -0.00139819 0 0.239024 -0.0012877 0 0.110649 0.000266074 0 + 0.278548 -0.00153508 0 0.198199 -0.00076528 0 0.151629 -0.000452796 0 0.199804 0.000495954 0 + 0.126432 8.73865e-05 0 0.197366 -0.000457291 0 0.292461 -0.000593249 0 0.287927 -0.00105138 0 + 0.0790021 -0.000145329 0 0.251551 -0.00139401 0 0.288915 -0.000563943 0 0.288195 -0.000681195 0 + 0.212739 0.000788117 0 0.2883 -0.00101427 0 0.149229 -0.000552061 0 0.0593523 8.81602e-05 0 + 0.179643 0.000448937 0 0.227829 -0.00114711 0 0.208029 0.00083669 0 0.288893 -0.00039866 0 + 0.258876 0.0005068 0 0.0352865 -3.12092e-05 0 0.2565 0.00106785 0 0.228783 -0.000792536 0 + 0.0889342 -0.000154807 0 0.287066 -0.00112395 0 0.256235 0.000789021 0 0.2034 0.000703335 0 + 0.242862 -0.00168754 0 0.106052 -0.00041624 0 0.183046 0.000429652 0 0.287535 -5.42824e-07 0 + 0.19554 -0.000443539 0 0.292782 -0.000588458 0 0.257171 0.00059657 0 0.256707 -0.00150445 0 + 0.146578 0.00023769 0 0.197935 -0.000432686 0 0.192845 -0.0012022 0 0.255691 0.00115641 0 + 0.222185 0.00130788 0 0.212608 0.000884644 0 0.134383 -0.000437609 0 0.18724 0.000486199 0 + 0.232113 -0.00122297 0 0.253511 0.00078131 0 0.0655771 5.63103e-05 0 0.114722 -0.00029788 0 + 0.288152 -4.10257e-05 0 0.277413 -0.00201459 0 0.110965 6.92625e-05 0 0.279913 -0.00184828 0 + 0.102672 -0.000118078 0 0.291062 -0.000639814 0 0.196777 0.00102593 0 0.285382 -0.000759859 0 + 0.250618 0.00267553 0 0.0945265 -0.000136752 0 0.159618 0.000235616 0 0.112218 -0.00028335 0 + 0.208152 0.000745802 0 0.24041 -0.00131352 0 0.0944582 0.000178643 0 0.290972 -0.000429522 0 + 0.0374175 4.37517e-05 0 0.148066 0.000415276 0 0.11225 0.000248952 0 0.28527 9.00434e-05 0 + 0.263829 0.000471607 0 0.269119 -0.00128199 0 0.190381 -0.00071242 0 0.286457 -0.000653539 0 + 0.184563 0.00036332 0 0.260655 0.000707125 0 0.178358 0.000285766 0 0.158197 0.000609884 0 + 0.0880164 0.000114394 0 0.242563 -0.00142851 0 0.168977 0.000563478 0 0.236782 -0.00117913 0 + 0.113059 0.000244918 0 0.28958 -0.000558336 0 0.150991 0.000211415 0 0.0995093 -0.00020448 0 + 0.0780158 8.52362e-05 0 0.289085 -0.000427266 0 0.0940258 0.000191166 0 0.2858 3.25603e-05 0 + 0.206423 -0.000499595 0 0.190837 -0.00068146 0 0.114871 0.000315165 0 0.258806 0.000792986 0 + 0.0946829 0.000107645 0 0.247595 0.000756599 0 0.238512 -0.00141879 0 0.185917 -0.000400438 0 + 0.108861 0.000119463 0 0.189299 0.000547283 0 0.173464 0.000312938 0 0.2894 -0.000178134 0 + 0.28495 -4.0779e-05 0 0.292765 -0.000531806 0 0.271168 -0.00286968 0 0.236492 -0.00123954 0 + 0.123566 -0.000321679 0 0.25547 0.000702809 0 0.290236 -0.000409936 0 0.161763 -0.00027477 0 + 0.28846 -0.000210433 0 0.223699 -0.00102084 0 0.133469 0.000346878 0 0.228387 -0.000833196 0 + 0.0438118 -4.86819e-05 0 0.222097 -0.000996518 0 0.125051 -0.000180189 0 0.202089 -0.000772487 0 + 0.0901214 -0.000183533 0 0.266826 -0.00312154 0 0.103547 -0.000160868 0 0.283156 0.000164541 0 + 0.22366 0.0017335 0 0.153434 -0.000750665 0 0.185116 0.000483367 0 0.191364 0.000549778 0 + 0.19837 0.000740924 0 0.2646 -0.00209568 0 0.0986795 9.82845e-05 0 0.233003 -0.000845055 0 + 0.286235 -0.000859393 0 0.219882 -0.000692958 0 0.061669 -0.00013116 0 0.288973 -0.000352789 0 + 0.207179 0.000790577 0 0.213279 -0.00102041 0 0.183943 0.00050942 0 0.186714 0.000365187 0 + 0.288174 -0.000181759 0 0.288022 -0.000310285 0 0.24677 -0.00170019 0 0.136077 0.000475555 0 + 0.288766 -0.000277159 0 0.251957 0.000517004 0 0.124246 -0.000309678 0 0.254624 0.000760795 0 + 0.109168 7.93844e-05 0 0.221745 -0.000565035 0 0.0604901 8.47869e-05 0 0.246843 -0.00178818 0 + 0.0964691 6.68937e-05 0 0.173809 -0.000344476 0 0.288952 -0.000937815 0 0.107167 -0.000253727 0 + 0.0352336 -2.97103e-05 0 0.234515 -0.00133497 0 0.28309 0.000191027 0 0.242327 -0.00150329 0 + 0.130062 0.000160357 0 0.230903 -0.00113954 0 0.102439 0.000205968 0 0.191823 0.00106228 0 + 0.288507 -0.000250428 0 0.0944084 -0.000205532 0 0.179087 0.000337803 0 0.264727 -0.00169938 0 + 0.163307 -0.000678732 0 0.18749 0.000434748 0 0.180863 0.000426737 0 0.277436 -0.0016116 0 + 0.268551 0.000477778 0 0.288192 -0.000396424 0 0.211797 0.000836262 0 0.289102 -0.000154486 0 + 0.29039 -0.000433915 0 0.0935833 6.09013e-05 0 0.129161 0.000418636 0 0.142808 0.000398537 0 + 0.25401 -0.00124077 0 0.113455 0.00029889 0 0.290675 -0.000634702 0 0.106178 0.000334694 0 + 0.154417 0.000459887 0 0.180261 -0.000362395 0 0.26142 0.00127903 0 0.279838 -0.000792332 0 + 0.176051 -0.000795617 0 0.146403 -0.000657652 0 0.264116 0.00117268 0 0.0916227 0.000105896 0 + 0.102602 0.000115908 0 0.238992 -0.00184993 0 0.157029 0.000635231 0 0.202395 0.000744794 0 + 0.121127 -0.000306059 0 0.131964 -0.000211886 0 0.122092 0.000363882 0 0.247696 -0.00146266 0 + 0.254703 0.00118462 0 0.207096 0.000885571 0 0.276378 -0.000805416 0 0.287615 -5.04877e-05 0 + 0.186975 0.000681209 0 0.234025 0.000925079 0 0.284915 0.000101877 0 0.247943 0.000551251 0 + 0.175037 0.000440561 0 0.220639 -0.0012634 0 0.273226 -0.000817738 0 0.286229 -6.67441e-05 0 + 0.285005 -0.00127427 0 0.10563 -0.000263152 0 0.0677834 -0.000108785 0 0.272483 -0.0012676 0 + 0.0932735 -0.000100401 0 0.230611 -0.00119626 0 0.259816 0.000770873 0 0.153487 0.000348365 0 + 0.114709 0.00012907 0 0.221475 0.00138664 0 0.112984 -0.00026988 0 0.263164 0.00054617 0 + 0.235348 -0.00115401 0 0.290379 -0.000709381 0 0.272947 -0.00161114 0 0.261362 0.00278723 0 + 0.290086 -0.000156058 0 0.0782738 0.000139727 0 0.21658 0.00139149 0 0.0182452 1.19721e-05 0 + 0.227281 -0.00126028 0 0.116889 0.000373961 0 0.197369 0.000782291 0 0.276582 -0.00159606 0 + 0.112392 0.000138336 0 0.288732 -0.000166347 0 0.181533 0.00063222 0 0.126977 -0.00040164 0 + 0.213551 -0.00052699 0 0.252669 0.000845452 0 0.181303 0.000340315 0 0.13807 -0.000211244 0 + 0.160977 0.000366837 0 0.223374 -0.00107214 0 0.235967 -0.00136417 0 0.196117 -0.000419559 0 + 0.163012 0.000515832 0 0.285691 -3.63451e-07 0 0.28838 -0.000424306 0 0.203116 -0.000472516 0 + 0.137035 -0.000463109 0 0.211874 -0.000512794 0 0.288426 -0.000139084 0 0.246737 0.000815521 0 + 0.205231 -0.00110299 0 0.28237 0.000206198 0 0.191274 0.00069015 0 0.283498 -0.00154051 0 + 0.101713 0.000104422 0 0.206224 0.000836935 0 0.0846865 -9.74977e-05 0 0.2751 -0.000967897 0 + 0.173687 0.0005777 0 0.145783 0.000203804 0 0.288043 -0.000265893 0 0.28264 0.000219897 0 + 0.134744 0.000203 0 0.261421 -0.00397973 0 0.267651 0.000504403 0 0.287253 -0.000297714 0 + 0.145983 -0.000684609 0 0.206185 0.000936345 0 0.288197 -0.000571631 0 0.257794 -0.00152981 0 + 0.271167 -0.00306207 0 0.235051 -0.00121347 0 0.211706 0.000937441 0 0.283871 -0.00100547 0 + 0.0913294 8.3944e-05 0 0.121561 -0.000356062 0 0.251325 -0.00117364 0 0.290719 -0.000751491 0 + 0.284076 -1.73584e-06 0 0.0805472 -0.000151783 0 0.210652 -0.00114009 0 0.287393 -0.000380117 0 + 0.16785 -0.000308738 0 0.201342 -0.000458776 0 0.245953 -0.00158853 0 0.288255 -0.000340743 0 + 0.272685 -0.00192133 0 0.292463 -0.000626592 0 0.287577 -0.000855197 0 0.154293 0.000252537 0 + 0.27918 -0.00154897 0 0.210873 0.000886336 0 0.286912 -2.82511e-05 0 0.287775 -0.000232804 0 + 0.277836 -0.00103965 0 0.258873 -0.00359089 0 0.234277 -0.00140219 0 0.190149 -0.000404178 0 + 0.253186 -0.00187178 0 0.165797 -0.000297344 0 0.188034 -0.000927121 0 0.247458 0.00150265 0 + 0.283456 -0.00128499 0 0.285304 -0.00121297 0 0.270526 -0.00187153 0 0.124476 0.000151484 0 + 0.25621 -0.00253575 0 0.242105 -0.00157826 0 0.178299 -0.00035 0 0.0682627 0.00011414 0 + 0.29064 -0.000616666 0 0.140152 0.000212909 0 0.232156 0.00118928 0 0.225972 -0.00075959 0 + 0.180432 0.000664266 0 0.285429 -3.69142e-05 0 0.196423 0.000738631 0 0.0833911 0.000148598 0 + 0.0947935 -0.000350094 0 0.131155 -0.000646599 0 0.185962 0.000642386 0 0.28977 -0.000506327 0 + 0.252652 0.000696329 0 0.272286 0.000940836 0 0.142263 0.000115657 0 0.170568 0.000387302 0 + 0.112287 -0.000521374 0 0.276026 -0.00158281 0 0.27411 -0.00289586 0 0.292494 -0.000587581 0 + 0.235735 -0.00143299 0 0.152013 -0.000583658 0 0.231373 -0.00141253 0 0.239864 0.00119657 0 + 0.168836 -0.000745688 0 0.256292 0.00175454 0 0.224817 -0.00149183 0 0.289033 -0.000589118 0 + 0.209967 -0.00130749 0 0.253782 0.000824529 0 0.204266 0.00074517 0 0.186529 -0.000378974 0 + 0.284151 0.000136681 0 0.0824936 -0.000152534 0 0.286421 -0.00027431 0 0.265648 -0.0010445 0 + 0.153063 -0.000772792 0 0.196387 0.000825204 0 0.260389 0.000862763 0 0.200447 0.000928938 0 + 0.238288 -0.00149004 0 0.117023 -0.000262876 0 0.243325 -0.00196675 0 0.0917295 0.000144169 0 + 0.125294 0.000173424 0 0.155978 0.000354818 0 0.283145 4.25723e-05 0 0.28762 -0.000415682 0 + 0.136784 -0.000379319 0 0.286719 -0.00114075 0 0.249419 0.00165464 0 0.249984 -0.00188228 0 + 0.282862 -0.00101908 0 0.091287 0.000173072 0 0.28963 -0.000480898 0 0.19023 0.000727276 0 + 0.292777 -0.000516998 0 0.217815 -0.000885298 0 0.284901 3.34732e-05 0 0.230289 -0.000810584 0 + 0.287358 -3.39813e-06 0 0.103265 0.000232026 0 0.165711 -0.000704752 0 0.0188799 1.00547e-05 0 + 0.14915 0.000242587 0 0.291397 -0.000683914 0 0.0644519 -0.000117369 0 0.129055 -0.000342852 0 + 0.193293 0.000693466 0 0.283216 -0.000936203 0 0.228134 -0.00109223 0 0.277525 -0.000993359 0 + 0.176201 0.000801203 0 0.289689 -0.000583554 0 0.088299 0.00013353 0 0.286467 -0.00117699 0 + 0.28805 -0.000146993 0 0.197231 -0.00067788 0 0.212413 -0.00117086 0 0.196002 -0.00100273 0 + 0.261412 0.00121271 0 0.0576041 3.92653e-05 0 0.253092 -0.00159065 0 0.227038 -0.00132259 0 + 0.097378 0.000226422 0 0.178109 -0.000822468 0 0.281794 0.000269513 0 0.249274 0.000948046 0 + 0.28752 -0.000333584 0 0.221765 -0.00104647 0 0.285671 -0.000972526 0 0.277917 -0.00212487 0 + 0.130481 -0.00019192 0 0.278163 -0.00221139 0 0.287303 -0.000251547 0 0.195416 0.000779338 0 + 0.145016 -0.000725287 0 0.184878 0.00067618 0 0.251485 0.000713134 0 0.292122 -0.000670143 0 + 0.289068 -0.000922698 0 0.289474 -0.00080718 0 0.116335 0.00017715 0 0.245659 -0.00167192 0 + 0.239686 -0.00152133 0 0.110243 0.000237302 0 0.147174 0.000314701 0 0.288622 -0.000880395 0 + 0.241661 -0.00165304 0 0.283502 -4.63979e-05 0 0.234466 -0.000863266 0 0.210672 -0.00070931 0 + 0.287732 -0.000117343 0 0.105904 0.000120948 0 0.25615 -0.0016664 0 0.121181 0.000292198 0 + 0.278328 -0.00170162 0 0.205287 0.000885119 0 0.270086 0.00125778 0 0.287025 -0.000217328 0 + 0.224222 0.0016384 0 0.281614 -0.0017258 0 0.128082 0.000178716 0 0.138301 0.000249529 0 + 0.179345 0.000697504 0 0.288945 -0.000478874 0 0.28489 -0.00098306 0 0.283087 -0.00157639 0 + 0.162934 -0.000843033 0 0.0853173 7.28744e-05 0 0.144498 -0.000777062 0 0.188144 -0.000584298 0 + 0.282918 -0.00149679 0 0.214468 0.00111108 0 0.227311 0.00163125 0 0.284692 0.000111583 0 + 0.28664 -0.000381893 0 0.260765 0.00164964 0 0.266442 -0.00657556 0 0.271784 -0.00168117 0 + 0.163122 0.00046164 0 0.168366 -0.00118251 0 0.159989 -0.000870928 0 0.170551 0.00142727 0 + 0.27975 -0.00106181 0 0.0828601 -0.000190168 0 0.189521 -0.000780351 0 0.0366114 -4.30365e-05 0 + 0.286197 9.22719e-07 0 0.118306 0.000279672 0 0.203282 0.000788694 0 0.148339 0.000335595 0 + 0.286939 1.96787e-05 0 0.209968 0.000938489 0 0.242781 -0.00185848 0 0.189202 0.000765679 0 + 0.203898 -0.000794127 0 0.104477 0.000256374 0 0.199486 0.000877845 0 0.252175 -0.00184039 0 + 0.246431 -0.00187669 0 0.204373 0.000935119 0 0.271683 -0.00125317 0 0.289103 -0.000506086 0 + 0.229851 -0.00138089 0 0.231598 -0.00134554 0 0.143617 -0.000546809 0 0.164709 0.000355642 0 + 0.100195 0.00022125 0 0.28406 7.08126e-05 0 0.0665089 -0.000178096 0 0.286828 -0.000412238 0 + 0.255696 -0.00125209 0 0.100481 0.000241388 0 0.171391 0.000634669 0 0.272702 0.000272081 0 + 0.285552 -0.00025476 0 0.246445 -0.00206815 0 0.184617 -0.000366411 0 0.201406 0.00078759 0 + 0.278628 -0.00215435 0 0.205297 0.000989245 0 0.246377 -0.00216918 0 0.221489 -0.0007099 0 + 0.287734 -0.000191373 0 0.250823 -0.00162139 0 0.286586 -0.000561692 0 0.255569 0.00189593 0 + 0.28259 -0.00139258 0 0.286692 -0.000310928 0 0.213611 -0.000973542 0 0.176038 0.000522477 0 + 0.273373 -0.00283186 0 0.152682 -0.000799434 0 0.283177 -0.0012923 0 0.174468 -0.000325818 0 + 0.254556 -0.00123126 0 0.281047 -0.0017595 0 0.12793 -0.000443683 0 0.105693 0.000220367 0 + 0.28623 1.98113e-05 0 0.286487 -0.000228496 0 0.209971 0.00105007 0 0.290898 -0.000763859 0 + 0.245441 -0.00175377 0 0.254883 -0.00116907 0 0.139119 -0.00039673 0 0.172466 -0.000314201 0 + 0.209141 0.00111003 0 0.238058 -0.00156451 0 0.249212 0.00053897 0 0.169539 0.000364157 0 + 0.24996 -0.00207764 0 0.256909 0.000565645 0 0.275068 0.000754323 0 0.226585 -0.0010671 0 + 0.281014 0.000313249 0 0.290067 -0.000816148 0 0.0433564 4.49268e-05 0 0.242498 0.00243982 0 + 0.286191 -0.000192564 0 0.152863 -0.00041791 0 0.111922 0.000301339 0 0.267511 0.00165744 0 + 0.260294 -0.00168009 0 0.287434 -0.000161063 0 0.151372 -0.000923587 0 0.280701 -0.00176017 0 + 0.208501 -0.000725549 0 0.226816 -0.00138751 0 0.222282 -0.00129493 0 0.255505 0.00109522 0 + 0.187362 0.000939451 0 0.193685 -0.000639684 0 0.264196 -0.00119589 0 0.141707 -0.000606847 0 + 0.247649 0.00109768 0 0.239429 -0.00159826 0 0.281772 -0.00103054 0 0.22307 -0.00112447 0 + 0.0999465 -0.000280186 0 0.220636 -0.00078293 0 0.153822 -0.0007218 0 0.247596 -0.00117447 0 + 0.269722 -0.00184508 0 0.202317 0.0008338 0 0.285005 7.4617e-05 0 0.231157 -0.00148237 0 + 0.268234 0.000304495 0 0.282749 8.61592e-05 0 0.215529 -0.000765287 0 0.274607 -0.00164988 0 + 0.220412 -0.00132449 0 0.285663 -0.00034524 0 0.256318 0.00101189 0 0.221452 -0.00109794 0 + 0.268186 -0.00169108 0 0.263864 -0.00125951 0 0.286058 -3.0524e-05 0 0.285807 5.06223e-05 0 + 0.223148 0.00183195 0 0.28982 -0.000707953 0 0.119221 0.000351113 0 0.268436 -0.00191796 0 + 0.254566 0.000925864 0 0.10579 -0.000357409 0 0.258732 0.00101971 0 0.175276 0.000395164 0 + 0.12799 0.000430475 0 0.279939 -0.000940172 0 0.263679 -0.00188353 0 0.273955 -0.00163453 0 + 0.155719 0.000439463 0 0.286487 -2.87784e-05 0 0.112607 0.000141393 0 0.197389 -0.000839375 0 + 0.282647 0.0001802 0 0.166723 -0.000591692 0 0.204741 -0.00120755 0 0.126368 0.000405063 0 + 0.282104 -0.00166907 0 0.0975264 -0.000221316 0 0.283545 0.000158257 0 0.225459 -0.00129163 0 + 0.24778 0.00180662 0 0.285946 -0.000387321 0 0.200436 0.000832005 0 0.192335 0.000653856 0 + 0.28261 -1.7265e-05 0 0.201371 0.000880486 0 0.100227 -0.000196555 0 0.289371 -0.000802445 0 + 0.21189 -0.000948412 0 0.280148 -0.00176678 0 0.0185648 -1.12529e-05 0 0.254836 0.00261998 0 + 0.248885 -0.00184826 0 0.216921 -0.00138571 0 0.121538 0.000157955 0 0.23768 -0.00164655 0 + 0.277543 -0.00183343 0 0.284584 -2.63925e-06 0 0.215197 -0.00135106 0 0.216438 -0.00107098 0 + 0.271884 -0.00190278 0 0.230083 -0.00131517 0 0.0906303 0.000188352 0 0.212627 -0.000862342 0 + 0.0866078 0.000160336 0 0.252934 0.00108031 0 0.0803147 0.000146689 0 0.24659 0.00207444 0 + 0.288309 -0.000814051 0 0.235171 -0.00165505 0 0.285657 -0.000209587 0 0.198559 0.000925433 0 + 0.283699 0.000163431 0 0.192255 0.000731334 0 0.285003 -8.16829e-05 0 0.0661025 9.88793e-05 0 + 0.11944 0.000384083 0 0.159818 -0.00055258 0 0.257913 0.00110625 0 0.114934 0.000414311 0 + 0.21367 0.00117602 0 0.26082 -0.00127579 0 0.272922 -0.00234924 0 0.289269 -0.000834119 0 + 0.11408 -0.000313146 0 0.246858 0.00118065 0 0.256747 0.00208105 0 0.194487 0.00091525 0 + 0.219459 -0.000907198 0 0.115813 -0.000394467 0 0.268469 -0.00227412 0 0.111157 -0.000347079 0 + 0.184243 -0.00087044 0 0.239122 -0.00168115 0 0.269169 -0.00447427 0 0.285865 -0.000299047 0 + 0.27982 -0.00200593 0 0.25902 -0.00124253 0 0.259681 0.000991261 0 0.0875901 -0.000171903 0 + 0.286983 -0.000172875 0 0.28703 -9.52815e-05 0 0.152711 -0.0008344 0 0.161865 0.000483963 0 + 0.276911 -0.00222038 0 0.217568 -0.00120458 0 0.267509 -0.00189474 0 0.0739119 -0.000147257 0 + 0.212802 0.00111242 0 0.194429 0.000821298 0 0.120468 0.000197924 0 0.152103 -0.000855796 0 + 0.285347 -0.000168623 0 0.111474 0.000346052 0 0.283689 4.23951e-05 0 0.111289 -0.000295961 0 + 0.245223 -0.00184287 0 0.218019 0.00124208 0 0.26322 0.00151845 0 0.0868161 -0.000246921 0 + 0.135619 0.000243514 0 0.159455 -0.000932924 0 0.201779 -0.00104337 0 0.280476 0.000285602 0 + 0.2671 -0.00118033 0 0.0900034 0.000313661 0 0.199077 -0.000697876 0 0.244403 0.000740717 0 + 0.29116 -0.000756079 0 0.260731 0.00254354 0 0.269453 -0.00121625 0 0.206588 -0.00124105 0 + 0.192749 -0.000702126 0 0.156236 0.000319702 0 0.197446 0.000699148 0 0.265501 0.00138604 0 + 0.284728 -0.000321788 0 0.0840717 0.000164478 0 0.148918 0.000737419 0 0.186005 0.0013066 0 + 0.283319 -0.00155151 0 0.0790734 -0.000208425 0 0.281804 -0.00167296 0 0.0987589 -0.000217498 0 + 0.279685 -0.00176501 0 0.0713646 0.000118861 0 0.153634 0.00071206 0 0.23093 -0.00155813 0 + 0.278705 -0.00193368 0 0.260708 0.00195851 0 0.284361 -0.00140585 0 0.148102 0.000560364 0 + 0.264085 -0.00468745 0 0.249169 -0.00204557 0 0.284773 -0.000423657 0 0.286673 -0.000138468 0 + 0.0981494 0.000229435 0 0.255623 0.000901767 0 0.0961702 -0.000206456 0 0.281146 -0.00074668 0 + 0.241724 -0.00174204 0 0.166065 -0.00110791 0 0.118695 0.000150865 0 0.237571 -0.00181172 0 + 0.0915717 -0.000167633 0 0.125069 0.000454087 0 0.131586 -0.000524029 0 0.20823 0.00104964 0 + 0.225436 0.00129979 0 0.281566 2.90559e-05 0 0.203482 0.000987213 0 0.0692911 -0.000153852 0 + 0.246346 -0.00227865 0 0.0858791 -0.000205635 0 0.285475 4.0798e-05 0 0.252135 0.00116622 0 + 0.280808 -0.000968745 0 0.194078 -0.000972111 0 0.285349 -0.000122034 0 0.282735 0.000202074 0 + 0.119711 -0.000614567 0 0.0683385 9.94339e-05 0 0.218751 -0.000998864 0 0.278264 -0.00192797 0 + 0.164386 0.00044044 0 0.158701 0.000324779 0 0.226417 -0.0015247 0 0.191234 0.000770674 0 + 0.0751751 0.000184374 0 0.28529 -8.85491e-07 0 0.264832 -0.00127747 0 0.28323 0.000114517 0 + 0.243055 -0.0017781 0 0.241483 -0.0018206 0 0.282381 0.000158482 0 0.276922 -0.00200589 0 + 0.198631 -0.000731285 0 0.113099 0.000324883 0 0.163275 -0.000812302 0 0.179363 0.000626275 0 + 0.267806 -0.00655736 0 0.283133 -2.0573e-06 0 0.235162 0.00117009 0 0.15118 -0.000946956 0 + 0.249826 -0.00218472 0 0.284719 -0.00017497 0 0.278673 -0.00095264 0 0.177526 0.000398586 0 + 0.283741 -0.000295454 0 0.0663052 9.73998e-05 0 0.199387 0.000700636 0 0.258856 0.00107624 0 + 0.290115 -0.000652393 0 0.242779 -0.00236352 0 0.0816539 -0.000207825 0 0.134758 -0.000488834 0 + 0.188052 0.000646578 0 0.242619 0.00179242 0 0.279522 -0.00184543 0 0.150013 0.00028957 0 + 0.279635 -0.000887393 0 0.0743895 -0.000107938 0 0.133356 0.000461619 0 0.286184 -0.000148376 0 + 0.214715 -0.000844092 0 0.265086 0.00120362 0 0.286469 -0.00095504 0 0.107546 0.00016137 0 + 0.28277 -0.00102479 0 0.285761 -0.00100209 0 0.285033 -0.000466106 0 0.219014 -0.000763835 0 + 0.253981 0.00105553 0 0.122344 0.00047653 0 0.137709 -0.00059113 0 0.284271 -0.00131359 0 + 0.246494 0.00111811 0 0.285569 -0.000649401 0 0.251936 -0.002146 0 0.233668 -0.00162007 0 + 0.27924 0.000158819 0 0.23525 -0.00157824 0 0.0645352 0.000160524 0 0.284391 -0.000131748 0 + 0.280987 -0.00100476 0 0.0971941 0.000129897 0 0.22269 0.00193371 0 0.285611 -0.00130306 0 + 0.245684 0.00072668 0 0.158851 -0.00101614 0 0.241861 0.00125241 0 0.183908 0.00112643 0 + 0.24194 -0.00192373 0 0.198673 0.00103156 0 0.154627 0.000371334 0 0.2074 0.00110864 0 + 0.285855 -0.000111269 0 0.290032 -0.000769082 0 0.253176 0.00114061 0 0.208633 -0.000901188 0 + 0.284617 -0.000646305 0 0.202616 0.0010414 0 0.142833 0.000534077 0 0.283601 -0.000638843 0 + 0.169068 0.000504745 0 0.285012 -0.000363695 0 0.154565 0.000621579 0 0.132306 0.000744996 0 + 0.178252 0.000657637 0 0.212904 0.00124348 0 0.0351216 3.66055e-05 0 0.128915 0.000215514 0 + 0.138304 -0.00061592 0 0.222523 -0.00123426 0 0.284909 -0.000265958 0 0.152122 0.000364233 0 + 0.185915 0.000717007 0 0.107719 -0.000356653 0 0.218107 0.00192261 0 0.280104 -0.00162115 0 + 0.283763 -0.000406138 0 0.0849245 0.000224311 0 0.217283 0.0013151 0 0.265162 -0.00121205 0 + 0.182651 0.000600319 0 0.109163 0.000348518 0 0.27258 0.00101941 0 0.0978536 -0.000303427 0 + 0.284463 3.36531e-05 0 0.277429 -0.00232886 0 0.247894 0.00418688 0 0.245161 -0.00202698 0 + 0.284601 -0.000223203 0 0.264021 0.001562 0 0.274152 -0.00252083 0 0.134041 -0.000549417 0 + 0.190397 -0.000915869 0 0.249756 -0.00229155 0 0.101702 -0.000299915 0 0.258197 -0.00511594 0 + 0.269739 -0.00261482 0 0.124724 -0.000418011 0 0.283654 7.38014e-05 0 0.217089 -0.000974056 0 + 0.1328 -0.000470508 0 0.282827 -0.00158274 0 0.16325 0.000700123 0 0.21587 -0.00117407 0 + 0.212005 0.00117642 0 0.113432 0.000170702 0 0.17029 0.000480761 0 0.287367 -0.000129196 0 + 0.284042 -0.000448091 0 0.181867 0.000869434 0 0.196775 -0.000710489 0 0.282712 -0.000272308 0 + 0.173984 0.000790326 0 0.119864 -0.000391258 0 0.229635 -0.00144951 0 0.15833 0.00040163 0 + 0.0872271 0.00017482 0 0.206807 -0.00118668 0 0.265475 -0.00228664 0 0.229415 -0.00152073 0 + 0.118532 -0.00042167 0 0.0946735 -0.000243239 0 0.256071 0.00224625 0 0.216428 0.00124446 0 + 0.163132 0.000632506 0 0.27319 0.000406716 0 0.269845 -0.00163535 0 0.284154 -0.00145208 0 + 0.191598 0.000955935 0 0.213021 -0.000822917 0 0.100251 0.000134209 0 0.252521 -0.00119459 0 + 0.284062 -0.000340666 0 0.284717 5.82448e-05 0 0.233465 -0.00178856 0 0.234059 -0.00147174 0 + 0.26145 0.00234021 0 0.140166 -0.00061672 0 0.230728 -0.00171191 0 0.144793 0.000278841 0 + 0.117665 -0.00037224 0 0.28192 0.000115826 0 0.0896897 0.000105357 0 0.248851 -0.00119651 0 + 0.18381 0.000711141 0 0.251393 0.00219632 0 0.233813 -0.00154447 0 0.283956 -0.000239191 0 + 0.186244 0.00088748 0 0.145581 -0.00070525 0 0.202791 0.00116053 0 0.21217 0.00131393 0 + 0.247064 0.00300623 0 0.204318 -0.000758173 0 0.265736 -0.00426798 0 0.0655142 -8.57064e-05 0 + 0.075295 7.22996e-05 0 0.116453 -0.000453969 0 0.110734 0.000431464 0 0.283656 -0.000195489 0 + 0.204433 0.0010444 0 0.207651 -0.000798906 0 0.234775 -0.00127218 0 0.277117 0.000532169 0 + 0.237541 -0.00189566 0 0.102784 0.000335855 0 0.0800822 -0.000131032 0 0.284971 -0.00129485 0 + 0.225752 0.00239577 0 0.267631 -0.00224809 0 0.221869 -0.00142489 0 0.235518 -0.0015044 0 + 0.123303 0.000203567 0 0.199538 -0.000665063 0 0.165295 0.000899499 0 0.107948 -0.000241326 0 + 0.187062 0.000609195 0 0.187148 -0.000641586 0 0.0637168 4.78387e-05 0 0.197702 -0.000645997 0 + 0.289992 -0.000786688 0 0.18049 0.000595355 0 0.28271 -0.000385021 0 0.267705 -0.00548274 0 + 0.249745 -0.00240783 0 0.278111 0.000213236 0 0.28131 -0.00168324 0 0.285898 -0.000581755 0 + 0.220888 -0.00120447 0 0.0763231 -0.000201934 0 0.242865 -0.00247606 0 0.264074 0.00179802 0 + 0.257777 -0.00236862 0 0.186456 0.000984977 0 0.262176 -0.00122886 0 0.108942 -0.000329054 0 + 0.24509 -0.00212946 0 0.091326 0.000254929 0 0.284306 9.52402e-05 0 0.282508 -0.000624413 0 + 0.264503 -0.00441148 0 0.262142 -0.0192784 0 0.162076 -0.000466564 0 0.173654 0.000643027 0 + 0.238976 -0.0019353 0 0.0562955 0.000111667 0 0.244816 0.000782224 0 0.185191 -0.000621768 0 + 0.118378 0.000501672 0 0.251301 0.0010395 0 0.281553 -0.000224882 0 0.234981 -0.00182691 0 + 0.284445 -8.36928e-05 0 0.0811213 0.00016606 0 0.193572 0.000962837 0 0.170169 0.000537018 0 + 0.251835 -0.00225245 0 0.289839 -0.000728807 0 0.259339 0.00120828 0 0.065472 0.000147483 0 + 0.241531 0.0157442 0 0.248604 -0.00214177 0 0.285679 -0.000543786 0 0.280254 -0.00119215 0 + 0.251992 0.00204374 0 0.168283 0.000799732 0 0.274243 0.000847702 0 0.140776 -0.000643672 0 + 0.137585 -0.000816585 0 0.28302 -0.000433614 0 0.255623 0.0228643 0 0.283033 -0.000316037 0 + 0.24635 -0.00238498 0 0.284293 -0.00143852 0 0.21124 0.00124298 0 0.284081 -4.07845e-05 0 + 0.282989 -0.00021737 0 0.258534 0.0013103 0 0.283905 9.73073e-05 0 0.282334 0.000233706 0 + 0.0435221 5.2162e-05 0 0.155066 -0.000434939 0 0.20311 -0.000871665 0 0.289594 -0.000845211 0 + 0.195928 0.00107866 0 0.215695 0.00131666 0 0.214688 -0.00175054 0 0.178767 0.000898373 0 + 0.105398 -0.000228342 0 0.206839 0.00130399 0 0.267109 0.00158965 0 0.0969189 -0.000190662 0 + 0.272781 -0.00120371 0 0.211472 0.00138688 0 0.285562 -0.00116593 0 0.282668 -0.000170945 0 + 0.19991 -0.00101331 0 0.285763 -0.00068677 0 0.0837862 -0.000217569 0 0.256325 -0.00158299 0 + 0.176032 0.00102059 0 0.2066 0.00116973 0 0.246041 0.0025064 0 0.110663 0.000314474 0 + 0.289516 -0.000861627 0 0.114445 -0.00041375 0 0.215915 0.00147045 0 0.270487 0.0011017 0 + 0.281552 -0.000347041 0 0.290062 -0.000630464 0 0.246493 -0.00262559 0 0.282669 -0.00142074 0 + 0.125351 -0.000499354 0 0.19341 0.000618945 0 0.243534 0.000796679 0 0.121176 0.000383746 0 + 0.237113 0.00138516 0 0.269677 0.00134749 0 0.28282 0.000113741 0 0.266141 0.00188587 0 + 0.133536 -0.000322935 0 0.104303 0.000338547 0 0.17709 0.000555213 0 0.226161 -0.00199554 0 + 0.241423 -0.00201095 0 0.281343 -0.00060821 0 0.109194 -0.000376866 0 0.172582 0.000486595 0 + 0.0983444 0.000279186 0 0.284834 -0.000685767 0 0.136432 -0.000647332 0 0.10598 0.000281612 0 + 0.0883754 -0.000233652 0 0.250198 0.00106171 0 0.257639 -0.00247279 0 0.083409 0.000101921 0 + 0.232304 0.00169897 0 0.16675 0.000446881 0 0.284726 -0.000531309 0 0.0950687 0.000221307 0 + 0.215292 0.00155148 0 0.118497 0.000366858 0 0.279617 -0.00200873 0 0.283846 -0.0006809 0 + 0.243882 0.00200722 0 0.193469 0.00143324 0 0.195426 0.000869353 0 0.205832 0.00123342 0 + 0.0720084 7.41069e-05 0 0.148006 -0.000735445 0 0.258681 -0.00341117 0 0.286122 -0.000894896 0 + 0.22597 0.00227447 0 0.117984 0.000394785 0 0.248536 -0.00224632 0 0.257938 -0.00122284 0 + 0.255098 -0.00214878 0 0.279337 -0.00201787 0 0.150764 0.000932003 0 0.283481 0.000135361 0 + 0.14363 -0.000832129 0 0.267357 -0.00166979 0 0.102664 0.000266605 0 0.28188 -0.000400109 0 + 0.248502 -0.00247757 0 0.132905 -0.000579366 0 0.245051 -0.00223238 0 0.05736 5.83201e-05 0 + 0.239579 0.00172984 0 0.226601 -0.00145528 0 0.0828329 -0.000141026 0 0.2677 -0.00634475 0 + 0.2464 -0.00250556 0 0.242786 -0.00205239 0 0.280572 -0.00171481 0 0.120173 -0.000540287 0 + 0.25899 0.00163965 0 0.144958 -0.000752687 0 0.20733 -0.00108213 0 0.210508 0.00131239 0 + 0.274565 -0.00122805 0 0.2819 -0.000278545 0 0.270608 -0.0016536 0 0.220166 0.00155441 0 + 0.202518 -0.000737494 0 0.212167 -0.00122678 0 0.219576 0.0016423 0 0.220203 -0.00138946 0 + 0.279336 -0.00200026 0 0.198513 -0.00171442 0 0.362016 0.0187247 0 0.25789 -0.0022465 0 + 0.201281 -0.000847374 0 0.0784206 0.000193597 0 0.100463 -0.000316177 0 0.155746 0.000597618 0 + 0.133321 -0.000557871 0 0.263196 -0.00166132 0 0.25178 -0.00236939 0 0.110355 -0.000222157 0 + 0.276843 0.000188482 0 0.284974 -0.000572691 0 0.286005 -0.000863027 0 0.0350518 2.99391e-05 0 + 0.125869 0.000577142 0 0.281511 0.000279578 0 0.229033 -0.00199673 0 0.172532 0.000605474 0 + 0.273546 -0.000807811 0 0.280372 -0.000184911 0 0.123355 -0.000279228 0 0.108167 0.000326082 0 + 0.111949 0.000393599 0 0.0714014 -0.000107427 0 0.281893 -0.000176677 0 0.174785 0.000612911 0 + 0.281511 -0.000117518 0 0.201778 0.00109726 0 0.226736 0.00172887 0 0.197827 0.00108529 0 + 0.19321 -0.000670645 0 0.127056 0.00024741 0 0.208342 0.00117211 0 0.241378 -0.00210773 0 + 0.0853173 -0.000264715 0 0.24711 0.00142286 0 0.28377 -0.000139779 0 0.283501 -0.00113232 0 + 0.213851 -0.00074575 0 0.261584 0.00152035 0 0.236221 -0.00129949 0 0.258415 0.0025076 0 + 0.278554 0.000324802 0 0.283718 -0.000519453 0 0.286269 -0.000756792 0 0.276158 -0.0012328 0 + 0.114974 0.000376434 0 0.260351 0.00233256 0 0.207573 0.00123683 0 0.111427 0.000195042 0 + 0.276567 0.000613036 0 0.0855384 -0.000139035 0 0.271888 -0.00109817 0 0.211952 -0.00128516 0 + 0.132249 -0.000597542 0 0.275456 0.000264827 0 0.183781 0.000569721 0 0.155886 0.00065888 0 + 0.0942179 -0.000325413 0 0.248503 -0.00236366 0 0.268841 -0.00289796 0 0.252971 -0.00229415 0 + 0.288879 -0.000966932 0 0.280349 -0.000313989 0 0.255294 0.00312129 0 0.136645 -0.000694963 0 + 0.122788 -0.000517843 0 0.243365 0.00214372 0 0.216143 -0.0011211 0 0.214715 0.00163489 0 + 0.117055 0.000505186 0 0.253079 -0.00218807 0 0.195501 -0.000815078 0 0.130381 -0.000551841 0 + 0.192518 0.000909513 0 0.192909 -0.00172352 0 0.0771598 -0.000112349 0 0.265915 -0.00163605 0 + 0.28343 -9.56813e-05 0 0.165936 -0.00123108 0 0.166651 0.000555032 0 0.1456 -0.000386672 0 + 0.160764 0.000408489 0 0.0598837 0.000126874 0 0.201278 0.00128484 0 0.276617 0.000347724 0 + 0.209811 0.00138386 0 0.279977 -0.00185693 0 0.254912 0.00160067 0 0.17826 0.000527548 0 + 0.200971 0.00115542 0 0.122707 -0.000475758 0 0.220409 0.00104056 0 0.205097 0.00129914 0 + 0.279424 -0.00205584 0 0.0868308 -0.000276009 0 0.0453439 -6.85259e-05 0 0.225709 -0.00123115 0 + 0.168326 -0.000521139 0 0.245058 -0.00233453 0 0.0738485 -0.000117808 0 0.276115 0.000671768 0 + 0.248972 0.00487539 0 0.2414 -0.00231337 0 0.0861716 0.000292036 0 0.178232 0.00133058 0 + 0.16199 0.000659477 0 0.189144 0.000612676 0 0.282273 7.47863e-05 0 0.283983 -0.00056575 0 + 0.265066 0.00204587 0 0.261599 -0.00225894 0 0.136693 0.000618218 0 0.280697 -0.000369508 0 + 0.0689032 0.000181536 0 0.151015 -0.000967348 0 0.246757 0.0016115 0 0.225013 -0.00142076 0 + 0.272865 0.000960367 0 0.280696 -0.000120059 0 0.249885 -0.00277763 0 0.242746 -0.00215215 0 + 0.0889611 0.000302266 0 0.244522 -0.0684586 0 0.247113 0.00086163 0 0.209459 -0.00161759 0 + 0.0621196 0.000120527 0 0.116755 0.000471748 0 0.0901503 0.000252556 0 0.214335 0.00146951 0 + 0.0792003 0.000192757 0 0.26245 -0.00270475 0 0.267287 -0.00097514 0 0.281552 -0.00177484 0 + 0.0883647 0.00024407 0 0.279067 -0.000272083 0 0.0697145 -9.83185e-05 0 0.273611 -0.00249684 0 + 0.280732 -0.000241909 0 0.282781 -0.000671572 0 0.280322 -6.33017e-05 0 0.066713 -0.000160727 0 + 0.271605 -0.00289837 0 0.197654 0.000974941 0 0.139322 -0.000677935 0 0.258163 0.00299155 0 + 0.191309 -0.000650726 0 0.234867 -0.00199607 0 0.225618 0.00252047 0 0.0381958 5.14133e-05 0 + 0.258206 0.00168273 0 0.241371 -0.00220667 0 0.135186 0.000584375 0 0.219687 -0.00180982 0 + 0.12975 -0.00052479 0 0.0637733 0.00012741 0 0.147205 -0.000782679 0 0.0624589 -0.000134516 0 + 0.218666 0.00155579 0 0.252918 -0.00241147 0 0.217586 -0.00254156 0 0.191794 -0.000620663 0 + 0.250037 -0.00290999 0 0.205483 0.0014421 0 0.274241 -0.00270075 0 0.272294 -0.00339618 0 + 0.0772059 0.00018501 0 0.275077 -0.0027638 0 0.200349 -0.00146645 0 0.240372 0.00378563 0 + 0.193462 0.000864574 0 0.24342 0.00108929 0 0.265928 -0.00360795 0 0.280242 -0.00165199 0 + 0.284431 -0.000761983 0 0.213717 0.00154898 0 0.248526 0.00606043 0 0.282632 -0.000498091 0 + 0.279346 -0.00206829 0 0.0880783 -0.00025671 0 0.121063 -0.000500261 0 0.260831 0.00156479 0 + 0.230626 -0.00204431 0 0.183525 -0.000949331 0 0.101281 0.00028948 0 0.258981 0.00155559 0 + 0.156561 0.00079664 0 0.280013 -0.00187869 0 0.245062 0.00175391 0 0.221418 -0.00185627 0 + 0.278854 0.000215284 0 0.219033 0.00173307 0 0.0705993 -0.000169409 0 0.119443 0.000455899 0 + 0.281643 -0.000659758 0 0.151831 -0.00087799 0 0.176128 -0.000765456 0 0.16916 0.00069288 0 + 0.143384 -0.000850492 0 0.189721 -0.00100023 0 0.242746 -0.00225457 0 0.199547 0.000979365 0 + 0.11705 -0.000435911 0 0.0934621 -0.000160426 0 0.250246 -0.00305234 0 0.113513 0.00041641 0 + 0.276807 -0.00247426 0 0.258076 -0.0176656 0 0.268142 -0.00546132 0 0.275967 -0.00261966 0 + 0.251614 0.00231912 0 0.278588 -0.00216086 0 0.218082 0.00164222 0 0.262199 -0.00163745 0 + 0.278546 -0.000716923 0 0.188296 0.000895457 0 0.0684811 0.000161113 0 0.278942 -0.000411968 0 + 0.27905 9.85433e-05 0 0.245093 -0.00245456 0 0.142134 0.000658497 0 0.279519 -8.04038e-05 0 + 0.131911 -0.00063995 0 0.251665 0.00160327 0 0.241478 -0.0024237 0 0.250212 0.00287196 0 + 0.25154 0.00300843 0 0.282926 -0.00054832 0 0.0713705 -0.000203494 0 0.277695 -0.000222614 0 + 0.214186 0.00172061 0 0.226211 0.00183015 0 0.280746 -0.00150425 0 0.0873897 0.000119959 0 + 0.105877 0.00035675 0 0.274005 0.000356222 0 0.211322 -0.00166218 0 0.0734283 -0.000163734 0 + 0.256207 0.00166228 0 0.283375 -0.000928758 0 0.166216 -0.00050294 0 0.253034 -0.00293127 0 + 0.234876 -0.00208787 0 0.129599 0.000545387 0 0.135489 0.000742358 0 0.0715248 -0.000152244 0 + 0.279304 -0.000473161 0 0.279144 -2.14412e-05 0 0.15146 0.000758574 0 0.27308 -0.00208282 0 + 0.204869 0.00151346 0 0.107668 0.000407154 0 0.195414 0.000620955 0 0.182848 0.000829511 0 + 0.16294 0.00088023 0 0.279891 -0.00073471 0 0.272472 0.000457218 0 0.281479 -0.000474811 0 + 0.205519 -0.00105299 0 0.124633 0.000581553 0 0.18943 0.00121901 0 0.279445 -0.000335226 0 + 0.175774 0.00116176 0 0.166197 -0.00107662 0 0.244634 0.00107136 0 0.20039 0.00227236 0 + 0.198751 0.00133819 0 0.230337 -0.00125373 0 0.237547 -0.00227843 0 0.199097 -0.00115906 0 + 0.113832 -0.000429587 0 0.238431 0.00174803 0 0.271385 -0.00102034 0 0.27702 -0.00066704 0 + 0.179718 -0.00128895 0 0.27952 -0.000202351 0 0.171416 0.00098694 0 0.245181 -0.00257187 0 + 0.166044 -0.00127754 0 0.272481 -0.00146366 0 0.283049 -0.00105818 0 0.256964 -0.00381241 0 + 0.238911 -0.00212382 0 0.15965 0.000383629 0 0.272202 -0.00343114 0 0.283072 -0.00126144 0 + 0.106075 0.000254193 0 0.254763 -0.00288682 0 0.266969 -0.00520772 0 0.267492 0.00139517 0 + 0.281794 -0.000526809 0 0.23649 0.00115667 0 0.139308 0.000760536 0 0.279142 -0.000143547 0 + 0.282312 -0.000935059 0 0.276411 0.000258161 0 0.264995 -0.000942333 0 0.159376 0.000529253 0 + 0.277548 -0.000370587 0 0.132054 0.000668029 0 0.225578 0.00264874 0 0.161149 0.00122846 0 + 0.128539 -0.000617238 0 0.213144 0.00163071 0 0.261348 0.000839256 0 0.230696 -0.00213876 0 + 0.21268 -0.00111755 0 0.273415 -0.00262963 0 0.279436 4.41114e-05 0 0.181822 0.00111083 0 + 0.273923 -0.00268219 0 0.218542 0.00182659 0 0.24783 -0.00330389 0 0.266813 0.0017258 0 + 0.273253 -0.00307305 0 0.25613 -0.0021829 0 0.280837 -0.00179106 0 0.257344 0.00408232 0 + 0.224684 -0.00212007 0 0.280579 -6.13674e-06 0 0.189005 0.00110382 0 0.286413 -0.00079 0 + 0.257441 -0.00160964 0 0.144761 0.000679473 0 0.278543 -0.00171435 0 0.25172 -0.00248761 0 + 0.28608 -0.00108549 0 0.221434 0.00260367 0 0.254719 -0.00261805 0 0.222786 -0.00117773 0 + 0.188703 0.00127212 0 0.213711 0.00180828 0 0.115398 0.00047642 0 0.193568 0.00124488 0 + 0.272455 0.000844866 0 0.234924 -0.00218573 0 0.122978 0.000551748 0 0.277938 -0.000438721 0 + 0.231839 -0.00264151 0 0.118551 0.000223925 0 0.25704 0.00162342 0 0.274775 -0.00273545 0 + 0.271147 -0.00372672 0 0.103291 -0.000395328 0 0.254927 0.00601717 0 0.146396 0.000858919 0 + 0.14319 -0.000868975 0 0.244612 0.00288808 0 0.15853 -0.00115272 0 0.123814 -0.000561854 0 + 0.145765 0.000328261 0 0.139203 -0.000725476 0 0.278088 -0.000288764 0 0.167801 0.000589977 0 + 0.217547 0.00173133 0 0.272975 -0.00280369 0 0.260644 -0.00222793 0 0.276369 0.00037633 0 + 0.124803 -0.00051614 0 0.198088 0.00140098 0 0.239006 -0.00232955 0 0.241576 0.00141678 0 + 0.0909249 -0.000153471 0 0.280192 5.0476e-05 0 0.249551 0.00380211 0 0.263985 -0.0022393 0 + 0.27565 -0.00260793 0 0.225478 0.00145777 0 0.0408882 -4.99979e-05 0 0.278176 -0.000143471 0 + 0.209594 -0.00182415 0 0.203743 0.0014338 0 0.276239 -0.000163576 0 0.180718 0.000820643 0 + 0.266178 -0.00307846 0 0.273908 -0.00287569 0 0.194097 0.0013739 0 0.214822 -0.00190021 0 + 0.119196 0.000564968 0 0.283168 -0.000888004 0 0.0981448 0.000300603 0 0.181031 0.00115625 0 + 0.245889 0.000878368 0 0.281993 -0.00107311 0 0.204301 0.00158596 0 0.253182 -0.00307579 0 + 0.190704 0.00100343 0 0.24743 -0.00315737 0 0.278983 0.000265884 0 0.231846 -0.00128192 0 + 0.277777 -7.83161e-05 0 0.237654 -0.00238332 0 0.248747 0.0017773 0 0.0806002 0.000234151 0 + 0.209155 0.00145675 0 0.139566 -0.000712155 0 0.282265 -0.00162068 0 0.275559 -0.000667197 0 + 0.254026 0.00163596 0 0.188174 0.000577433 0 0.278174 0.000423154 0 0.271083 0.000963467 0 + 0.276041 -0.000316378 0 0.24865 -0.00272268 0 0.274925 -0.0027496 0 0.249727 -0.00252509 0 + 0.233357 -0.00204242 0 0.114816 -0.000485165 0 0.126778 0.000523523 0 0.187208 0.000845405 0 + 0.0816422 -0.000249774 0 0.275874 -0.0026126 0 0.192368 -0.00151203 0 0.210813 0.00146141 0 + 0.210929 -0.00108857 0 0.272602 -0.00277985 0 0.0699937 -0.000172195 0 0.188289 0.00191855 0 + 0.111553 -0.000465134 0 0.17302 -0.00119936 0 0.0887697 -0.000291712 0 0.280428 -0.00064329 0 + 0.154289 -0.000913003 0 0.0837669 -0.000275314 0 0.266422 -0.00150438 0 0.229091 -0.00208855 0 + 0.275027 0.000341787 0 0.274953 0.000477401 0 0.0697657 -0.000164148 0 0.170365 0.000735326 0 + 0.234345 -0.00265274 0 0.260498 0.00279607 0 0.137853 -0.000638512 0 0.273093 -0.00945542 0 + 0.257398 0.00398836 0 0.0949703 0.000281473 0 0.0807642 0.000204562 0 0.284041 -0.00125821 0 + 0.185304 0.00093018 0 0.253316 0.00176294 0 0.0869513 0.000233004 0 0.23747 -0.00207831 0 + 0.281207 -0.00135816 0 0.239123 -0.00243697 0 0.165463 0.000581211 0 0.258496 -0.00265843 0 + 0.192683 0.00101149 0 0.117937 0.000564926 0 0.280099 -0.000587826 0 0.172541 0.000672859 0 + 0.282073 -0.000890837 0 0.106283 0.000409555 0 0.265576 0.00168302 0 0.212621 0.00171447 0 + 0.208542 0.00153142 0 0.188015 0.00132538 0 0.228417 0.00114095 0 0.175195 0.000837022 0 + 0.276453 -0.000387023 0 0.0934044 0.000299904 0 0.268603 -0.00149399 0 0.0822457 0.000232098 0 + 0.210197 0.00153778 0 0.270863 0.000563773 0 0.0704382 -0.000186181 0 0.279943 0.00016456 0 + 0.278896 -0.000776328 0 0.243838 0.00115036 0 0.159328 -0.000470318 0 0.0922448 0.000137967 0 + 0.235165 -0.00238846 0 0.231393 0.00126798 0 0.253393 -0.00322667 0 0.140317 -0.000666887 0 + 0.173259 -0.00140206 0 0.250518 -0.00319931 0 0.129842 -0.000572724 0 0.251878 -0.00287565 0 + 0.258483 0.00199629 0 0.274545 -0.00271921 0 0.080558 0.000235745 0 0.16855 -0.00111595 0 + 0.0674236 0.00015546 0 0.213293 0.00189777 0 0.0624817 -0.000157752 0 0.226118 -0.00190948 0 + 0.28556 -0.00118906 0 0.208643 0.00177707 0 0.256465 0.00383775 0 0.241603 -0.00253645 0 + 0.275727 -0.0108401 0 0.141936 -0.000483574 0 0.0502204 -8.62115e-05 0 0.248799 -0.00285199 0 + 0.115644 0.000548645 0 0.190247 0.000580396 0 0.230814 -0.00223373 0 0.195221 -0.00114134 0 + 0.276788 -8.92449e-05 0 0.201009 -0.00119285 0 0.181958 -0.00133239 0 0.280207 -0.00078874 0 + 0.121514 -0.000539786 0 0.217734 0.00202116 0 0.216661 -0.00195133 0 0.167353 0.00115959 0 + 0.177229 0.000765462 0 0.276874 -0.00157587 0 0.217064 0.00182289 0 0.110492 -0.00048386 0 + 0.285017 -0.00133572 0 0.180912 0.000909743 0 0.274481 -0.000269196 0 0.273904 -0.000634097 0 + 0.154071 -0.000936735 0 0.200375 -0.00164554 0 0.274705 -0.000100434 0 0.136925 -0.000677511 0 + 0.276655 -0.000235492 0 0.273575 -0.00309145 0 0.203129 0.00150325 0 0.197468 0.00146452 0 + 0.263006 -0.00357189 0 0.260942 0.00241236 0 0.0991159 -0.000354629 0 0.276369 -1.55155e-05 0 + 0.126443 -0.000675349 0 0.114047 0.000478235 0 0.255762 0.00455676 0 0.280585 -0.00146976 0 + 0.219847 -0.00138397 0 0.19324 -0.00110776 0 0.283678 -0.00142916 0 0.254856 0.00337372 0 + 0.17297 0.000824772 0 0.27877 -0.00056235 0 0.28463 -0.00080021 0 0.200575 0.0013482 0 + 0.278574 0.000371162 0 0.19218 0.00135858 0 0.268476 -0.0020868 0 0.249102 0.00334395 0 + 0.28363 -0.0011655 0 0.18278 0.00053667 0 0.17736 0.00107835 0 0.0745251 0.000213006 0 + 0.256947 0.00353229 0 0.124256 0.000239898 0 0.147855 -0.000402955 0 0.24263 0.00116857 0 + 0.20746 0.00168547 0 0.184923 0.000540454 0 0.242999 -0.00259172 0 0.280495 -0.0012362 0 + 0.276534 -0.00127958 0 0.1983 -0.0015404 0 0.220659 -0.0023081 0 0.266528 -0.00366913 0 + 0.267567 -0.0022886 0 0.254185 0.00172642 0 0.235019 -0.00228583 0 0.278021 -0.00212951 0 + 0.101419 -0.000403473 0 0.129323 -0.000611879 0 0.0686117 -0.000173042 0 0.175341 0.00151814 0 + 0.212152 0.00179991 0 0.112609 -0.000464704 0 0.275847 -0.00240931 0 0.259952 -0.00334464 0 + 0.157993 0.000842278 0 0.285629 -0.00124951 0 0.239292 -0.00254764 0 0.274922 -0.000347333 0 + 0.245321 -0.00269311 0 0.239625 0.00296779 0 0.246641 -0.00274961 0 0.131103 0.00027167 0 + 0.177229 0.000496838 0 0.273571 0.000573866 0 0.227759 0.00107978 0 0.0826482 -0.000126209 0 + 0.171444 0.000703352 0 0.254962 -0.00318085 0 0.109377 0.000433835 0 0.186212 0.00148073 0 + 0.28605 -0.00106002 0 0.0725593 0.000156708 0 0.0867654 -0.000168925 0 0.251276 -0.00351662 0 + 0.238936 -0.00222091 0 0.211589 0.0381511 0 0.277452 -0.000771551 0 0.273558 0.000437716 0 + 0.21743 0.00212178 0 0.232345 0.00315113 0 0.251783 -0.00368607 0 0.173816 -0.00145921 0 + 0.0694855 0.000147449 0 0.0207154 -1.01205e-05 0 0.0794699 -0.00023349 0 0.249956 0.00210392 0 + 0.138135 -0.000354219 0 0.252025 -0.0030149 0 0.135309 -0.000753806 0 0.248885 0.00242054 0 + 0.275311 -2.19511e-05 0 0.271754 0.00104206 0 0.199914 0.00141282 0 0.223055 -0.0083091 0 + 0.150767 -0.00103133 0 0.146674 0.000478953 0 0.237491 -0.00217489 0 0.0990745 -0.000403384 0 + 0.279126 -0.00062257 0 0.248999 -0.00299014 0 0.178236 -0.000792119 0 0.233614 -0.00233382 0 + 0.267053 -0.00295889 0 0.139258 0.000293937 0 0.179441 0.000501348 0 0.265614 0.000787006 0 + 0.260978 -0.00277645 0 0.12575 -0.000292374 0 0.25086 -0.00335205 0 0.285688 -0.00123134 0 + 0.167002 0.000753914 0 0.0610758 0.000123927 0 0.0999429 0.000361726 0 0.268796 -0.00298975 0 + 0.115314 -0.000247504 0 0.207975 0.0016078 0 0.121718 0.000554417 0 0.221943 -0.00257715 0 + 0.221961 0.00214684 0 0.275625 -0.00259854 0 0.0885184 0.000277944 0 0.13855 -0.00075905 0 + 0.27307 -2.79882e-05 0 0.209627 0.00161613 0 0.284935 -0.00134842 0 0.210169 -0.00125071 0 + 0.129224 0.000641119 0 0.259956 -0.00302335 0 0.077053 0.000220802 0 0.272794 -0.000207286 0 + 0.229848 0.00312627 0 0.274876 5.67589e-05 0 0.25702 0.00247203 0 0.276748 -0.0024739 0 + 0.221702 0.0022575 0 0.275142 -0.000178948 0 0.101148 0.000159643 0 0.215392 -0.00128978 0 + 0.26006 -0.00129501 0 0.0841992 0.00011044 0 0.217107 -0.00132356 0 0.120435 0.000614076 0 + 0.26694 0.000658834 0 0.271595 -0.00851251 0 0.170065 0.000933909 0 0.199454 0.00127662 0 + 0.272104 0.000684867 0 0.165663 0.000420286 0 0.27064 0.000671829 0 0.076838 -0.000221973 0 + 0.264057 -0.00151036 0 0.245514 -0.00281847 0 0.255492 0.00541623 0 0.268071 -0.00717747 0 + 0.231625 0.00160907 0 0.166497 -0.00132058 0 0.26647 0.00075346 0 0.270751 -0.00303057 0 + 0.188195 0.000804852 0 0.209108 0.00169601 0 0.272815 -0.0032395 0 0.088894 -0.000313114 0 + 0.211741 0.00188691 0 0.164676 0.00125094 0 0.0782731 -0.000247205 0 0.229196 -0.00218097 0 + 0.119753 -0.000546026 0 0.226383 -0.00217332 0 0.168014 0.000425821 0 0.280371 0.00010299 0 + 0.277373 -0.000556528 0 0.278504 -0.00193877 0 0.159331 -0.00120348 0 0.0728976 0.000180755 0 + 0.138255 0.000773337 0 0.206998 0.00176403 0 0.230599 -0.00195585 0 0.252234 -0.00316609 0 + 0.13657 0.000731678 0 0.173805 0.00046311 0 0.2044 0.00136587 0 0.2525 -0.00331872 0 + 0.233397 -0.00213497 0 0.255832 -0.00294075 0 0.171523 0.000458031 0 0.175181 0.00106026 0 + 0.153422 0.000643868 0 0.253489 0.00224833 0 0.246841 -0.00287965 0 0.189254 0.000852298 0 + 0.275956 -0.0007235 0 0.203321 0.00173307 0 0.267496 -0.0040228 0 0.138865 -0.000742195 0 + 0.273261 -0.000291192 0 0.217197 0.0022237 0 0.26656 0.00179934 0 0.135619 -0.000742324 0 + 0.243909 0.00156486 0 0.107398 -0.00039048 0 0.280598 -0.00103944 0 0.204868 -0.0108295 0 + 0.0918718 0.000304769 0 0.224462 -0.00186311 0 0.254233 0.00220608 0 0.27065 0.000942643 0 + 0.262777 -0.00275935 0 0.0798299 -0.00025061 0 0.22696 0.00114958 0 0.172037 -0.000714263 0 + 0.280103 -0.00197137 0 0.277587 -0.00232116 0 0.216479 -0.00172297 0 0.0377817 5.00489e-05 0 + 0.272992 -0.003238 0 0.273749 5.3895e-05 0 0.264847 -0.00415249 0 0.233481 -0.0022339 0 + 0.150593 0.000519159 0 0.276849 5.07363e-05 0 0.202564 0.00157358 0 0.277753 -0.000623708 0 + 0.270464 0.00116875 0 0.239516 -0.00266249 0 0.222882 -0.00246137 0 0.249264 -0.00313252 0 + 0.270423 -0.00341204 0 0.25411 0.00208934 0 0.0668082 -0.000156844 0 0.221521 0.0023703 0 + 0.234073 0.00353637 0 0.265688 -0.00499897 0 0.258503 0.00237263 0 0.0865908 -0.000293026 0 + 0.188331 -0.00142057 0 0.12154 -0.000595239 0 0.194767 0.00131458 0 0.221571 -0.00202105 0 + 0.26307 -0.00304811 0 0.144337 -0.000503722 0 0.146705 -0.000827325 0 0.237812 -0.00249114 0 + 0.272072 -0.00334703 0 0.103406 0.0004085 0 0.22172 -0.00210514 0 0.272111 -0.00293689 0 + 0.118792 -0.000566324 0 0.272461 -0.00296247 0 0.235939 -0.00271705 0 0.18743 0.00120449 0 + 0.255965 0.00627882 0 0.207889 0.00194205 0 0.216275 0.0020128 0 0.273466 -0.00213302 0 + 0.245765 -0.0029508 0 0.195478 0.00125638 0 0.212732 -0.00127284 0 0.179773 0.00140063 0 + 0.26854 -0.00305803 0 0.18276 0.000746503 0 0.168108 0.00112739 0 0.270064 -0.00881678 0 + 0.161439 -0.00102664 0 0.270998 -0.000131959 0 0.199296 0.00147854 0 0.248561 0.00229156 0 + 0.273529 -0.000112329 0 0.289354 -0.0330824 0 0.276431 0.000122014 0 0.226629 0.00204164 0 + 0.0602448 0.000108804 0 0.246082 -0.00308836 0 0.273296 0.000139119 0 0.275805 -0.0026095 0 + 0.145793 0.000956814 0 0.0950363 0.000140574 0 0.216556 -0.00187428 0 0.256034 -0.00324341 0 + 0.122157 -0.000344771 0 0.227929 0.00153712 0 0.239248 0.00249056 0 0.206012 -0.00172728 0 + 0.0997443 -0.000327676 0 0.27476 -0.0106137 0 0.27064 -0.00812576 0 0.158536 -0.00111774 0 + 0.0918959 -0.000330436 0 0.115562 0.000507079 0 0.135166 0.000782339 0 0.287757 -0.0295511 0 + 0.246092 0.0017284 0 0.243419 0.00241566 0 0.273356 -0.00307595 0 0.120952 0.000596833 0 + 0.251082 0.0024926 0 0.144085 0.000466874 0 0.256418 0.00252847 0 0.151587 -0.000900241 0 + 0.190345 0.00186399 0 0.227118 -0.0024568 0 0.220595 0.00214128 0 0.228411 0.00253482 0 + 0.174747 -0.00151831 0 0.275812 -0.000478022 0 0.2754 0.000402381 0 0.263299 -0.00497877 0 + 0.251661 0.00790739 0 0.178278 0.000730897 0 0.130034 -0.000685323 0 0.159021 -0.000988755 0 + 0.223858 -0.0026487 0 0.274353 -0.000709912 0 0.192854 0.00130131 0 0.270024 -0.00337158 0 + 0.122178 0.000595852 0 0.254967 -0.00392224 0 0.159787 0.000713447 0 0.264057 -0.00366638 0 + -0.0138943 -0.000105135 0 0.0703012 0.000190006 0 0.118032 -0.000580927 0 0.247101 -0.00301573 0 + 0.266254 0.00131353 0 0.163923 0.000850753 0 0.254517 0.00364608 0 0.235476 0.00401161 0 + 0.239801 -0.002782 0 0.0698326 -0.000188844 0 0.229018 -0.00191071 0 0.0893075 -0.000180545 0 + 0.248435 0.00168346 0 0.113876 -0.000500532 0 0.254156 0.00371229 0 0.143751 0.000829237 0 + 0.198328 -0.00159766 0 0.124994 0.000347437 0 0.153316 0.000963186 0 0.158856 -0.00118294 0 + 0.245596 0.00237332 0 0.109074 0.000266901 0 0.206141 0.00137244 0 0.271822 -0.00333203 0 + 0.272015 0.000548282 0 0.21598 0.00211045 0 0.272933 -0.00322952 0 0.225369 -0.00239493 0 + 0.27621 -0.000539691 0 0.112094 0.000519017 0 0.254445 -0.00373388 0 0.0816175 -0.000151879 0 + 0.262523 -0.000901786 0 0.133832 0.000279699 0 0.224041 0.0014641 0 0.119814 0.000585988 0 + 0.276497 -0.00102403 0 0.25488 0.00204594 0 0.27063 -0.000334445 0 0.241947 -0.00628438 0 + 0.129318 0.000717452 0 0.246472 -0.00322987 0 0.254765 0.00247825 0 0.281168 -0.000939059 0 + 0.271853 0.000394536 0 0.272092 0.000137375 0 0.0203315 -9.36723e-06 0 0.245133 0.00347673 0 + 0.284029 -0.00147654 0 0.181729 0.00078291 0 0.275421 0.000127073 0 0.242903 0.00376219 0 + 0.28034 -0.00191307 0 0.104269 -0.000425935 0 0.220349 0.00224896 0 0.271628 0.000224464 0 + 0.250969 0.00172555 0 0.158435 0.0010185 0 0.186699 0.00125573 0 0.136283 -0.000710293 0 + 0.0855436 0.000276596 0 0.111351 0.000484314 0 0.137972 -0.000788874 0 0.255809 -0.00368696 0 + 0.165013 0.00113002 0 0.105175 -0.000373473 0 0.207611 0.00202454 0 0.212147 -0.00209716 0 + 0.271136 -0.000424141 0 0.0793603 -0.000254196 0 0.0845101 0.000159911 0 0.274985 0.000206014 0 + 0.269083 -4.98149e-05 0 0.271821 -4.12745e-05 0 0.255594 -0.00412776 0 0.197319 0.0017424 0 + 0.249596 -0.0032827 0 0.264927 0.00082429 0 0.217046 0.00232679 0 0.267965 -0.00301944 0 + 0.183125 0.00117357 0 0.271766 -0.000800603 0 0.264457 -0.00539015 0 0.0937432 -0.000322105 0 + 0.259252 -0.00117631 0 0.248076 0.002455 0 0.167206 -0.00135784 0 0.093788 0.000332784 0 + 0.222926 0.00123245 0 0.0908637 -0.0002742 0 0.221428 0.00248537 0 0.201178 0.00178677 0 + 0.265287 0.00185373 0 0.0840482 0.000284796 0 0.195108 0.0011335 0 0.232128 0.00891286 0 + 0.173656 0.00127725 0 0.0508017 -8.50117e-05 0 0.191864 0.00160901 0 0.19633 -0.000958256 0 + 0.238934 0.00335364 0 0.273855 -0.00290252 0 0.234687 0.00375735 0 0.103669 0.00042999 0 + 0.249398 0.00225645 0 0.274022 0.000493101 0 0.27421 -0.000446861 0 0.272003 0.000926843 0 + 0.216486 -0.00237517 0 0.164165 0.00126431 0 0.271491 -0.000222441 0 0.271339 5.23539e-05 0 + 0.267261 -0.00583835 0 0.272974 -0.00153393 0 0.270571 0.00080949 0 0.207769 0.00254689 0 + 0.263755 0.00228512 0 0.0969378 0.000358332 0 0.26664 -0.00778028 0 0.267744 -0.00072644 0 + 0.184561 -0.000835336 0 0.107492 -0.000483545 0 0.269827 -0.000767668 0 0.215758 0.00220908 0 + 0.226884 0.00129214 0 0.224974 0.00215625 0 0.274477 0.0288887 0 0.190195 0.00116687 0 + 0.090208 0.000279884 0 0.243431 -0.00283626 0 0.0920895 0.000334651 0 0.194402 -0.000931004 0 + 0.251895 0.00169303 0 0.170267 0.000663329 0 0.232264 0.00151216 0 0.274655 -0.000524859 0 + 0.0738627 0.000189138 0 0.0695307 0.00027018 0 0.268073 -0.00419449 0 0.255865 0.00513944 0 + 0.163099 -0.000644065 0 0.0673518 -0.000173823 0 0.0492779 8.54457e-05 0 0.269595 -0.00432272 0 + 0.162173 0.000727618 0 0.270317 -0.00397325 0 0.252897 0.00242259 0 0.229351 -0.00227562 0 + 0.275339 -0.00110371 0 0.255414 0.00242807 0 0.153554 -0.0010302 0 0.0654234 0.000160277 0 + 0.181953 -0.00168117 0 0.169148 0.00096814 0 0.129495 -0.000399022 0 0.220182 0.00235848 0 + 0.268652 -0.000263212 0 0.231016 -0.0027907 0 0.173133 -0.00137374 0 0.272313 0.00030457 0 + 0.27391 0.000209676 0 0.191434 0.00166499 0 0.117492 -0.000583316 0 0.253038 -0.00109453 0 + 0.250002 -0.00343878 0 0.0461858 -4.59155e-05 0 0.254608 0.0066174 0 0.265742 -0.00403085 0 + 0.269976 -0.00415565 0 0.206251 0.00192311 0 0.217975 -0.00107705 0 0.2773 0.02158 0 + 0.134863 -0.000782012 0 0.269191 -0.000362001 0 0.265928 -0.00876426 0 0.242678 -0.00303109 0 + 0.273461 0.000294698 0 0.0983788 0.000345453 0 0.184176 0.00145408 0 0.199526 -0.00194671 0 + 0.257852 -0.0041697 0 0.118425 0.000585157 0 0.127044 -0.000381057 0 0.18385 0.000790833 0 + 0.244151 -0.00429861 0 0.145708 -0.00092196 0 0.111503 -0.000286861 0 0.202018 0.00122208 0 + 0.253944 -0.00427923 0 0.039953 -5.0526e-05 0 0.238297 -0.00271872 0 0.200834 0.00185687 0 + 0.270129 -0.00298316 0 0.27347 -0.0018781 0 0.207406 0.00210608 0 0.101507 0.000363152 0 + 0.230984 -0.00233098 0 0.261057 -0.00184077 0 0.222528 -0.00267048 0 0.240493 -0.00138664 0 + 0.216984 0.00243139 0 0.179732 -0.00141325 0 0.269962 7.06705e-05 0 0.221591 -0.00155975 0 + 0.0772596 0.000227694 0 0.259672 0.00151603 0 0.170957 0.0014077 0 0.272556 0.000596779 0 + 0.272603 -0.000663726 0 0.113162 0.000514082 0 0.26654 -0.000183945 0 0.0776257 -0.000230949 0 + 0.130775 -0.000657611 0 0.274993 -0.00129722 0 0.262822 0.000970002 0 0.26666 -0.00562328 0 + 0.237914 0.0062575 0 0.138252 -0.000776768 0 0.151638 -0.000551765 0 0.109365 -0.000494267 0 + 0.186809 -0.00165114 0 0.257208 -0.00459135 0 0.269604 -0.000149719 0 0.158152 0.000552355 0 + 0.249337 -0.00565789 0 0.257892 -0.0035212 0 0.153107 0.000531059 0 0.18018 -0.00152734 0 + 0.269457 0.000172424 0 0.22448 -0.00178346 0 0.269895 -0.00196742 0 0.113266 -0.000509092 0 + 0.244119 -0.00310088 0 0.236327 -0.0028332 0 0.230392 -0.00126799 0 0.134069 -0.000793135 0 + 0.0100565 2.13135e-06 0 0.264026 -0.00618832 0 0.252387 0.00260455 0 0.271042 0.000988868 0 + 0.211393 0.00197522 0 0.1959 0.00165502 0 0.266872 0.000947968 0 0.226124 -0.00182722 0 + 0.240152 -0.00290561 0 0.26348 -0.00782432 0 0.243116 -0.00316747 0 0.272133 -0.000589848 0 + 0.263553 0.00220051 0 0.267042 4.15437e-05 0 0.1882 0.00115414 0 0.255199 -0.00334139 0 + 0.282288 -0.00160068 0 0.18213 0.00164949 0 0.271025 0.000717463 0 0.281624 -0.00121413 0 + 0.250497 -0.00360441 0 0.232914 0.00159726 0 0.280712 -0.00189262 0 0.208945 0.00317398 0 + 0.0840156 0.000258149 0 0.266528 0.00142811 0 0.262903 0.00180143 0 0.195482 0.00171716 0 + 0.212939 0.00198894 0 0.274609 -0.00238481 0 0.284371 -0.0228701 0 0.0647836 0.000149893 0 + 0.273678 -0.00265649 0 0.242017 -0.00277405 0 0.259174 0.00194622 0 0.215618 0.00230845 0 + 0.243062 0.00257682 0 0.180403 -0.00156149 0 0.161089 -0.00116064 0 0.220914 0.00203564 0 + 0.0963677 0.000335493 0 0.0675767 0.000141401 0 0.120847 -0.000608751 0 0.196966 0.00180603 0 + 0.264865 0.000150764 0 0.272262 -0.000879681 0 0.311712 0.10772 0 0.0946867 -0.000365946 0 + 0.253668 -0.00338746 0 0.0646539 -7.38645e-05 0 0.224564 -0.00203284 0 0.249641 0.00598285 0 + 0.259129 -0.00377173 0 0.130249 0.00073708 0 0.231492 -0.00253487 0 0.129466 -0.000707862 0 + 0.221445 -0.00248606 0 0.274919 -0.00103694 0 0.107561 0.000426839 0 0.25472 -0.00274897 0 + 0.191058 0.00171777 0 0.220104 0.00246992 0 0.253261 -0.00365461 0 0.190234 0.000810788 0 + 0.0979805 -0.000218685 0 0.259977 -0.00831643 0 0.116385 0.000309252 0 0.046911 8.14064e-05 0 + 0.25515 -0.00188926 0 0.267111 -0.000292036 0 0.236286 -0.00312761 0 0.111774 0.000505218 0 + 0.26225 0.00230904 0 0.256623 0.00301325 0 0.195125 0.001777 0 0.23958 0.00234146 0 + 0.280855 -0.00108591 0 0.247128 0.00550642 0 0.0888444 0.000182611 0 0.241077 -0.00316705 0 + 0.256217 0.00392478 0 0.266102 0.00154859 0 0.265504 -0.000675545 0 0.281025 -0.00132049 0 + 0.0707218 0.000176512 0 0.269181 -0.00157242 0 0.26264 0.00169806 0 0.182523 -0.000809294 0 + 0.143055 -0.000883165 0 0.258494 -0.0043973 0 0.0724542 0.000187793 0 0.210907 0.00215248 0 + 0.130918 0.000678466 0 0.264885 0.00204724 0 0.18841 -0.000888317 0 0.268042 0.000146128 0 + 0.2322 0.00396657 0 0.262937 -0.00433745 0 0.236783 0.00335362 0 0.200554 0.00192496 0 + 0.273794 -0.00243274 0 0.283648 -0.00145001 0 0.129186 0.000380679 0 0.27373 -0.00289481 0 + 0.156141 -0.000599543 0 0.104253 0.000401352 0 0.178204 0.00103704 0 0.257878 -0.0147094 0 + 0.268169 -0.00234937 0 0.212266 0.00235932 0 0.212652 0.00208089 0 0.110056 0.000485668 0 + 0.237843 0.00129641 0 0.26101 -0.00358223 0 0.0789003 -0.000244794 0 0.15938 0.000585906 0 + 0.161103 -0.00117949 0 0.26547 -0.00515295 0 0.280897 -0.000890975 0 0.280155 -0.0019234 0 + 0.100432 0.000401128 0 0.246939 -0.00338273 0 0.0201634 -1.05076e-05 0 0.263092 -0.000616565 0 + 0.240579 0.00232216 0 0.143897 -0.000812035 0 0.211113 0.00206392 0 0.12285 -0.000566941 0 + 0.12734 -0.000654219 0 0.12806 0.000650075 0 0.262421 -0.0038999 0 0.223328 -0.00255406 0 + 0.149332 -0.000530314 0 0.267518 0.000254317 0 0.241777 -0.00159199 0 0.270423 -0.00202952 0 + 0.166639 0.000616801 0 0.257241 0.00409763 0 0.253067 0.00255871 0 0.234717 -0.00276584 0 + 0.244573 -0.00324337 0 0.221536 0.00272663 0 0.267588 -6.51287e-05 0 0.260565 0.00116068 0 + 0.269027 -0.00442018 0 0.12601 -0.000679755 0 0.258915 -0.00410516 0 0.207435 -0.00213028 0 + 0.217017 0.00253901 0 0.210781 0.00224089 0 0.250341 0.00253224 0 0.175577 -0.00142256 0 + 0.202915 0.00180734 0 0.236785 -0.00295391 0 0.240574 -0.00303307 0 0.270363 -0.000855751 0 + 0.137247 -0.000443275 0 0.150418 0.000781451 0 0.262271 0.00186015 0 0.0101756 5.85273e-06 0 + 0.134859 -0.000424756 0 0.262181 -0.0035142 0 0.189134 -0.00170566 0 0.225816 0.00292238 0 + 0.26442 0.000962479 0 0.256291 0.00781802 0 0.268929 -0.00433423 0 0.256339 -0.00434778 0 + 0.270237 -0.000545513 0 0.135943 -0.000725737 0 0.152387 0.00110571 0 0.101811 0.000407032 0 + 0.253774 -0.00383605 0 0.278374 -0.00221385 0 0.112713 -0.000508529 0 0.0957865 -0.000361249 0 + 0.269995 -0.00412266 0 0.209507 -0.001755 0 0.264277 -8.82274e-05 0 0.211404 -0.00180376 0 + 0.249901 0.00308052 0 0.248314 -0.00346068 0 0.173468 -0.00108739 0 0.114429 0.000513287 0 + 0.255858 0.00672386 0 0.192382 -0.00140794 0 0.215568 0.00240923 0 0.243741 -0.00296708 0 + 0.138808 0.000873727 0 0.26645 0.000767811 0 0.132581 0.001023 0 0.275598 -0.00241406 0 + 0.103079 -0.000249388 0 0.268226 -0.00175279 0 0.241672 0.00511246 0 0.0675262 -7.96845e-05 0 + 0.262536 0.000272902 0 0.151214 -0.00105228 0 0.0880693 -0.000308908 0 0.129685 -0.000697015 0 + 0.269542 -0.00427318 0 0.0953397 -0.000206837 0 0.109084 0.000403896 0 0.186015 -0.00199783 0 + 0.260549 -0.00390404 0 0.145548 -0.000930085 0 0.265437 3.09747e-05 0 0.226122 0.00307279 0 + 0.205977 0.00200196 0 0.0974855 -0.000383274 0 0.106963 -0.000470065 0 0.267744 -0.00461353 0 + 0.264882 -0.000206256 0 0.256758 -0.00407838 0 0.227189 -0.00279109 0 0.272885 -0.00124662 0 + 0.268323 -0.000822357 0 0.257279 -0.00299627 0 0.265975 0.000568183 0 0.108717 0.000472701 0 + 0.269625 -0.00294946 0 0.165308 -0.000669622 0 0.26598 0.000250446 0 0.255921 0.00526072 0 + 0.212439 0.00217317 0 0.263319 -0.00459481 0 0.242313 -0.0029009 0 0.272555 0.000724085 0 + 0.163631 0.00127628 0 0.212305 0.00226553 0 0.226264 0.00215611 0 0.254387 -0.00403359 0 + 0.221762 0.00285673 0 0.260691 0.00194502 0 0.145453 -0.000943145 0 0.264399 -0.00386697 0 + 0.0417378 -5.89358e-05 0 0.265437 0.000367069 0 0.225323 0.00204381 0 0.0954777 0.000365825 0 + 0.202293 0.00195305 0 0.127536 0.000678665 0 0.137421 0.000417203 0 0.229037 -0.00286736 0 + 0.264923 -0.00295247 0 0.122161 0.000334844 0 0.2475 -0.00353939 0 0.245194 0.00253553 0 + 0.255621 0.00374619 0 0.24154 -0.00351624 0 0.10708 0.000470042 0 0.229382 -0.010129 0 + 0.270758 -0.000636794 0 0.237595 0.00403238 0 0.228621 -0.00300868 0 0.201585 0.00171551 0 + 0.0693146 -0.000159161 0 0.0985411 0.000214607 0 0.167466 0.00158306 0 0.20257 0.00188095 0 + 0.267103 -0.00503939 0 0.264528 -0.00576696 0 0.264821 -0.00326146 0 0.26865 -0.00716531 0 + 0.281217 -0.00160102 0 0.266936 -0.00473547 0 0.245704 -0.000968831 0 0.258449 -0.00293698 0 + 0.205774 0.00207945 0 0.267838 -0.00485283 0 0.126943 -0.000662638 0 0.172826 0.00117664 0 + 0.24957 0.00354282 0 0.243246 0.00167572 0 0.0804639 0.000141917 0 0.256887 -0.00376367 0 + 0.257221 0.0011362 0 0.0621642 0.000131407 0 0.064932 0.000150518 0 0.251136 0.00432677 0 + 0.14852 0.00100306 0 0.272106 0.000807895 0 0.196302 0.00210967 0 0.114031 -0.000303276 0 + 0.242151 0.00169764 0 0.254775 0.00193795 0 0.239522 -0.00309165 0 0.232742 -0.00286273 0 + 0.213851 -0.0023998 0 0.263171 0.00144623 0 0.16429 0.000606665 0 0.261852 1.6811e-05 0 + 0.207253 0.00227003 0 0.206593 0.0018435 0 0.257481 -0.00274574 0 0.250541 0.0817981 0 + 0.264671 -0.00456782 0 0.280638 -0.00173993 0 0.259436 -0.00433283 0 0.235155 -0.00288193 0 + 0.26667 -0.00494934 0 0.146443 -0.000846925 0 0.245757 -0.00354599 0 0.262313 0.00110265 0 + 0.242306 0.00132254 0 0.124579 0.000647932 0 0.161713 0.00121761 0 0.0480798 -8.3059e-05 0 + 0.238634 -0.00283891 0 0.269565 -0.00221878 0 0.240219 0.00247224 0 0.200196 0.0012156 0 + 0.263222 -0.0039687 0 0.268203 -0.000489035 0 0.262467 -0.0924728 0 0.264394 -0.00296552 0 + 0.185361 0.00135671 0 0.112501 0.00048231 0 0.251087 -0.00378021 0 0.248053 -0.00191713 0 + 0.161417 -0.00121883 0 0.250046 0.0146636 0 0.230228 0.00329926 0 0.270906 0.00108806 0 + 0.0979643 -0.000391674 0 0.25178 -0.00274133 0 0.254431 0.00343778 0 0.230842 -0.0016273 0 + 0.259252 0.000140557 0 0.116776 0.000553083 0 0.26273 0.00196783 0 0.266128 -0.000780682 0 + 0.116413 0.000408656 0 0.266613 -0.00365036 0 0.266159 0.0016178 0 0.264565 -0.00281525 0 + 0.077048 0.000222986 0 0.263136 0.000145188 0 0.258226 -0.00486546 0 0.102036 0.000410201 0 + 0.221406 0.0012378 0 0.255656 0.00353054 0 0.170478 -0.00161453 0 0.259898 -0.00419195 0 + 0.26297 0.00129501 0 0.0875415 0.000308364 0 0.264354 -0.00660941 0 0.210748 0.00233068 0 + 0.26249 -0.000110555 0 0.215612 0.00251281 0 0.106546 0.000434809 0 0.254311 0.00964498 0 + 0.252388 -0.00386942 0 0.257463 -0.00288603 0 0.260826 -0.00484581 0 0.179898 -0.00120502 0 + 0.253297 0.00309972 0 0.273568 0.000858134 0 0.196228 0.00119882 0 0.257389 -0.0042988 0 + 0.226248 -0.0020836 0 0.248891 -0.00362369 0 0.266487 0.00045802 0 0.0665816 -0.000166389 0 + 0.220245 0.00270352 0 0.143196 -0.000923964 0 0.223001 -0.00990868 0 0.241929 0.00354351 0 + 0.268761 -0.000586891 0 0.21981 -0.00196996 0 0.259206 0.00107659 0 0.236308 0.0035557 0 + 0.247664 0.00262814 0 0.25273 0.00359459 0 0.257057 0.00391895 0 0.281559 -0.00174331 0 + 0.268459 0.000341848 0 0.245117 -0.00338997 0 0.139122 0.000589817 0 0.248441 0.00259308 0 + 0.26377 0.000385231 0 0.263205 0.000511977 0 0.256017 -0.00797011 0 0.263558 -0.00282591 0 + 0.260149 -0.00492521 0 0.216654 0.00363321 0 0.22464 0.00290313 0 0.113707 0.000701314 0 + 0.241672 -0.00330609 0 0.237849 -0.0234532 0 0.266022 -0.000422537 0 0.120139 -0.000617019 0 + 0.262253 -0.00300056 0 0.197734 0.00167689 0 0.118878 -0.000405437 0 0.127739 -0.000641081 0 + 0.254927 0.00450396 0 0.256019 0.00345734 0 0.189928 0.00158289 0 0.120445 0.000562584 0 + 0.228815 0.00227814 0 0.274152 -0.0128453 0 0.236344 0.00166465 0 0.093733 0.000333567 0 + 0.14939 0.00100688 0 0.241772 0.00333066 0 0.280827 -0.00180972 0 0.0734812 0.00019609 0 + 0.267959 0.000448278 0 0.239039 -0.00296212 0 0.269002 -0.00124291 0 0.190265 0.00196991 0 + 0.15348 -0.00104495 0 0.281419 -0.00178568 0 0.172101 0.00121257 0 0.105583 -0.000414303 0 + 0.0915287 0.000186604 0 0.243325 0.0056368 0 0.255116 -0.00424479 0 0.194873 -0.00172342 0 + 0.151076 0.00119664 0 0.0911136 -0.000232795 0 0.202598 -0.00212286 0 0.115269 0.000555615 0 + 0.227924 -0.00265707 0 0.258163 -0.0036948 0 0.165785 0.00110002 0 0.158518 -0.0011346 0 + 0.267216 -0.00396523 0 0.189399 -0.00188347 0 0.267345 0.000833194 0 0.0628287 -0.000161483 0 + 0.131944 0.000394276 0 0.168485 -0.00130106 0 0.150902 -0.00104817 0 0.127512 -0.00084013 0 + 0.252602 -0.00417305 0 0.263764 -0.000730912 0 0.142867 -0.000892016 0 0.266989 -0.00694502 0 + 0.269305 -0.00302722 0 0.224509 -0.00119406 0 0.206945 -0.00479297 0 0.0819168 -0.000261322 0 + 0.205965 -0.00153298 0 0.214013 0.00452489 0 0.132296 0.000754547 0 0.166675 -0.00133348 0 + 0.267223 0.00109419 0 0.145517 -0.000959423 0 0.2657 -0.00303751 0 0.256636 0.00881201 0 + 0.208234 0.00185926 0 0.260758 -0.00554275 0 0.123386 0.000590817 0 0.105173 0.000430717 0 + 0.0799462 0.000222657 0 0.266619 -0.000529281 0 0.220488 0.00282992 0 0.232955 -0.00313983 0 + 0.257491 0.0040439 0 0.281123 -0.00157266 0 0.0974433 0.000368846 0 0.205955 -0.00166239 0 + 0.260896 -0.00292128 0 0.268249 -0.00286283 0 0.266925 -0.00445787 0 0.18949 0.00163539 0 + 0.25451 0.00135588 0 0.265498 -0.00329967 0 0.195397 -0.00182929 0 0.266581 -0.00277053 0 + 0.237966 -0.0032091 0 0.251785 -0.00396975 0 0.252937 0.00445773 0 0.267463 -0.00132495 0 + 0.260427 -0.00442811 0 0.21248 0.00255695 0 0.129783 0.000733701 0 0.253833 0.00304516 0 + 0.226569 0.00323763 0 0.258462 -0.000151909 0 0.17908 0.000995306 0 0.238755 -0.00354898 0 + 0.259402 -0.00517867 0 0.0783955 0.00020989 0 0.265133 -0.0030093 0 0.230763 0.00349082 0 + 0.159754 -0.000898864 0 0.244641 -0.00405406 0 0.18238 0.00122125 0 0.212862 -0.00224766 0 + 0.259926 -3.49605e-07 0 0.260851 0.00154028 0 0.239047 0.00163825 0 0.205524 -0.00237653 0 + 0.181514 -0.00165347 0 0.256459 0.000281127 0 0.154663 0.00772876 0 0.240209 0.00161967 0 + 0.255317 0.00382235 0 0.165971 -0.00125425 0 0.178434 -0.00180182 0 0.110354 0.000504708 0 + 0.261193 -0.00524173 0 0.234768 -0.00322696 0 0.259184 -0.000290248 0 0.268091 -0.00479906 0 + 0.0691919 -0.00015246 0 0.246505 -0.00371243 0 0.137631 0.000828933 0 0.224969 0.00305009 0 + 0.259852 -0.000852808 0 0.168618 0.00136003 0 0.263681 -0.000344561 0 0.255967 -0.00447723 0 + 0.0408503 -4.64585e-05 0 0.268996 -0.0027238 0 0.10842 0.000461423 0 0.244259 -0.00346008 0 + 0.261417 0.000522557 0 0.0990942 -0.000401012 0 0.142641 -0.000918588 0 0.200327 -0.00158633 0 + 0.26005 0.000411795 0 0.260675 0.00027263 0 0.253106 -0.00406626 0 0.243174 -0.00360989 0 + 0.241111 0.00134134 0 0.231618 -0.0034022 0 0.268439 -0.0050977 0 0.240094 -0.00322522 0 + 0.267061 -0.0015899 0 0.195368 -0.00200808 0 0.268328 0.000629076 0 0.260834 0.000663115 0 + 0.234043 -0.00254278 0 0.265083 -0.00439009 0 0.205938 -0.00159686 0 0.267328 -0.00537795 0 + 0.0705317 -0.000107897 0 0.277173 -0.00232519 0 0.21514 -0.00205371 0 0.268455 0.0202487 0 + 0.267277 -0.00515075 0 0.26795 -0.00507323 0 -0.00318337 0.0094426 0 0.267877 -0.00201805 0 + 0.0739186 0.000209579 0 0.226158 -0.00174719 0 0.265319 -0.00465693 0 0.267925 -0.00577595 0 + 0.229199 0.0032817 0 0.177575 0.00156549 0 0.256961 -0.000793466 0 0.0776324 0.000213851 0 + 0.276435 -0.00231236 0 0.192351 0.00155084 0 0.253158 0.00353784 0 0.116357 -0.000576808 0 + 0.196263 0.00204541 0 0.20532 -0.00206838 0 0.224861 -0.00297394 0 0.249573 -0.00379938 0 + 0.251616 0.00161522 0 0.266579 -0.00489089 0 0.260869 -0.00411487 0 0.248512 0.00191421 0 + 0.253826 -0.000719642 0 0.102039 0.000410683 0 0.268202 -0.00444175 0 0.267537 -0.00688666 0 + 0.146197 0.00102114 0 0.243642 -0.00331056 0 0.137332 -0.00082173 0 0.225196 -0.00284745 0 + 0.138047 0.000865474 0 0.267849 -0.00437542 0 0.188359 0.00181938 0 0.205932 -0.00871638 0 + 0.228437 -0.00276071 0 0.246912 0.00367221 0 0.267054 -0.00490781 0 0.29571 -0.0241355 0 + 0.221501 -0.00162575 0 0.204983 -0.0020045 0 0.221473 -0.00193814 0 0.24531 0.00629836 0 + 0.205688 0.00231601 0 0.118074 0.000575224 0 0.233515 -0.00711725 0 0.267666 0.000983827 0 + 0.227174 0.00342294 0 0.241682 0.00433133 0 0.256859 0.00401721 0 0.255547 -3.21119e-05 0 + 0.264318 -0.000460493 0 0.261865 -0.00193731 0 0.273114 0.0183965 0 0.0814458 -0.000630252 0 + 0.265137 -0.00393673 0 0.130407 -0.000671761 0 0.178878 0.00128852 0 0.245982 -0.00428598 0 + 0.268404 0.00147059 0 0.120825 0.000451105 0 0.208186 -0.00239555 0 0.231465 0.00370899 0 + 0.133002 0.000921996 0 0.238025 -0.00260249 0 0.249831 -0.00408336 0 0.200318 -0.00152637 0 + 0.233549 0.00239329 0 0.23332 -0.00297858 0 0.241782 -0.00265269 0 0.256658 0.00129954 0 + 0.216655 -0.00151397 0 0.210167 -0.00203895 0 0.200183 0.00212441 0 0.264375 0.000608759 0 + 0.268117 -0.0050137 0 0.12519 -0.000674395 0 0.201981 0.00223865 0 0.269963 -0.00108598 0 + 0.262407 -0.0056067 0 0.253457 0.000444982 0 0.266843 -0.00123461 0 0.21781 0.00290312 0 + 0.265314 -0.00285564 0 0.167408 0.00103768 0 0.207878 -0.00219719 0 0.219727 -0.00188938 0 + 0.248371 -0.00408744 0 0.180276 0.00120168 0 0.257685 0.00156673 0 0.119265 -0.000557477 0 + 0.127242 0.000697974 0 0.259014 -0.00480235 0 0.25717 0.000128112 0 0.0689617 0.000222194 0 + 0.188826 -0.00184482 0 0.196374 0.0015916 0 0.216064 -0.00229432 0 0.153653 -0.00109143 0 + 0.229492 0.00281679 0 0.0803268 -0.000244956 0 0.010757 -1.20956e-05 0 0.256313 -0.000184281 0 + 0.265188 -0.0013192 0 0.275301 -0.19408 0 0.229493 -0.0031264 0 0.211343 -0.00173285 0 + 0.263763 -0.00251332 0 0.169329 -0.00138445 0 0.257366 0.00416366 0 0.254556 0.00348313 0 + 0.202141 0.00232041 0 0.258039 0.00041591 0 0.169702 0.00106031 0 0.257387 0.00057158 0 + 0.264081 -0.00649583 0 0.244983 -0.00361984 0 0.276351 0.000641757 0 0.227931 0.0036429 0 + 0.0741711 0.0145938 0 0.229765 0.00347064 0 0.131585 0.000624425 0 0.10099 -0.00041671 0 + 0.128354 -0.00071639 0 0.256962 -0.00473774 0 0.228069 -0.00264274 0 0.154556 0.000847896 0 + 0.252945 0.00263584 0 0.25752 -0.00261059 0 0.244099 -0.00377868 0 0.238034 -0.00437141 0 + 0.28246 -0.0199382 0 0.190421 0.0015279 0 0.263842 0.000736681 0 0.255789 -0.00279928 0 + 0.0649303 0.000158048 0 0.225442 0.00321196 0 0.251293 -0.00419217 0 0.233991 -0.00309977 0 + 0.263 -0.00243841 0 0.267269 -0.00280713 0 0.270465 -0.00285851 0 0.269566 -0.00132525 0 + 0.231447 -0.00321973 0 0.228674 -0.00434414 0 0.261217 -0.000670863 0 0.162273 0.00141266 0 + 0.0729761 -0.000113857 0 0.264762 -0.00160582 0 0.135856 0.000823569 0 0.260495 -0.000545558 0 + 0.236845 -0.0122616 0 0.15426 0.00120327 0 0.270393 0.0160472 0 0.136431 0.000570953 0 + 0.263441 0.00117105 0 0.194426 0.00206109 0 0.252931 -0.00279413 0 0.257125 0.0138461 0 + 0.25355 -0.00439842 0 0.245581 -0.0146637 0 0.180365 0.00135758 0 0.217158 0.00265114 0 + 0.169614 -0.00139904 0 0.204001 -0.0016158 0 0.100086 -0.0276874 0 0.0942735 0.000247247 0 + 0.248161 -0.00370811 0 0.214732 -0.00160853 0 0.266727 -0.00589191 0 0.252986 0.00582159 0 + 0.194322 0.00118921 0 0.184062 -0.0017132 0 0.182222 -0.00119956 0 0.206411 -0.00129548 0 + 0.215989 -0.00264134 0 0.197801 -0.00207746 0 0.220863 0.0029675 0 0.302372 0.194113 0 + 0.0769412 0.000195178 0 0.146758 0.0009661 0 0.167684 -0.0168713 0 0.301481 0.0213121 0 + 0.260527 -0.00589349 0 0.211265 0.00262661 0 0.176918 0.000980883 0 0.20205 0.00164438 0 + 0.269412 -0.00100062 0 0.268785 0.000550931 0 0.221916 -0.00219108 0 0.243401 -0.0024624 0 + 0.222469 0.00524137 0 0.198724 -0.00126054 0 0.247679 0.00713813 0 0.242631 0.00352791 0 + 0.24517 0.00224973 0 0.252402 0.000112819 0 0.107381 0.000358693 0 0.256131 -0.00200926 0 + 0.198907 -0.00120932 0 0.133542 0.000862104 0 0.255836 0.00528773 0 0.250378 -0.000615205 0 + 0.247525 -0.00456187 0 0.215765 0.00262091 0 0.157029 0.00087025 0 0.244988 0.0118244 0 + 0.162146 -0.00143214 0 0.218351 0.00305447 0 0.233361 -0.00195074 0 0.209577 -0.00148804 0 + 0.237495 -0.001984 0 0.219736 -0.00165974 0 0.238707 -0.00334679 0 0.18089 -0.00099647 0 + 0.171009 0.000898554 0 0.260041 -0.00510331 0 0.155505 -0.0176648 0 0.0917979 0.000283884 0 + 0.23352 -0.00245305 0 0.260616 -0.000975437 0 0.264509 -0.00122081 0 0.262135 0.000758726 0 + 0.154031 0.00108671 0 0.194461 -0.0014517 0 0.351274 -0.027963 0 0.156605 0.00113216 0 + 0.254203 0.000276377 0 0.250214 0.00063249 0 0.198785 -0.00294178 0 0.0965161 0.000288225 0 + 0.160035 0.000788385 0 0.25555 0.00622109 0 0.263805 -0.00603599 0 0.0876682 -0.000289726 0 + 0.262419 -0.00486759 0 0.247374 -0.00389083 0 0.255525 -0.0172476 0 0.255159 0.0018201 0 + 0.264415 -0.00517525 0 0.127988 -0.000700127 0 0.221384 0.00312218 0 0.184728 0.00107981 0 + 0.204238 -0.00137143 0 0.262312 -0.00597618 0 0.263181 -0.00289401 0 0.214801 -0.00154006 0 + 0.255209 0.000581901 0 0.258461 -0.00270434 0 0.153852 -0.00109639 0 0.253931 0.00153199 0 + 0.246789 -0.00397656 0 0.266019 -0.00592015 0 0.268816 -0.00182637 0 0.254531 0.000751854 0 + 0.253215 -5.61139e-05 0 0.214734 -0.00182532 0 0.237151 0.00236569 0 0.270248 -0.00172078 0 + 0.226074 0.00339638 0 0.229828 -0.00247326 0 0.258112 -0.00503456 0 0.255489 -0.00668924 0 + 0.186771 0.00142951 0 0.213312 -0.00232299 0 0.250331 0.00818952 0 0.248994 0.000279018 0 + 0.209681 -0.00142531 0 0.254718 -0.000868308 0 0.151126 0.000694898 0 0.237835 -0.00367862 0 + 0.254917 -0.00451626 0 0.129203 -0.000709412 0 0.129389 0.000504324 0 0.18209 -0.00124601 0 + 0.268127 -0.00537687 0 0.257787 -0.000928126 0 0.267229 -0.00716592 0 0.26159 0.000894349 0 + 0.205861 0.00240322 0 0.134249 -0.000798513 0 0.258266 -0.00308256 0 0.211874 -0.00202175 0 + 0.112085 0.000521395 0 0.150768 -0.00101802 0 0.183656 0.00149993 0 0.204001 -0.00155221 0 + 0.0534735 -0.0499218 0 0.188504 -0.0015667 0 0.224175 0.00354372 0 0.257055 0.00294658 0 + 0.250935 -0.00276777 0 0.110431 -0.000509838 0 0.230552 -0.00268199 0 0.257691 -0.000463179 0 + 0.113463 0.000392415 0 0.217294 -0.00219195 0 0.230498 0.00368924 0 0.140535 0.000880332 0 + 0.230539 -0.00309528 0 0.185701 0.00152984 0 0.219631 -0.00261627 0 0.270504 -0.00282767 0 + 0.270619 -0.00148015 0 0.261328 0.00139335 0 0.25731 0.010004 0 0.237331 -0.00307886 0 + 0.14273 -0.000903813 0 0.228953 0.00388711 0 0.228699 -0.00479336 0 0.235621 -0.00260347 0 + 0.25465 -0.00465278 0 0.188423 -0.00132299 0 0.261832 -0.00496313 0 0.26685 -0.00420606 0 + 0.267053 -0.0063816 0 0.267785 -0.00623077 0 0.256046 -0.00478476 0 0.0968518 -0.000360433 0 + 0.146853 -0.000638339 0 0.102598 -0.000296042 0 0.262766 -0.00549743 0 0.235897 -0.00356559 0 + 0.0737631 -0.000207298 0 0.247749 0.0035389 0 0.0913904 -0.000334055 0 0.234423 -0.00378469 0 + 0.262632 -0.00410842 0 0.181673 0.00126771 0 0.220017 0.0149037 0 0.212762 0.00266709 0 + 0.184006 0.00173297 0 0.240534 -0.00365156 0 0.25105 0.00181459 0 0.242436 -0.00367678 0 + 0.249848 9.64189e-05 0 0.22917 -0.00166893 0 0.0937692 -0.000248174 0 0.222118 0.00299786 0 + 0.222619 0.00315518 0 0.133944 -0.000789442 0 0.21469 -0.00167859 0 0.222072 0.00330524 0 + 0.221804 -0.00271939 0 0.259438 -0.00537846 0 0.231569 -0.00290212 0 0.23772 -0.00171904 0 + 0.020915 -1.22457e-05 0 0.246209 0.00461341 0 0.137083 -0.000834134 0 0.207313 0.00235506 0 + 0.0941581 0.000432371 0 0.118301 0.000575564 0 0.246719 -0.000531838 0 0.246387 -0.00417952 0 + 0.0672695 -0.000132214 0 0.204228 0.00285211 0 0.2664 0.0153357 0 0.153731 -0.00109495 0 + 0.230017 0.00227444 0 0.0877886 0.000235146 0 0.259453 0.0101707 0 0.198311 -0.00148205 0 + 0.0997144 0.000305827 0 0.165871 -0.00120187 0 0.223142 -0.0030216 0 0.242264 -0.0088622 0 + 0.263953 0.00138031 0 0.232726 0.00226763 0 0.261232 -0.00544924 0 0.251 0.000447898 0 + 0.2841 0.0278415 0 0.254663 -0.000363852 0 0.259991 -0.00287358 0 0.177629 0.00137058 0 + 0.266103 -0.00526262 0 0.0884086 -0.000315166 0 0.226873 0.00361674 0 0.239438 0.00228854 0 + 0.126683 0.000685256 0 0.226467 -0.00503015 0 0.249523 -0.00430915 0 0.175706 -0.00112518 0 + 0.083694 -0.000666218 0 0.258908 0.000688203 0 0.19289 0.00149226 0 0.0353092 3.92137e-06 0 + 0.38797 -0.103296 0 0.20574 -0.00315783 0 0.166933 0.00379564 0 0.258466 -0.000600513 0 + 0.26364 -0.00724362 0 0.253916 0.00301164 0 0.234898 -0.00190543 0 0.251546 0.00342329 0 + 0.154052 0.00125695 0 0.252423 0.00206904 0 0.263985 -0.00590017 0 0.206238 -0.00219758 0 + 0.256158 0.00717213 0 0.252172 0.0007798 0 0.245308 0.000460147 0 0.162152 -0.000936938 0 + 0.26814 -0.0052047 0 0.26806 -0.00527625 0 0.261493 -0.00151475 0 0.235677 -0.00300258 0 + 0.243187 -0.00271092 0 0.23066 -0.00178226 0 0.251464 0.000963855 0 0.0691674 -0.0167022 0 + 0.123795 0.000642146 0 0.198205 0.00161067 0 0.153634 -0.00126168 0 0.266231 -0.00794179 0 + 0.191438 -0.00272869 0 0.135059 0.000816426 0 0.268039 -0.00537643 0 0.24671 0.000846934 0 + 0.0919515 -0.000343765 0 0.246909 -0.00341162 0 0.22623 -0.0016726 0 0.216444 0.00286609 0 + 0.12371 0.000470197 0 0.105015 -0.000421744 0 0.237731 0.00467972 0 0.234873 0.00466017 0 + 0.264417 -0.0043122 0 0.200236 0.00219467 0 0.270773 -0.00178814 0 0.185774 -0.00295807 0 + 0.269299 -0.00792387 0 0.270473 0.0170402 0 0.268058 -0.00594016 0 0.218008 -0.00235835 0 + 0.233481 0.00426899 0 0.121254 0.000608061 0 0.194509 -0.00139698 0 0.177628 -0.00275579 0 + 0.250372 -0.00398703 0 0.167881 -0.0267791 0 0.105058 0.000436815 0 0.137248 -0.000821119 0 + 0.189435 -0.00174889 0 0.205626 0.00223524 0 0.11626 -0.000558107 0 0.258303 0.000838826 0 + 0.111688 0.000492927 0 0.242367 -0.0034535 0 0.210809 0.00242287 0 0.223279 0.00334023 0 + 0.249246 -0.00206456 0 0.15761 0.000771169 0 0.249629 0.00245614 0 0.269953 -0.00279792 0 + 0.134398 -0.000787792 0 0.246695 0.00552783 0 0.248558 0.00846082 0 0.0773274 -0.000231241 0 + 0.251046 0.00347162 0 0.143354 0.000968872 0 0.23926 0.00512971 0 0.263521 0.00147783 0 + 0.209462 -0.001686 0 0.161689 -0.00123737 0 0.145911 0.000661334 0 0.266304 -0.00434027 0 + 0.236099 0.00237944 0 0.200142 -0.00174235 0 0.255491 -0.000516402 0 0.233862 0.00225816 0 + 0.248937 -0.00388815 0 0.187381 0.00137797 0 0.235658 -0.00336245 0 0.242519 0.00331367 0 + 0.255913 -0.00494458 0 0.121504 0.000624442 0 0.258205 0.00140297 0 0.248354 -0.00503241 0 + 0.125451 -0.000682367 0 0.247936 0.00213669 0 0.239141 -0.00387365 0 0.269791 -0.00252165 0 + 0.257343 -0.00509374 0 0.153419 -0.00106019 0 0.186302 -0.00128128 0 0.152166 -0.00109004 0 + 0.258287 -0.00781254 0 0.244887 0.00559726 0 0.169082 -0.00255762 0 0.255675 -0.00150682 0 + 0.246219 0.000257126 0 0.177 -0.0015551 0 0.218998 -0.00252811 0 0.271138 -0.00155189 0 + 0.176806 -0.00093201 0 0.236999 -0.00325956 0 0.219984 0.00345265 0 0.00722773 0.0053207 0 + 0.102274 -0.000396292 0 0.250727 0.0127159 0 0.255978 0.0133903 0 0.259312 0.00286161 0 + 0.166914 -0.00134622 0 0.263797 -0.00564758 0 0.251793 0.00567416 0 0.175705 0.0014922 0 + 0.08209 0.000226795 0 0.268632 -0.00427722 0 0.203928 -0.00224175 0 0.254519 0.00605669 0 + 0.166265 0.000868085 0 0.263079 0.00185383 0 0.0994639 0.000363575 0 0.188148 0.0171586 0 + 0.222973 0.00350631 0 0.262606 -0.00585444 0 0.191552 0.00141555 0 0.25084 -0.00456421 0 + 0.255669 0.00591886 0 -0.000369231 0.00827323 0 0.0926069 0.000322356 0 0.260959 -0.00578637 0 + 0.217 0.00301571 0 0.201927 0.00216478 0 0.256729 -0.00729489 0 0.241295 0.00067768 0 + 0.24068 -0.00410814 0 0.26297 -0.0116353 0 0.255948 0.00542241 0 0.254934 0.00490583 0 + 0.248891 0.000993634 0 0.256224 0.000874731 0 0.112106 0.000424834 0 0.128337 0.00055618 0 + 0.18466 0.00467073 0 0.138761 0.00070778 0 0.242358 0.00370312 0 0.255334 -0.00676649 0 + 0.174375 -0.00149859 0 0.185733 -0.0138515 0 0.169061 -0.00145587 0 0.246138 0.00484952 0 + 0.27202 -0.00274793 0 0.257363 -0.00528632 0 0.237015 -0.00080485 0 0.256923 0.00762301 0 + 0.252362 -0.00442189 0 0.247539 0.000642551 0 0.184171 0.00195935 0 0.210978 0.00252019 0 + 0.221714 -0.00148822 0 0.269354 -0.00761504 0 0.248156 0.00120062 0 0.235164 0.00270118 0 + 0.151673 0.00115348 0 0.0368208 -4.93509e-05 0 0.251317 -0.000786515 0 0.249374 -0.00472315 0 + 0.221161 -0.00280113 0 0.259019 -0.00569606 0 0.261746 -0.00419629 0 0.245327 -0.00430804 0 + 0.215581 0.0214268 0 0.0825249 0.000210505 0 0.185897 -0.00407552 0 0.224706 -0.00155754 0 + 0.111374 -0.000514019 0 0.150936 -0.0010501 0 0.134414 -0.000792524 0 0.227916 0.00386686 0 + 0.266633 0.0436116 0 0.00923648 9.83336e-05 0 0.233662 -0.00351426 0 0.237024 0.00467732 0 + 0.226131 -0.00258865 0 0.10664 -0.000465152 0 0.182997 -0.00102947 0 0.245826 -0.00379017 0 + 0.255596 0.00103861 0 0.250084 0.00568355 0 0.240763 -0.00336659 0 0.0903722 0.000228139 0 + 0.213779 -0.00255932 0 0.233399 -0.00186261 0 0.271635 -0.00885924 0 0.136134 0.000970853 0 + 0.247666 -0.0024308 0 0.252346 -0.00486435 0 0.246572 0.00284492 0 0.0226975 0.00101085 0 + 0.110453 -0.000353288 0 0.260544 0.0101758 0 0.232254 -0.00275025 0 -0.000629972 0.0011179 0 + 0.251368 -0.000245143 0 0.235094 -0.01288 0 0.185047 -0.00189289 0 0.364149 0.10331 0 + 0.254815 0.00591776 0 0.277038 0.00058925 0 0.265032 -0.0060725 0 0.17707 0.00140705 0 + 0.203787 0.00165928 0 0.274257 -0.0100062 0 0.255725 0.00613386 0 0.255689 0.00164812 0 + 0.190044 -0.00193067 0 0.256736 0.00748496 0 0.245886 -0.00473334 0 0.247777 -0.00442682 0 + 0.214735 -0.00276421 0 0.208426 -0.0022654 0 0.19245 -0.00135431 0 0.226541 0.00416009 0 + 0.229107 -0.00174197 0 0.136641 0.000912704 0 0.25883 -0.00545744 0 0.239733 0.000222245 0 + 0.139084 -0.025696 0 0.25345 0.00617896 0 0.103009 0.000403549 0 0.100759 -0.000394554 0 + 0.135754 0.00106901 0 0.212319 0.00245563 0 0.232611 0.00425839 0 0.0868142 0.00025129 0 + 0.25359 -0.0046841 0 0.268066 -0.0061946 0 0.106714 -0.00044538 0 0.24535 0.00124739 0 + 0.247904 -0.00418571 0 0.26733 -0.0042705 0 0.244784 -0.00262545 0 0.262691 -0.00627522 0 + 0.0720365 -0.000185287 0 0.238927 -0.00202738 0 0.109301 0.000483855 0 0.20003 -0.00240164 0 + 0.32926 -0.0761142 0 0.236557 0.00514136 0 0.286742 0.102897 0 0.251224 0.0152173 0 + 0.366229 -0.00236516 0 0.269927 -0.00790901 0 0.221412 -0.00177802 0 0.224598 -0.00163274 0 + 0.0821181 -0.000277478 0 0.250712 -0.00566752 0 0.241103 0.00569766 0 0.216991 -0.00245742 0 + 0.102647 -0.0235557 0 0.185242 0.0015758 0 0.118286 0.000629444 0 0.247741 -0.000707038 0 + 0.21651 -0.0016512 0 0.313387 0.17673 0 0.020381 -0.000198388 0 0.207068 -0.00206384 0 + 0.102989 0.000363956 0 0.236909 0.00094123 0 0.138469 0.000900728 0 0.261625 0.0124581 0 + 0.267563 -0.0075192 0 0.240821 -2.37596e-06 0 0.225781 -0.00333035 0 0.21604 0.00273712 0 + 0.268775 0.0153247 0 0.246864 0.00343431 0 0.242597 0.0163919 0 0.241517 -0.000896365 0 + 0.149231 -0.000665625 0 0.144156 -0.000951907 0 0.244587 0.00147362 0 0.255589 0.00498112 0 + 0.174366 0.00110066 0 0.251702 -0.0101737 0 0.222179 -0.00227962 0 0.249127 -0.00694034 0 + 0.252253 -0.000411959 0 0.253346 0.00107919 0 0.221442 -0.00170184 0 0.085651 0.000254101 0 + 0.211265 -0.180711 0 0.242272 0.000451241 0 0.127017 -0.000458124 0 0.206164 0.00250141 0 + 0.250869 -0.00430097 0 0.262728 -0.0013099 0 0.234052 0.00464924 0 0.254998 -0.00498844 0 + 0.159755 0.00135612 0 0.213192 0.00279243 0 0.238612 0.00513425 0 0.244588 0.00393163 0 + 0.119315 -0.000587808 0 0.211411 -0.00152844 0 0.265974 -0.00691957 0 0.261248 -0.00753487 0 + 0.147865 0.000759389 0 0.169083 0.00134611 0 0.0763144 -0.000218667 0 0.211702 0.00274888 0 + 0.24166 -0.00382949 0 0.23179 -0.000642874 0 0.253377 0.00583542 0 0.241908 0.021912 0 + 0.243792 0.000870726 0 0.231558 -0.00384774 0 0.264927 -0.00760383 0 0.230543 0.00322212 0 + 0.197622 0.00293126 0 0.236672 -0.00351103 0 0.137454 -0.00083 0 0.202114 -0.013382 0 + 0.216567 -0.00158177 0 0.26734 -0.00603416 0 0.0843987 -0.000250598 0 0.264148 0.0131508 0 + 0.105768 0.00046097 0 0.169955 0.0016408 0 0.277003 -0.0112593 0 0.22749 -0.00255606 0 + 0.174867 0.00174031 0 0.161415 -0.00129116 0 0.212483 -0.00217282 0 0.235894 -0.00460931 0 + 0.126271 0.0130681 0 0.255482 0.00607423 0 0.206127 -0.00141099 0 0.268118 -0.00516367 0 + 0.253756 0.00570953 0 0.242923 0.0010968 0 0.247813 -0.000104946 0 0.249495 -0.00502441 0 + 0.19481 -0.00196307 0 0.207485 0.00244593 0 0.0930355 -0.000335375 0 0.260935 -0.00818058 0 + 0.196326 0.0019854 0 0.22399 -0.00286741 0 0.182214 0.00200598 0 0.194608 0.0018896 0 + 0.0992057 0.000917201 0 0.0639861 -0.000147517 0 0.249179 -0.00442598 0 0.211501 -0.00146368 0 + 0.145454 -0.000957921 0 0.21742 0.00277115 0 0.210691 -0.000922509 0 0.235096 0.000450608 0 + 0.258825 -0.00661702 0 0.235552 0.0029943 0 0.252062 -0.00454859 0 0.252711 0.00126295 0 + 0.267757 -0.00736209 0 0.117712 0.000670674 0 0.155146 -0.00114749 0 0.270044 -0.00858223 0 + 0.162563 0.000993033 0 0.279912 -0.0158566 0 0.248747 -0.000279475 0 0.0772258 0.000207751 0 + 0.200344 0.00199127 0 0.136547 0.00147183 0 0.257158 -0.00127322 0 0.200664 -0.00129747 0 + 0.173576 0.00113941 0 0.109112 0.00157617 0 0.248197 0.00520614 0 0.255781 0.00602521 0 + 0.379914 -0.00729017 0 0.226178 -0.000508971 0 0.210542 0.00322132 0 0.254771 0.00623912 0 + 0.272008 -0.00880701 0 0.191524 0.00236799 0 0.0458322 -7.24393e-05 0 0.213923 -0.00298625 0 + 0.259324 -0.00770413 0 0.220361 -0.00222056 0 0.236111 -0.00404336 0 0.161996 0.000910293 0 + 0.229043 -0.0018264 0 0.251944 0.00589114 0 0.0260627 0.00229303 0 0.268313 -0.00620515 0 + 0.211755 -0.00233046 0 0.240943 0.00290638 0 0.228177 0.00459551 0 0.257836 -0.0072124 0 + 0.188258 0.0018652 0 0.163453 0.000963197 0 -0.000388529 0.00154542 0 0.117141 0.000745458 0 + 0.252942 0.0018796 0 0.390375 -0.0943003 0 0.250267 0.00132946 0 0.247471 0.00340152 0 + 0.219839 0.00369546 0 0.260783 -0.00365373 0 0.238582 0.00575864 0 0.269509 -0.00420704 0 + 0.250639 -0.00470666 0 0.190338 0.0211276 0 0.265449 -0.00746532 0 0.196902 0.00152821 0 + 0.243307 0.00642015 0 0.235017 -0.00173653 0 0.171976 -0.0015274 0 0.107837 -0.000335543 0 + 0.224523 -0.00170495 0 0.19321 -0.00219747 0 0.256766 -0.0055852 0 0.0411354 1.51546e-05 0 + 0.179566 0.00124584 0 0.195804 0.00246395 0 0.233538 -0.00169978 0 0.175064 0.0015431 0 + 0.145515 -0.000955763 0 0.239114 -0.00175678 0 0.260902 -0.00619176 0 0.263659 -0.00181626 0 + 0.244296 0.00420173 0 0.256601 -0.00163224 0 0.248729 -0.00146617 0 0.236602 -0.00392919 0 + 0.0901258 0.000310343 0 0.219811 -0.00158814 0 0.230757 0.00461551 0 0.105639 0.00306299 0 + 0.237946 0.00069186 0 0.24055 -0.015173 0 0.256006 -0.00566769 0 0.236288 0.000193781 0 + 0.0657615 -0.000876996 0 0.235346 0.0050233 0 0.23227 0.00738348 0 0.137213 -0.000828637 0 + 0.251128 0.00588707 0 0.232091 0.00124353 0 0.258431 -0.00578993 0 0.225497 0.00385795 0 + 0.26606 -0.0974711 0 0.262075 -0.00742123 0 0.141449 0.00073346 0 0.194397 0.00199987 0 + 0.202465 0.00279883 0 0.215039 -0.00141115 0 0.2496 0.00152935 0 0.105028 -0.000446484 0 + 0.0217017 6.61307e-05 0 0.239704 0.00113097 0 0.238785 0.00138882 0 0.252175 -0.012947 0 + 0.269517 -0.00276566 0 0.183185 0.00154204 0 0.256488 -0.00670904 0 0.222084 -0.0029041 0 + 0.1197 0.000494508 0 0.265901 -0.0056561 0 0.238356 -0.00420976 0 0.251177 -0.00508252 0 + 0.20098 -0.00211507 0 0.172987 -0.00161069 0 0.272552 -0.00915096 0 0.250164 0.0022464 0 + 0.240531 0.0057178 0 0.230003 0.000710464 0 0.248813 -0.00804623 0 0.105037 0.000481578 0 + 0.264389 -0.00190479 0 0.263015 -0.0137832 0 0.187879 -0.00198654 0 0.25628 -0.0011416 0 + 0.259767 0.0188229 0 0.245167 -0.00396622 0 0.0755126 0.000203251 0 0.263577 -0.00158131 0 + 0.243796 -0.000608182 0 0.215227 0.00648203 0 0.225719 -0.00249114 0 0.260516 -0.00632978 0 + 0.171385 0.0013892 0 0.269264 -0.00247052 0 0.2358 0.00514327 0 0.202775 -0.00251618 0 + 0.239839 -0.0037166 0 0.221269 -0.00951827 0 0.222158 -0.00333702 0 0.253429 -0.00483468 0 + 0.238345 -0.00102207 0 0.262266 -0.00161771 0 0.194469 0.00194411 0 0.17532 -0.00135486 0 + 0.211788 -0.00683068 0 0.271186 -0.00842444 0 0.274357 -0.00989957 0 0.268824 -0.00763554 0 + 0.220938 -0.00292254 0 0.111168 -0.00649179 0 0.262458 -0.00642259 0 0.265408 -0.00237543 0 + 0.210479 -0.00211233 0 0.110428 -0.000368809 0 0.172806 -0.00279842 0 0.239445 0.00366772 0 + 0.147777 0.00194451 0 0.168395 -0.0011912 0 0.231694 0.00462911 0 0.265405 0.0449249 0 + 0.189224 -0.00108692 0 0.288382 0.0223833 0 0.219804 0.00451331 0 0.19873 0.00154465 0 + 0.174467 -0.00414841 0 0.242686 -0.000408426 0 0.26502 -0.00484533 0 0.268019 -0.00763342 0 + 0.181666 -0.00838495 0 0.257819 -0.00223176 0 0.227996 -0.00319496 0 0.217624 -0.00227512 0 + 0.230186 0.00422644 0 0.127274 0.000782515 0 0.214015 0.00329858 0 0.187214 -0.00215348 0 + 0.151525 -0.00247146 0 0.20536 -0.00384714 0 0.0897475 0.00032705 0 0.256539 -0.00979317 0 + 0.0980979 0.000477766 0 0.227858 -0.00289786 0 0.293192 -0.00848624 0 0.10476 -0.00310857 0 + 0.226804 0.00161602 0 0.261986 -0.00120165 0 0.221025 -0.00239676 0 0.168353 -0.00124735 0 + 0.167937 -0.00084282 0 0.080132 0.000232004 0 0.134425 -0.000529481 0 0.13695 -0.000829472 0 + 0.240994 0.00655478 0 0.230158 0.00516478 0 0.131953 -0.000505844 0 0.26381 -0.00486734 0 + 0.159127 -0.00119697 0 0.234424 0.00300356 0 0.147666 -0.00101681 0 0.207284 0.00218745 0 + 0.0676524 -0.0142186 0 0.238718 0.00255965 0 0.246943 0.00160987 0 0.23125 0.000424103 0 + 0.143871 0.00155881 0 0.267723 -0.00494888 0 0.22974 -0.00297896 0 0.242727 -0.00108955 0 + 0.254062 -0.00522614 0 0.264669 -0.00687226 0 0.229197 0.00420308 0 0.0876871 -0.000295271 0 + 0.233209 0.000963371 0 0.26073 -0.00699808 0 0.225428 0.00413354 0 0.132052 0.000743318 0 + 0.184437 0.00206672 0 0.280848 -0.0134279 0 0.201078 -0.00188965 0 0.168895 0.00109483 0 + 0.151014 -0.00105128 0 0.0938402 0.00107434 0 0.198485 -0.00213023 0 0.246254 0.00183039 0 + 0.114984 0.000584789 0 0.269636 -0.00757063 0 0.147715 0.00296522 0 0.245887 0.00734655 0 + 0.235223 0.00145523 0 0.160168 0.000968032 0 0.0426549 0.000258952 0 0.237821 -0.00339885 0 + 0.132782 0.000611855 0 0.236482 0.00216805 0 0.0138296 -0.00246333 0 0.263288 -0.00212051 0 + 0.234263 0.00173748 0 0.224457 -0.00624248 0 0.190253 0.00191378 0 0.184227 0.00169442 0 + 0.2607 -0.0110206 0 0.148373 0.00082369 0 0.156042 -0.00125126 0 0.217385 0.037172 0 + 0.145847 -0.000907782 0 0.242824 0.00646488 0 0.0646566 -0.0142838 0 0.25426 0.00214381 0 + 0.156532 -0.000724779 0 0.0671445 -0.000155038 0 0.264055 -0.00220805 0 0.247118 0.00261243 0 + 0.237901 0.00577927 0 0.270895 -0.00848213 0 0.254183 -0.00545582 0 0.227118 0.00458074 0 + 0.25411 -0.00623174 0 0.118126 -0.000716791 0 0.259841 -0.00708952 0 -0.0130209 0.00180736 0 + 0.181893 0.00168344 0 0.183884 0.00177443 0 0.103343 0.000514152 0 0.238269 -0.000258426 0 + 0.116382 0.000562791 0 0.274263 -0.0102503 0 0.19893 -0.00183333 0 0.12815 0.000725688 0 + 0.266099 -0.00713191 0 0.207467 -0.00232782 0 0.270324 -0.00851585 0 0.21343 0.00395715 0 + 0.273685 0.0339937 0 0.157257 0.00244648 0 0.267775 -0.00528194 0 0.209728 -0.00240256 0 + 0.240307 -0.00479909 0 0.224379 0.00103007 0 0.125417 -0.000731213 0 0.22322 -0.00276746 0 + 0.243463 -0.00385394 0 0.2293 -0.00159158 0 0.27103 -0.00825099 0 0.245316 -0.00209799 0 + 0.239563 -0.00349292 0 0.223989 -0.00360808 0 0.167113 0.00306438 0 0.150035 0.00100559 0 + 0.351142 -0.0254932 0 0.258225 -0.00186429 0 0.24366 0.00755033 0 0.130244 -0.00143289 0 + 0.268276 -0.00524713 0 0.257303 0.00905371 0 0.209825 -0.00136611 0 0.187894 -0.00177359 0 + 0.255581 0.00508794 0 0.258792 -0.00608896 0 0.124036 0.000735274 0 0.266452 0.0148419 0 + 0.247941 -0.00492347 0 0.200839 -0.00124507 0 0.228427 -0.00673724 0 0.250136 0.00526943 0 + 0.178187 0.0100816 0 0.193044 -0.00115517 0 0.233287 -0.000950387 0 0.225729 0.0007072 0 + 0.266873 -0.00520868 0 0.241052 -0.0039069 0 0.227738 -0.000784338 0 0.114323 0.000626147 0 + 0.266912 -0.00761153 0 0.391519 0.0878798 0 0.13729 -0.00109452 0 0.252617 -0.00595356 0 + 0.249271 -0.00489665 0 0.125501 0.000534784 0 0.208866 0.0508156 0 0.241729 -0.00985638 0 + 0.283818 -0.0151645 0 0.125905 0.000690434 0 0.188346 -0.00355631 0 0.0988848 -0.000279962 0 + 0.232549 0.00591467 0 0.237322 0.00188375 0 0.23381 -0.0032685 0 0.239481 -0.000484954 0 + 0.187174 -0.00105313 0 0.211086 0.037857 0 0.226197 -0.00397372 0 0.219931 -0.000317014 0 + 0.244028 -0.00194093 0 0.256607 -0.0053518 0 0.266433 -0.0085711 0 0.25381 0.0023405 0 + 0.201965 0.00209386 0 0.213556 0.00532654 0 0.156059 0.000896397 0 0.126634 0.000845378 0 + 0.223097 0.00454875 0 0.0948436 -0.00036453 0 0.236949 0.00335226 0 0.0877248 -0.000277289 0 + 0.242924 -0.00403349 0 0.121149 -0.000609368 0 0.272108 -0.00872825 0 0.215195 -0.00255785 0 + 0.232715 0.00396688 0 0.268373 -0.00502454 0 0.256399 0.00951496 0 0.270277 -0.00787176 0 + 0.22097 0.00203518 0 0.273249 -0.00942008 0 0.230338 0.00181801 0 0.264784 -0.00845073 0 + 0.126349 0.00469574 0 0.238247 0.00560849 0 0.252934 -0.00711088 0 0.227987 0.0012905 0 + 0.293005 0.0187548 0 0.266088 -0.00243584 0 0.135102 -0.000773626 0 0.212992 -8.66035e-05 0 + 0.101231 0.000339041 0 0.192877 -0.00785267 0 0.140993 0.000675385 0 0.138058 -0.000930201 0 + 0.110395 -0.000570942 0 0.221125 0.00373258 0 0.228624 -0.00518007 0 0.250384 -0.00568529 0 + 0.241513 0.00154373 0 0.0730283 0.000160731 0 0.279035 -0.0126352 0 0.21969 -0.00732126 0 + 0.203885 -0.00236838 0 0.189746 -0.0376266 0 0.26594 -0.00275967 0 0.268382 -0.00791996 0 + 0.0355704 0.0551313 0 0.267505 -0.00513158 0 0.246476 0.00437735 0 0.254992 -0.00517502 0 + 0.25861 -0.0104076 0 0.150761 0.00378771 0 0.272921 -0.00959659 0 0.229316 0.0021368 0 + 0.286286 -0.0171104 0 0.183704 -0.00252024 0 0.215393 -0.00213315 0 0.176979 0.00380299 0 + 0.113174 0.000521759 0 0.254308 0.0028786 0 0.205743 -0.00602642 0 0.254298 -0.0126009 0 + 0.261963 -0.010792 0 0.0998421 0.000343233 0 0.264342 -0.0103929 0 0.374085 0.00373514 0 + 0.286095 -0.00123406 0 0.265223 -0.00269359 0 0.247252 0.00371265 0 0.200877 -0.00337653 0 + 0.226008 -0.00295296 0 0.258739 -0.00233094 0 0.265147 -0.00552268 0 0.211332 -0.00522816 0 + 0.0648968 0.000135246 0 0.244805 -0.00144216 0 0.242747 -0.00503356 0 0.195831 -0.0366802 0 + 0.271032 -0.00836582 0 0.242399 -0.0043943 0 0.0981479 0.000363185 0 0.161895 -0.00124563 0 + 0.153571 0.000871431 0 0.244433 0.0189457 0 0.298233 -0.0815379 0 0.170549 0.00102383 0 + 0.357044 -0.0164026 0 0.168271 0.00100353 0 0.182224 -0.00150505 0 0.262888 -0.00700483 0 + 0.240403 0.00660432 0 0.161 -0.000782757 0 0.215392 0.00452863 0 0.26494 -0.00820798 0 + 0.176555 0.00112066 0 0.000218289 -0.00784008 0 0.215699 -0.00221377 0 0.273232 -0.00951648 0 + 0.0943328 -0.000365346 0 0.218165 0.00139643 0 0.227207 -0.00337992 0 0.134678 0.0353435 0 + 0.233456 -0.000137308 0 0.243122 0.00320483 0 0.164513 -0.00136109 0 0.142636 -0.000912749 0 + 0.15421 -0.000697491 0 0.240709 0.00179438 0 0.237136 -0.00374618 0 0.142148 -0.000585762 0 + 0.139729 -0.000560751 0 0.264313 -0.0083724 0 0.158577 -0.00109682 0 0.129924 0.00446853 0 + 0.248234 0.00495679 0 0.183678 0.0270481 0 0.259119 -0.00197238 0 0.108637 -0.000494388 0 + 0.209117 -0.00272423 0 0.180576 -0.00179305 0 0.214727 -0.00592703 0 0.216782 -0.00144845 0 + 0.228052 -0.0086389 0 0.0991605 0.000397659 0 0.381435 -0.00229776 0 0.244343 -0.00475136 0 + 0.268827 -0.00854971 0 0.241549 0.00263727 0 0.26266 0.0542237 0 0.245475 0.00742041 0 + 0.0852547 -0.000293226 0 0.280444 -0.013152 0 0.270576 -0.101752 0 0.35498 0.0260702 0 + 0.292009 0.193694 0 0.0709024 0.000153446 0 0.244565 0.00248798 0 0.192382 -0.00388148 0 + 0.236831 -0.00968672 0 0.279887 -0.0128854 0 0.24163 0.00785068 0 0.123351 0.000797317 0 + 0.225379 0.00988107 0 0.206744 -0.00199609 0 0.241402 -0.0196963 0 0.0525619 -0.000123788 0 + 0.108284 0.000513053 0 0.255676 0.00923977 0 0.219616 0.00103484 0 0.134251 -0.00078225 0 + 0.224064 0.00379271 0 0.222577 -0.0485524 0 0.170107 -0.00152605 0 0.248109 -0.0119048 0 + 0.253484 -0.0100376 0 0.23479 -0.000381368 0 0.235664 -0.0117064 0 0.188969 0.00216599 0 + 0.269454 -0.00852667 0 0.261056 0.00289456 0 0.258716 0.00973332 0 0.214499 0.00253853 0 + 0.218674 0.00341521 0 0.231385 0.00501035 0 0.234935 0.00585136 0 0.26409 -0.0113658 0 + 0.139206 -0.000726082 0 0.232875 -0.0117796 0 0.220943 0.00762508 0 0.177662 -0.00170254 0 + 0.201696 0.00560998 0 0.119048 -0.000597627 0 0.227365 -0.00354249 0 0.248909 0.00514288 0 + 0.233534 0.00515109 0 0.204677 -0.00193864 0 0.275844 -0.0107983 0 0.224949 0.00226374 0 + 0.206569 0.00387684 0 0.17734 -0.00216445 0 0.228023 0.000129545 0 0.225291 0.00519691 0 + 0.265596 -0.00784807 0 0.237578 0.00307228 0 0.159133 -0.00578609 0 0.229339 -0.0096572 0 + 0.252303 -0.00504476 0 0.224623 0.00423245 0 0.260795 -0.00691559 0 0.28991 -0.019841 0 + -0.0159376 0.000102151 0 0.265079 -0.0101548 0 0.170157 -0.000872836 0 0.272059 -0.0102076 0 + 0.211263 0.00183425 0 0.237672 0.00676704 0 0.0961947 -0.000549228 0 0.218277 -0.00262804 0 + 0.259972 -0.0102169 0 0.164559 -0.00142011 0 0.226827 0.00313362 0 0.229995 0.00945623 0 + 0.0289694 0.0397796 0 0.224968 0.0158414 0 0.242304 -0.123532 0 0.222227 0.00167131 0 + 0.243203 0.00764411 0 0.188667 0.00205909 0 0.239345 0.010738 0 0.0520153 -0.0127466 0 + 0.133703 0.00143873 0 0.270964 -0.00888954 0 0.171104 0.0301109 0 0.221298 0.00406199 0 + 0.223847 0.00261786 0 0.242646 0.00216038 0 0.262118 0.0121819 0 0.000122341 -0.00781554 0 + 0.260905 0.0851985 0 0.222541 0.00409022 0 0.219632 -0.00319455 0 0.232658 0.00515239 0 + 0.274169 -0.00977415 0 0.261941 0.0113652 0 0.219046 -0.0027172 0 0.234191 0.00947452 0 + -0.00974225 -0.000899362 0 0.21523 0.00359408 0 0.118686 -0.151487 0 0.156781 -0.00163025 0 + 0.229794 0.00357955 0 0.236887 -0.00572986 0 0.268021 -0.00503215 0 0.209833 0.00843794 0 + 0.13553 0.000634571 0 0.201191 0.00247398 0 0.358405 -0.0196398 0 0.264659 -0.00707772 0 + 0.131764 0.0116872 0 0.1027 -0.0279183 0 0.237901 0.00941457 0 0.244958 0.0483726 0 + 0.161798 -0.00134453 0 0.181761 0.00172284 0 0.212829 0.00142386 0 0.229871 -0.0035957 0 + 0.257975 0.00947615 0 0.215465 0.00334327 0 0.273156 -0.0101563 0 0.253328 0.0140466 0 + 0.267321 -0.0128336 0 0.193242 0.00660123 0 0.218964 0.00495371 0 0.0369597 -5.58362e-05 0 + 0.247318 0.00888424 0 0.269489 -0.0134518 0 0.366982 0.00266893 0 0.271637 0.0176124 0 + 0.286757 0.0266586 0 0.26636 -0.00510743 0 -0.0115105 -0.00281548 0 0.202628 0.00555022 0 + 0.22943 -0.000155512 0 0.103287 -0.0004338 0 0.1213 -0.000780547 0 0.222813 0.00538737 0 + 0.243622 0.00294503 0 0.262607 -0.0360656 0 0.216943 -0.00438845 0 0.118207 -0.000976481 0 + 0.208171 0.00524509 0 0.206248 -0.0226542 0 0.169507 0.00381457 0 0.106459 0.000541426 0 + 0.320887 0.038436 0 0.261633 0.0130143 0 0.252614 0.0100073 0 0.272306 -0.00965767 0 + 0.230948 -0.0107045 0 0.144715 0.0019006 0 0.221464 0.0170428 0 0.327281 0.134621 0 + 0.257347 0.0111834 0 0.127975 -0.000952713 0 0.230777 -0.00213134 0 0.249727 0.0195458 0 + 0.262542 0.0112558 0 0.230792 0.0160204 0 0.251258 -0.00531085 0 0.181974 0.00190086 0 + 0.168971 -0.00196468 0 0.253238 -0.0055292 0 0.193524 -0.00316538 0 0.179861 -0.00145499 0 + 0.235576 -0.00881837 0 0.224954 0.00755164 0 0.240549 -0.0115584 0 0.205657 0.00215694 0 + 0.230704 -0.00868962 0 0.235736 0.00582745 0 0.238383 0.0067112 0 0.259302 -0.108559 0 + 0.246112 0.0152358 0 0.229154 0.00516711 0 0.150897 -0.00104552 0 0.228077 0.0046491 0 + 0.228906 -0.00846198 0 0.227744 0.00278216 0 0.278097 -0.0121357 0 0.118387 -0.000601938 0 + 0.142739 -0.000920593 0 0.151292 -0.00159214 0 0.218991 0.0027619 0 0.0956242 0.000360939 0 + 0.261105 -0.00671878 0 0.229829 -0.00282849 0 0.230489 -0.00325591 0 0.215857 0.00212972 0 + 0.232495 -0.00335832 0 0.187073 -0.00271553 0 0.267159 -0.00789461 0 0.226429 0.00519106 0 + 0.264405 -0.013445 0 0.301736 0.025589 0 0.00276764 0.0048257 0 0.15292 -0.00117357 0 + 0.147099 -0.00108432 0 0.31742 -0.0627515 0 0.202564 0.00975489 0 0.237664 -0.0140117 0 + 0.218788 -0.00769783 0 0.232744 0.0022875 0 0.0867372 0.000279334 0 0.203587 0.00235655 0 + 0.256243 -0.00723015 0 0.28595 -0.0413167 0 0.0736997 0.0210333 0 0.154415 0.00240559 0 + 0.176039 -0.00148361 0 0.224303 0.00456412 0 0.129094 0.00143066 0 0.217834 0.00316746 0 + 0.225214 0.00382474 0 0.272166 0.0191305 0 0.221623 -0.000629831 0 0.258648 -0.00761251 0 + 0.108969 -0.0105106 0 0.34252 -0.0290551 0 0.256956 0.0118642 0 0.183824 0.007711 0 + 0.231663 0.00594594 0 0.232023 -0.00966442 0 0.140745 -0.00119678 0 0.209573 0.00298929 0 + 0.00630271 -0.00514856 0 0.293675 -0.0229018 0 0.278742 -0.0123596 0 0.203218 -0.0339801 0 + 0.177197 0.0270467 0 0.240479 -0.0138459 0 0.183421 -0.000180083 0 0.150068 -0.00136997 0 + 0.249266 0.0119039 0 0.134194 -0.00987067 0 0.257158 -0.0211329 0 0.27387 -0.0100921 0 + 0.311424 0.0188425 0 0.1972 -0.00202882 0 0.145535 -0.000953894 0 0.150663 0.00300119 0 + 0.231866 0.00260363 0 0.153512 -0.00107589 0 0.159215 -0.00154811 0 0.20257 -0.000727906 0 + 0.217126 0.00630917 0 0.0973569 0.000376971 0 0.13946 -0.00157596 0 0.275866 -0.0109398 0 + 0.243125 -0.060006 0 0.143909 -0.00101515 0 0.241059 0.00793384 0 0.20328 -0.00218331 0 + 0.279141 -0.0127972 0 0.168068 -0.0105331 0 0.2025 0.0127345 0 0.204203 -0.00362488 0 + 0.239041 0.00812527 0 0.0951265 0.000340895 0 0.041635 2.67011e-06 0 0.170663 -0.00230852 0 + 0.234542 0.00995768 0 0.228433 0.0447008 0 0.263758 -0.00751014 0 0.181853 -0.0149729 0 + 0.200033 -0.0190239 0 0.229104 -0.00191743 0 0.222079 0.000384264 0 0.224213 -0.00957385 0 + 0.244414 -0.00625085 0 0.225306 0.00838953 0 0.268552 -0.00491933 0 0.29882 0.047581 0 + 0.211922 -0.00749251 0 0.263054 -0.00680477 0 0.200226 0.00205771 0 0.238348 0.00986791 0 + 0.246016 -0.00160913 0 0.242052 0.0097482 0 0.165596 -0.00181741 0 0.264567 -0.00497177 0 + 0.235137 -0.0102995 0 0.214832 -0.000439627 0 0.200016 0.00149519 0 0.154713 0.00108746 0 + 0.279074 -0.0125665 0 0.220348 -0.00270662 0 0.0662029 -0.000220262 0 0.235871 0.011398 0 + 0.16446 0.00303558 0 0.233345 0.00362583 0 0.258191 0.00894505 0 0.268617 -0.00889608 0 + 0.1663 -0.00130186 0 0.00584217 0.00477011 0 0.288784 0.0270495 0 0.255602 -0.00609317 0 + 0.358303 0.123388 0 0.183391 -0.0244633 0 0.177912 0.00153712 0 0.233693 -0.0106729 0 + 0.212391 0.00336193 0 0.0079037 -0.00336608 0 0.22614 -0.00489448 0 0.26277 0.01165 0 + 0.224803 -0.00940748 0 0.194325 0.0111946 0 0.18537 -0.00236927 0 0.269965 -0.00890257 0 + 0.129884 0.0055488 0 0.259097 0.0131147 0 0.182834 0.0075723 0 0.263649 -0.0169357 0 + 0.0464507 9.96411e-06 0 0.0661341 1.80399e-05 0 0.212388 -0.0261227 0 0.266911 -0.00887556 0 + -0.00318464 -0.00912663 0 0.275774 -0.105111 0 0.283465 0.104048 0 0.237916 -0.0127626 0 + 0.100286 -0.000392502 0 0.239397 -0.0780915 0 0.224901 -0.00218857 0 0.381832 0.00288241 0 + 0.0782683 0.000217957 0 0.24336 -0.0149553 0 0.287875 -0.0192418 0 0.157247 0.0109463 0 + 0.0893679 5.86945e-05 0 0.263098 0.0125185 0 0.026893 -0.00353024 0 0.191033 -0.0032345 0 + 0.211892 0.0389661 0 0.257521 0.0114066 0 0.228647 0.00424048 0 0.152747 -0.00193369 0 + 0.103832 0.0116988 0 0.107912 -0.13336 0 0.208005 -0.00414349 0 0.255041 -0.0142201 0 + 0.0851278 -0.000432773 0 0.225882 -0.00309368 0 0.195045 0.00295792 0 0.153451 0.00380656 0 + 0.271371 -0.00969831 0 0.246997 0.00900885 0 0.0346829 -0.00320791 0 0.134651 -0.000861068 0 + 0.24993 0.0110698 0 0.324995 -0.0359122 0 0.266768 -0.00663872 0 0.0997863 7.64845e-05 0 + 0.0834222 6.09059e-05 0 0.209752 0.043833 0 0.148646 0.0023785 0 0.201944 0.00103467 0 + 0.0541944 -0.0126719 0 0.147742 -0.00145335 0 0.238627 -0.00396431 0 0.252508 0.0101716 0 + 0.323734 0.0358613 0 0.243341 0.00191517 0 0.223593 6.80068e-05 0 0.261986 0.0133035 0 + -0.00108133 -0.00313907 0 0.277241 -0.0114266 0 0.28847 -0.116379 0 0.199679 0.00457973 0 + 0.351122 0.0172219 0 0.310289 0.153425 0 0.100742 -0.0196277 0 0.100401 -0.000411876 0 + 0.190514 0.00181671 0 0.0763513 0.0221589 0 0.390944 -0.0844908 0 0.264767 0.0213382 0 + 0.287702 -0.017975 0 0.296704 0.0351745 0 0.282548 -0.0145581 0 0.0282844 -0.00165569 0 + 0.211151 0.00382193 0 0.193507 -0.000483109 0 0.100217 -0.00062975 0 0.205277 0.00189421 0 + 0.265502 -0.0075712 0 0.297532 -0.0262606 0 0.381036 0.010357 0 0.170587 0.0114092 0 + 0.0403006 -0.00149907 0 0.0819104 -0.00131362 0 0.312177 0.0411798 0 0.0876462 -0.00065738 0 + 0.200503 0.00617758 0 0.220874 -0.0276491 0 0.247046 0.0450787 0 0.195281 0.00232179 0 + 0.207967 0.00293914 0 0.0749666 0.000666546 0 0.157572 0.00485574 0 0.19032 -0.00183377 0 + 0.26447 0.0125335 0 0.186351 -0.00723848 0 0.215494 0.000690009 0 0.279796 -0.0160441 0 + 0.0319747 -5.68038e-06 0 0.223827 -0.00296349 0 0.208776 0.0026701 0 0.226685 -0.00418574 0 + 0.159611 0.0192721 0 0.258842 0.00916339 0 0.0164239 -0.00509408 0 0.207233 0.0140779 0 + 0.259212 -0.00872424 0 0.18526 0.0128195 0 0.207314 0.00313271 0 0.128653 -0.000718771 0 + 0.103667 -0.00795142 0 0.130427 0.0022491 0 0.213053 0.00306878 0 0.205623 0.00681461 0 + 0.172191 -0.00561306 0 0.143773 -0.00216689 0 0.358757 -0.0812225 0 0.254506 0.0145494 0 + 0.120005 -0.01363 0 0.26626 0.014194 0 0.190941 0.00200612 0 -0.000899902 0.0072551 0 + 0.218223 -0.00918647 0 0.282637 -0.019246 0 0.301445 -0.0297951 0 0.174097 -0.00201433 0 + 0.0369067 4.80805e-05 0 0.173054 -0.001344 0 0.0318223 -0.0684367 0 0.196676 -0.0019815 0 + 0.0656174 -0.00206266 0 0.0403064 -3.14316e-05 0 0.233008 0.00879521 0 0.0307018 -0.00772199 0 + 0.283529 0.0269107 0 0.214871 0.00942119 0 0.211909 0.00393084 0 0.293222 -0.0209752 0 + 0.0889965 0.0362385 0 0.199618 0.0160399 0 0.194941 0.00221661 0 0.249387 0.0164804 0 + 0.252843 0.0158362 0 0.24726 0.0158421 0 0.278813 -0.0129799 0 0.217135 0.00032969 0 + 0.24408 -0.00440238 0 0.291148 -0.0222008 0 0.188546 0.00177501 0 0.285245 -0.0163592 0 + 0.174546 0.00378785 0 0.230196 0.0261115 0 0.264101 -0.000895363 0 0.290814 0.0287325 0 + 0.255765 -0.00864342 0 0.266705 -0.00849285 0 0.320326 0.0159697 0 0.12193 -0.0011038 0 + 0.286448 -0.0189356 0 0.154091 0.0152397 0 0.0150432 -0.014391 0 0.186861 0.00466984 0 + 0.30237 0.0339153 0 0.0975314 0.00112713 0 0.193025 0.00148775 0 0.166023 0.0136264 0 + 0.188489 0.00198313 0 0.253215 0.042854 0 0.255634 -0.146169 0 0.235794 0.00612804 0 + 0.120455 0.00486212 0 0.115831 0.00163282 0 -0.00444578 0.00939029 0 0.218287 -0.0021898 0 + 0.300651 0.0347959 0 0.285178 -0.017896 0 0.263649 -0.0429516 0 0.19687 0.00243947 0 + 0.222141 0.00331395 0 0.257074 0.0120947 0 0.0268601 -0.0122548 0 0.107172 0.00964247 0 + 0.0370202 -4.9976e-05 0 0.258239 -0.00621985 0 0.185548 0.00365091 0 0.173387 0.0089368 0 + 0.290436 -0.0230953 0 0.130363 0.0229827 0 0.0363105 -0.0136019 0 0.207256 -0.000195621 0 + 0.211754 0.00662076 0 0.242469 -0.00413175 0 0.0250058 0.00702192 0 0.260216 0.018225 0 + 0.241043 -0.0105473 0 0.215628 -0.00274359 0 0.242735 0.00984732 0 0.0865945 0.00109858 0 + 0.215069 -0.00293078 0 0.27593 -0.0118394 0 0.0552007 -0.00290271 0 0.262579 -0.00964479 0 + 0.194328 -0.00191849 0 0.16288 0.00613402 0 -0.0125858 -0.00155791 0 0.268259 -0.00851791 0 + 0.0436068 -0.0696538 0 0.24563 0.00321663 0 0.236048 0.00391582 0 0.200891 0.00329662 0 + 0.200801 0.00557234 0 0.25355 -0.00583437 0 0.197717 0.00252036 0 0.154079 0.00903553 0 + 0.223441 -0.00377082 0 0.190522 0.00465154 0 0.221172 0.00370874 0 0.26322 0.0115365 0 + 0.223136 -0.00849052 0 0.254515 0.0126187 0 0.261955 0.0141572 0 0.263638 0.0121933 0 + 0.199317 0.00381556 0 0.288138 -0.0206584 0 0.204794 -0.00111965 0 0.0932446 0.000336288 0 + 0.299118 -0.0242895 0 0.191959 0.00723424 0 0.166283 -0.00325049 0 0.0325067 6.2066e-06 0 + 0.190105 0.00938736 0 0.133714 0.00293791 0 0.0701611 0.00163867 0 0.22303 -0.00192727 0 + 0.116533 -0.0210845 0 0.280629 -0.0136095 0 0.267124 0.0158453 0 0.180862 0.00259785 0 + 0.147472 0.000964388 0 0.161117 -0.00113982 0 0.186429 -0.00451596 0 0.262372 0.0135915 0 + 0.225762 -0.0111811 0 0.217771 0.0031868 0 0.254231 -0.0550216 0 0.270587 -0.00375885 0 + 0.0460534 6.15561e-05 0 0.0672103 0.00287727 0 0.205259 0.000206526 0 0.0134775 -0.00204116 0 + 0.162265 0.00120882 0 0.262221 0.0283572 0 0.191343 0.00461348 0 0.246066 -0.0045661 0 + 0.0428093 -0.00525106 0 0.284795 -0.0220972 0 0.0600092 0.000397777 0 0.213026 -0.00248094 0 + 0.223371 0.00494231 0 0.19776 0.00794023 0 0.263816 -0.00149607 0 0.293539 -0.0221272 0 + 0.260891 -0.00151689 0 0.192657 -0.00200824 0 0.212362 -0.00240564 0 0.118683 -0.0177009 0 + 0.179071 -0.00250925 0 0.287174 -0.0184773 0 0.267819 -0.00807193 0 0.283143 -0.0226001 0 + 0.350651 0.0225573 0 0.192294 -0.0272567 0 0.160268 -0.00177405 0 0.255318 0.0133182 0 + 0.294504 -0.0254703 0 0.282791 -0.0147974 0 0.0160268 -0.00238721 0 0.103415 -0.00135151 0 + 0.25388 0.0622969 0 0.223772 0.00762919 0 0.260416 0.0123579 0 0.167116 -0.00211853 0 + 0.243019 -0.0114492 0 0.288934 -0.0190378 0 0.240282 -0.00422907 0 0.21608 0.00397553 0 + 0.126803 0.0197104 0 0.216969 -0.00304813 0 0.037664 -0.00118851 0 0.112414 -0.00122374 0 + 0.261366 -0.00770714 0 0.206482 0.0904914 0 0.208376 0.0108839 0 0.246631 -0.00521091 0 + 0.200192 -0.0022703 0 0.374575 0.0357889 0 0.206813 0.0573696 0 0.190653 -0.00160958 0 + 0.214497 -0.00247865 0 0.240405 -0.0137378 0 0.220052 0.00454028 0 0.254124 -0.073455 0 + 0.218713 0.00452856 0 0.172237 0.000177344 0 0.140669 0.0102027 0 0.183109 0.00201901 0 + 0.203478 0.00266787 0 0.219118 -0.00296819 0 0.190507 0.0020387 0 0.215048 0.0044266 0 + 0.153628 -0.00108819 0 0.0914339 -0.000336495 0 -0.000278327 0.000810943 0 0.132046 -0.00125599 0 + 0.250623 -0.0148933 0 0.183438 0.00933785 0 0.186041 -0.000685741 0 0.23196 -0.0114304 0 + 0.199326 -0.00587881 0 0.175602 -0.00231623 0 0.214685 -0.00701322 0 0.258213 -0.0437613 0 + 0.150968 -0.000990728 0 0.235601 0.00426001 0 0.139322 0.000845715 0 0.011055 -0.00045993 0 + 0.193408 0.0384448 0 0.0169411 -0.0138793 0 0.23218 -0.00374064 0 0.254969 0.0362516 0 + 0.100835 0.000404007 0 0.0259384 -0.00249073 0 0.238437 0.0644672 0 0.11083 -0.0005215 0 + 0.141837 0.00295083 0 0.238511 -0.0106061 0 0.232172 -0.0426255 0 0.182438 0.00840788 0 + 0.202708 -0.00212578 0 0.274406 0.0249802 0 0.161903 -0.0021165 0 0.207453 -0.0317894 0 + 0.247114 -0.0411819 0 0.0114195 -0.00151232 0 0.263446 -0.0327934 0 0.217802 0.00582034 0 + 0.386943 -0.015752 0 0.293985 -0.0251512 0 0.10041 0.0303081 0 0.254178 0.0170297 0 + 0.245224 0.00346464 0 0.285903 -0.000565721 0 0.286336 -0.0168509 0 0.164604 0.00864911 0 + 0.0763631 -0.000507388 0 0.189074 -0.00448412 0 0.234653 -0.0134406 0 0.305378 -0.0333592 0 + 0.307883 -0.0439075 0 0.256349 -0.0059695 0 0.284423 -0.015488 0 0.1912 0.0425215 0 + 0.282581 -0.0243013 0 0.389257 -0.0230279 0 0.267686 -0.00675285 0 0.256276 0.0128138 0 + 0.137807 -0.00080815 0 0.31012 -0.0292926 0 0.175016 0.00442987 0 0.251365 0.0105195 0 + 0.286493 -0.0252789 0 0.304734 -0.0359949 0 0.126706 -0.000676684 0 0.0158843 0.0067198 0 + 0.192117 0.00401766 0 0.125675 -0.00153366 0 0.0968022 0.000692113 0 0.216235 -0.00189416 0 + 0.326972 0.128834 0 0.246697 0.00412866 0 0.2444 -0.00427472 0 0.280029 0.104276 0 + 0.190678 -0.00493211 0 0.157251 0.00113158 0 0.188975 0.00920066 0 0.157177 -0.003027 0 + 0.297881 -0.0289639 0 0.237996 0.00513744 0 0.196823 0.00227149 0 0.0186513 0.000275592 0 + 0.00853485 -0.00427046 0 0.0634409 -5.45512e-05 0 0.250878 -0.0644987 0 0.257998 0.0127053 0 + 0.0220394 -0.00131403 0 0.291062 -0.0237732 0 0.253484 0.0121793 0 0.3597 0.0491786 0 + 0.0763177 0.0256462 0 0.285661 -0.0186085 0 0.24462 0.0247389 0 0.235404 0.00854925 0 + 0.242214 -0.0124343 0 0.015914 9.61234e-06 0 0.0156644 1.54839e-05 0 0.260398 -0.00049745 0 + 0.266669 -0.000518966 0 0.183285 -0.00165368 0 0.197455 -0.00249343 0 0.187517 0.00307066 0 + 0.229112 -0.00356882 0 0.274516 -0.0253163 0 0.208268 0.0039033 0 0.290539 -0.0213596 0 + 0.251261 0.0107061 0 0.244344 -0.00498156 0 0.155521 -0.000874998 0 0.313012 -0.0204332 0 + 0.145895 -0.0195635 0 0.0542436 0.00011283 0 0.111123 -0.000964653 0 0.0986083 -0.000406319 0 + 0.195929 -0.000932499 0 0.135496 -0.00531337 0 0.231337 -0.00417937 0 0.255317 0.0531812 0 + 0.328338 0.0127817 0 0.354746 0.13374 0 0.169702 0.00325816 0 0.206329 -0.00298176 0 + 0.31272 -0.0431264 0 0.24871 0.00433688 0 0.243158 -0.0744091 0 0.184205 -0.001818 0 + 0.200741 0.0124075 0 0.220303 -0.00839944 0 0.268543 -0.00687548 0 0.19042 0.0045995 0 + 0.109745 0.0207079 0 0.250084 -0.0162482 0 0.13302 -0.164764 0 0.129183 -0.0322085 0 + 0.268964 -0.00833959 0 0.0430273 -0.0107498 0 0.206835 -0.00279647 0 0.149037 -0.00245013 0 + 0.212012 -0.0290891 0 0.267749 0.0162109 0 0.15826 -0.0019286 0 0.260935 -0.0187983 0 + 0.310279 -0.030874 0 0.0331267 -0.000621227 0 0.126541 -0.00173673 0 0.371933 -0.0724558 0 + 0.287669 -0.0176012 0 0.196643 0.000547239 0 0.286586 -0.034619 0 0.204683 -0.00725747 0 + 0.245755 0.010638 0 0.211998 -0.00571879 0 0.154112 0.0292557 0 0.0913237 -0.00074106 0 + 0.0824644 -0.000271543 0 0.26231 0.0144652 0 0.270095 -0.000961018 0 0.264339 -0.000947215 0 + 0.246065 -0.0689781 0 0.127163 0.00219985 0 0.390224 0.114241 0 0.145789 0.00234875 0 + 0.283604 -0.0166523 0 0.125664 0.00138044 0 0.149045 -0.00174972 0 0.259715 -0.0206533 0 + 0.276437 0.000601707 0 0.151263 -0.00540735 0 0.292796 -0.0220162 0 0.206832 -0.00226319 0 + 0.181757 -0.0317969 0 0.128034 -0.00229258 0 0.269475 -0.00799401 0 0.208938 -0.0449356 0 + 0.262122 -0.0174304 0 0.176983 -0.0343843 0 0.267707 0.0169078 0 0.24301 0.00560804 0 + 0.25626 -0.0183011 0 0.386951 0.0174038 0 0.23165 -0.00508985 0 0.267496 -0.00111399 0 + 0.138501 0.00184255 0 0.279612 9.35812e-05 0 0.290446 -0.019566 0 0.00905672 -0.00108199 0 + 0.231129 0.0114882 0 0.128615 -0.000724161 0 0.227313 0.013284 0 0.350303 -0.0228289 0 + 0.212525 -0.0028102 0 0.267805 -0.12496 0 0.256199 0.01256 0 0.0180619 -1.1189e-05 0 + 0.249722 0.0112709 0 0.0185346 -0.0119513 0 -0.00454949 -0.00148275 0 0.169617 0.027792 0 + 0.175412 0.0375669 0 0.208852 0.00280295 0 0.28142 0.191025 0 0.269698 -0.00750078 0 + 0.15639 0.0030119 0 0.0308916 3.55347e-05 0 0.261465 0.0160057 0 0.230856 0.0126854 0 + 0.135365 0.00180125 0 0.087679 -0.000491394 0 -0.0133463 -0.000277572 0 0.244847 -0.0158747 0 + 0.270313 -0.00819307 0 0.138787 0.0029077 0 0.158196 -0.0360254 0 0.3102 -0.0415525 0 + 0.183073 -0.00472592 0 0.17212 0.00261932 0 0.267539 -0.00825729 0 0.174797 -0.00510308 0 + 0.0706043 0.00189242 0 0.0850639 0.00526441 0 0.0325286 -1.85181e-06 0 0.206871 0.0415138 0 + 0.204984 0.0385131 0 0.159143 0.00303953 0 0.182363 0.00483743 0 0.269772 -0.0493545 0 + 0.301243 -0.032534 0 0.0253983 -4.43907e-05 0 0.173391 0.0408582 0 0.157432 0.00399881 0 + 0.272945 0.0188408 0 0.255366 0.013588 0 0.224953 -0.00339902 0 0.170338 -0.00357158 0 + 0.288449 -0.0214479 0 0.366678 0.0160411 0 0.106636 -0.000833223 0 0.209339 0.00905742 0 + 0.305417 -0.0278678 0 0.301186 -0.0421458 0 0.214526 0.00311063 0 0.295795 0.0314534 0 + 0.145947 0.0371783 0 0.3367 0.0426551 0 0.273791 0.0247806 0 0.121769 -0.00437299 0 + 0.344844 0.0385131 0 0.151682 -0.00353387 0 0.25534 -0.00511788 0 0.198815 9.04266e-05 0 + 0.240924 0.0047192 0 0.311133 0.0470596 0 0.220622 -0.00313342 0 0.268581 -0.0204916 0 + 0.203656 -0.00638332 0 -0.00372946 0.00222782 0 0.296902 0.0470731 0 0.177137 0.00378746 0 + 0.229722 0.0085541 0 0.302074 -0.0383613 0 0.0702311 -0.00825022 0 0.381105 0.00817791 0 + 0.389445 -0.0741458 0 0.205041 0.00406073 0 0.26862 -0.00759181 0 0.264712 0.0494037 0 + 0.282369 -0.0121274 0 0.164877 0.0193278 0 0.304252 -0.0410824 0 0.297413 -0.0240716 0 + 0.270604 -0.0202397 0 0.142077 0.000886092 0 0.330287 0.0445847 0 0.294042 -0.024561 0 + 0.206972 0.018426 0 0.180536 0.0054826 0 0.152147 0.0098395 0 0.28941 -0.0184547 0 + 0.192257 0.0141339 0 0.108817 -0.000461381 0 0.288467 -0.0286979 0 0.0624785 1.71229e-05 0 + 0.381614 0.022807 0 0.272752 -0.0211785 0 0.128279 -0.000701811 0 0.277472 0.0208401 0 + 0.241602 -0.00590142 0 0.26955 -0.00746826 0 0.237884 -0.0183379 0 0.0929029 -0.00114829 0 + 0.264009 -0.0197059 0 0.291702 -0.0204121 0 0.244156 0.00510311 0 -0.0136364 -0.00112027 0 + 0.222399 -0.0074421 0 0.32166 0.0460383 0 0.257854 -0.00601241 0 0.187052 0.000959984 0 + 0.243236 0.0096982 0 0.13155 -0.00105277 0 0.169949 0.00766283 0 0.280983 -0.0158102 0 + 0.248536 -0.00640619 0 0.304836 -0.0502815 0 0.202944 0.00252684 0 0.357143 0.00849944 0 + 0.296799 -0.0253127 0 0.28529 -0.00438599 0 0.335411 0.00932159 0 0.225676 0.0397341 0 + 0.289686 -0.0195597 0 0.0967476 7.5659e-05 0 0.1929 0.00481544 0 0.142136 -0.00326037 0 + 0.119847 0.00133721 0 0.149298 0.00451999 0 0.259337 0.00954001 0 0.08839 0.0241486 0 + 0.257853 0.0710328 0 0.268245 -0.00692355 0 0.1792 0.0105857 0 0.377681 0.0896168 0 + 0.249768 -0.0062259 0 0.0243633 -0.0125358 0 0.139598 0.166892 0 0.0242607 0.0254257 0 + 0.180877 -0.00638744 0 0.203708 0.00457577 0 0.186787 -0.0151902 0 0.25012 -0.00537665 0 + 0.274661 -0.0286313 0 0.146515 0.023303 0 0.016826 -0.0107335 0 0.224581 -0.0313786 0 + 0.176262 -0.027669 0 0.151764 0.00259453 0 0.182197 0.0340146 0 0.255746 0.00564023 0 + 0.20657 0.00625472 0 0.122688 0.000653402 0 0.194426 0.0314829 0 0.166757 -0.0307987 0 + 0.175466 0.0974983 0 0.116687 -0.0131089 0 0.26012 -0.0175463 0 0.294096 -0.02715 0 + 0.322672 -0.0483499 0 0.227397 -0.0411269 0 0.100878 -0.00200804 0 0.0924081 0.00294511 0 + 0.0664717 0.0230829 0 0.283878 -0.0276039 0 0.311773 -0.0313074 0 0.294792 -0.0226411 0 + 0.144031 0.00477679 0 0.188104 -0.00280414 0 0.0066475 -0.00551998 0 0.357529 -0.156226 0 + 0.178653 -0.00431545 0 0.163092 -0.00626815 0 0.177143 0.0096798 0 0.201956 0.0104193 0 + 0.348213 -0.0334214 0 0.221981 0.00623284 0 0.209344 -0.00786706 0 0.189402 0.000445637 0 + 0.108541 -0.00156376 0 0.184942 0.0118116 0 0.249213 0.00524558 0 0.126616 0.0181306 0 + 0.210252 0.00349493 0 0.178136 0.00264104 0 0.201595 -0.0023833 0 0.230193 -0.03315 0 + 0.238729 -0.00518233 0 0.294789 -0.000188903 0 0.266512 -0.00724408 0 0.219368 0.0342519 0 + 0.306251 -0.0430136 0 0.0862135 0.00221896 0 0.109829 0.00323451 0 0.00735541 -0.00405493 0 + 0.111236 0.0071504 0 0.215749 0.0077991 0 0.196856 0.00486109 0 0.183976 0.00182507 0 + 0.14149 -0.000547569 0 0.29035 -0.0322339 0 0.110406 -0.000758272 0 0.258628 -0.0453875 0 + 0.291261 -0.0246363 0 0.281977 -0.0227335 0 0.211257 -0.00892707 0 0.270086 -0.00797368 0 + 0.160412 0.00125394 0 0.124561 0.0331707 0 0.171415 0.00866705 0 0.279454 0.0222765 0 + 0.0108499 -0.00270637 0 0.154655 0.00190258 0 0.072757 0.000992462 0 0.180233 -0.00319839 0 + 0.158117 0.036404 0 0.324101 -0.0374478 0 0.254187 0.0143932 0 0.244968 0.00940702 0 + 0.26832 0.0172943 0 0.289809 -0.0188464 0 0.220113 0.0422249 0 0.229546 0.00805844 0 + 0.162895 -0.0310161 0 0.16001 0.00330098 0 0.296231 -0.0227852 0 0.126445 -0.000263457 0 + 0.298166 -0.040417 0 0.200438 -0.00206017 0 0.167552 0.00759257 0 0.191717 -0.0307247 0 + 0.0248495 -9.88621e-05 0 0.073214 -0.000680018 0 0.300879 -0.028822 0 0.175057 -0.000376321 0 + 0.194656 0.00213283 0 0.382392 -0.0616232 0 0.295939 -0.0235688 0 0.281128 0.0228782 0 + 0.259732 0.0217833 0 0.294395 -0.0214629 0 0.291177 0.00867033 0 0.173742 0.0153213 0 + 0.190867 -0.108081 0 0.260941 0.0220875 0 -0.0137332 0.000877381 0 0.0670754 0.000105924 0 + 0.100896 0.018239 0 0.256908 0.043801 0 0.238374 0.0082245 0 0.0980508 -0.109653 0 + 0.197321 -0.0326745 0 0.218184 0.00402189 0 0.273868 0.0192957 0 0.171551 0.00574346 0 + 0.0999475 -0.0215193 0 0.187983 -0.00588197 0 0.141205 0.0349429 0 0.250145 0.0050557 0 + 0.252557 -0.000374454 0 0.366312 0.0788145 0 0.395767 0.0811492 0 0.28532 -0.0311083 0 + 0.132533 0.00616957 0 0.300608 -0.0252362 0 0.0608128 0.00263677 0 0.285337 0.125229 0 + 0.288688 -0.018039 0 0.160142 0.0110023 0 0.165665 0.00458497 0 0.230579 -0.00352041 0 + 0.244266 -0.0686353 0 0.330766 0.0348858 0 0.297594 -0.0280158 0 0.221489 0.00670285 0 + -0.00367189 0.00631633 0 0.154067 -0.00525968 0 0.283946 0.0249661 0 0.195422 0.00543752 0 + 0.163394 0.00529124 0 0.297127 -0.0306946 0 0.343313 0.0137672 0 0.0847958 0.000272503 0 + 0.139125 0.00555135 0 0.248513 0.004545 0 0.279284 -0.0436536 0 0.231604 0.0270757 0 + 0.169592 0.00645603 0 0.212269 0.039708 0 0.138443 0.0282237 0 0.0608657 -0.000733275 0 + 0.203735 0.00455084 0 0.219198 -0.0108861 0 0.117326 -0.00303844 0 0.269218 0.0354437 0 + 0.158842 -0.00147967 0 0.221095 0.148558 0 0.149644 0.00684317 0 0.122007 0.00799008 0 + 0.265585 0.0344098 0 0.12147 0.000618047 0 0.281783 -0.0250671 0 0.117185 0.00549911 0 + 0.350362 0.0321828 0 0.12762 0.00360773 0 0.273801 0.000798093 0 0.198779 0.00731531 0 + 0.240247 0.0103388 0 0.371925 0.0057184 0 -0.0158848 0.000432904 0 0.240393 -0.00456957 0 + 0.278525 -0.0426291 0 0.125716 -0.000691514 0 0.28582 0.0270716 0 0.242859 0.0360133 0 + 0.128336 -0.00141337 0 0.235563 0.00690297 0 0.156398 -0.00392098 0 0.219098 0.00323562 0 + 0.264116 0.0428451 0 0.261943 0.00219626 0 0.137751 0.00324367 0 0.281261 -0.107253 0 + 0.146839 0.00478193 0 0.343365 -0.0236654 0 0.282731 -0.0169446 0 0.275263 -0.032124 0 + 0.127543 -0.00341601 0 0.2528 -0.00565874 0 0.21217 -0.00337115 0 0.317669 -0.0243931 0 + 0.132583 -0.00257534 0 -0.00186295 -0.00470458 0 0.14556 -0.0282288 0 0.307079 -0.0539239 0 + 0.230743 0.010936 0 0.3861 -0.0634687 0 0.231338 0.0211459 0 0.29362 -0.0388835 0 + 0.176409 0.00144717 0 0.18844 -0.00793162 0 0.0954238 0.0131313 0 0.218352 0.0395647 0 + 0.225437 0.00789277 0 0.166255 -0.0226086 0 0.37934 0.0134239 0 0.229318 -0.00691904 0 + -0.00246936 -0.00501547 0 0.0562548 0.00990367 0 0.261357 0.0223936 0 0.289868 0.0290194 0 + 0.162927 -1.69533e-05 0 0.248031 0.011901 0 0.193537 0.0118901 0 0.156947 0.00791794 0 + 0.341373 0.00564499 0 0.162431 0.0171057 0 0.295293 -0.0219394 0 0.0127074 0.0165181 0 + 0.299311 -0.0260185 0 0.388476 0.0908756 0 0.165459 -0.00465286 0 0.278612 0.0213339 0 + 0.247982 -0.00515212 0 0.222569 0.0408024 0 0.254359 0.00724805 0 0.288627 -0.191845 0 + 0.161469 -0.00334283 0 0.254135 0.0785856 0 0.287572 -0.0176161 0 0.185518 0.0104545 0 + 0.286588 0.0291272 0 0.181344 -0.0370616 0 0.197523 -0.00969811 0 0.266643 -0.00386614 0 + 0.100517 0.0297992 0 0.245536 -0.00890505 0 0.0409798 8.23324e-06 0 0.336315 -0.0415571 0 + -0.00133218 -0.00486634 0 0.147343 0.0123482 0 -0.00502948 0.00903087 0 0.12276 0.00389179 0 + 0.213472 -0.0128437 0 0.273017 -0.0197737 0 0.367685 0.00182022 0 0.220575 -0.0136994 0 + 0.236184 0.00844441 0 0.286719 -0.0919384 0 0.358366 -0.0326372 0 0.160439 0.00609718 0 + 0.301787 0.0800368 0 0.351771 -0.0336946 0 0.274498 -0.0124141 0 0.267762 -0.00379695 0 + 0.140796 0.00249839 0 0.125635 -0.000669669 0 0.153132 0.0213207 0 0.299662 -0.0247864 0 + 0.196009 -0.00614351 0 0.312152 -0.025354 0 0.228692 -0.0278955 0 0.0891614 0.023562 0 + 0.0531206 3.5386e-05 0 0.278332 -0.000920384 0 0.104349 0.00147919 0 0.144916 0.0122878 0 + 0.289346 -0.0199209 0 0.0894426 0.000111163 0 0.0710688 6.65832e-05 0 0.259846 -0.00149292 0 + 0.248281 0.0116843 0 0.187746 0.00577365 0 0.0911244 -0.0151521 0 0.270204 -0.00356513 0 + 0.00107544 0.0054045 0 0.269989 -0.00760893 0 0.170188 0.00612452 0 0.260025 0.00976237 0 + 0.0451184 0.0154091 0 0.178939 0.000874411 0 0.129601 0.00557536 0 0.224562 0.0389488 0 + 0.280589 0.0251562 0 0.218163 -0.00300978 0 0.246232 0.0256358 0 0.146764 0.00402693 0 + 0.0354372 -0.0151113 0 0.154815 0.00482664 0 0.194193 -0.00731173 0 0.1621 -0.00497471 0 + 0.301159 -0.0315836 0 0.212455 -0.0198165 0 0.167757 0.00610508 0 0.261645 -0.00743175 0 + 0.216268 -0.00964956 0 0.244565 -0.019364 0 0.00368299 -0.0102517 0 0.276784 0.0296753 0 + 0.116823 -0.00140284 0 0.135226 -0.0225926 0 0.288517 0.0277245 0 0.323018 -0.0428346 0 + 0.260521 -0.0744122 0 0.39075 -0.0357697 0 0.228528 -0.0130819 0 0.16564 -0.00420095 0 + 0.291971 0.0830162 0 0.305002 -0.0323877 0 0.177884 -0.00459518 0 0.344513 0.0391335 0 + 0.283101 0.0347573 0 0.153058 0.00543398 0 0.294115 -0.0280611 0 0.139725 0.00950018 0 + 0.0613277 -0.00117517 0 0.155459 0.00114676 0 0.0982831 0.00715898 0 0.142264 -0.024805 0 + 0.131214 0.0252003 0 0.186198 0.00641429 0 0.300316 -0.0270001 0 0.31255 0.03442 0 + 0.114283 0.00634482 0 0.159912 0.000616905 0 0.388606 -0.0488651 0 0.296481 -0.0232093 0 + 0.394746 0.0904193 0 0.29004 0.0313632 0 0.281106 0.000183382 0 0.150644 0.00619471 0 + 0.235704 -0.000332589 0 -0.00201054 -0.00438147 0 0.00925964 -9.89404e-06 0 0.0794925 -0.00122112 0 + 0.260091 0.00962484 0 0.111405 0.00262493 0 0.257401 -0.0607979 0 0.333267 0.0105462 0 + 0.021092 0.0106757 0 0.0954053 -0.00308416 0 0.326357 0.0451631 0 0.0338845 -0.008631 0 + 0.282555 0.0234542 0 0.261815 0.0150614 0 -0.013596 0.00181254 0 0.190079 0.00850694 0 + 0.283671 0.0181851 0 0.258474 -0.0066208 0 0.225594 0.00698554 0 0.293194 -0.0209498 0 + 0.285689 0.0256255 0 0.0335352 -4.12053e-05 0 0.371894 0.00910733 0 0.257114 0.0340688 0 + 0.251276 0.00554978 0 0.180824 -0.00159794 0 0.270972 0.000732826 0 0.210862 -0.00215842 0 + 0.182195 -0.00221404 0 0.105235 0.0011942 0 0.270277 -0.00772273 0 0.11695 -0.00355244 0 + 0.286431 -0.00114358 0 0.193328 -0.00204467 0 0.0703765 0.00331936 0 -0.0132422 -0.000484179 0 + 0.139539 -0.00224554 0 0.117014 0.00209932 0 0.269134 -0.00706454 0 0.245376 0.0092677 0 + 0.28771 0.027767 0 0.201005 0.0125745 0 0.206541 0.00546649 0 0.251363 -0.0093389 0 + 0.224563 -0.0117137 0 0.303935 -0.0295549 0 -0.00529754 0.00179706 0 0.304871 -0.0350991 0 + 0.263427 0.0367348 0 -0.00739939 -0.00220222 0 0.306257 -0.0604128 0 0.285013 -0.000564574 0 + 0.244221 -0.00881076 0 0.123609 0.0270413 0 0.177079 -0.0358147 0 0.330176 -0.0371511 0 + 0.273813 0.0306146 0 0.119571 0.00211509 0 0.176057 -0.00882448 0 0.340714 0.0402331 0 + 0.0143996 -0.00260359 0 0.0108022 -0.00872166 0 0.0170863 -0.000167799 0 0.18701 -0.00190012 0 + 0.232872 -0.013312 0 0.187672 -0.00908843 0 0.345725 -0.0080137 0 0.219424 0.071649 0 + 0.051549 -0.00745664 0 0.228329 -0.0033933 0 0.201943 -0.0076056 0 0.0384755 -5.38039e-05 0 + 0.211218 0.0356723 0 0.237576 0.0437969 0 0.349022 0.0379367 0 0.168917 -0.00135175 0 + 0.116215 0.0041729 0 0.301102 -0.0253285 0 0.117407 -0.00641869 0 0.287126 -0.01724 0 + 0.195545 -0.0395719 0 0.104001 -0.0244547 0 0.12593 0.00310628 0 0.305119 -0.0283184 0 + 0.0443103 -8.34709e-05 0 0.164649 0.0144312 0 0.106002 -0.00229031 0 0.259339 -0.0389038 0 + 0.282948 -0.0284223 0 0.233584 0.00859216 0 0.216798 0.00399283 0 0.208279 -0.0116346 0 + 0.0654996 0.0001519 0 0.135357 -0.00200859 0 0.197754 0.004576 0 0.145445 -0.138977 0 + 0.017376 -0.000114611 0 0.158758 -0.00117282 0 0.183332 -0.00537934 0 0.0654177 -8.74258e-05 0 + 0.11522 0.0106414 0 0.25949 0.00942369 0 0.252347 0.00758841 0 0.153836 0.0199151 0 + 0.063242 -2.98667e-08 0 0.276315 0.103205 0 0.171693 0.0873091 0 0.110774 0.0175535 0 + 0.317425 0.036482 0 0.161742 -0.000494661 0 0.212322 0.00289301 0 0.262134 0.0153845 0 + 0.214646 -0.0411036 0 0.298091 -0.00060839 0 0.187486 -0.00173458 0 0.0077563 1.22252e-07 0 + 0.284354 -0.0163876 0 0.261613 -0.000511127 0 0.0745918 0.00630357 0 0.0918088 0.00677538 0 + 0.163897 0.0245819 0 0.292608 -0.020534 0 0.176447 0.00765907 0 0.253817 -0.019929 0 + 0.289721 -6.2331e-05 0 0.267431 0.0164755 0 0.286465 0.0310788 0 0.279757 0.0364326 0 + 0.257445 0.158561 0 0.33648 -0.0408642 0 0.272273 0.0234697 0 0.280789 -0.020987 0 + 0.0282044 0.0115311 0 0.0335464 1.88618e-05 0 0.143866 -0.00548499 0 0.348592 -0.0372754 0 + 0.118748 -0.0155629 0 0.290798 0.0351612 0 0.296941 -0.0316179 0 0.162945 0.00130643 0 + 0.27978 0.0250097 0 0.236054 -0.00437797 0 0.302867 -0.0375712 0 0.243913 -0.00965432 0 + 0.0431465 -3.72799e-05 0 0.0851744 -0.01376 0 0.270913 0.0864654 0 0.249522 0.0187493 0 + 0.161778 -0.00413615 0 0.208287 -0.0343965 0 0.257584 0.189604 0 0.128037 -0.0432352 0 + 0.34773 -0.0305633 0 0.0397055 3.81441e-05 0 0.261422 -0.00136487 0 0.254516 -0.000876497 0 + 0.250922 -0.000881412 0 0.258241 -0.00137929 0 0.100784 -0.118937 0 0.167924 0.00139924 0 + 0.152246 -0.0150902 0 0.248579 -0.000324361 0 0.00461168 -0.00471101 0 0.128419 -0.0315452 0 + 0.239236 -0.015415 0 0.196959 -0.0178952 0 0.285302 0.032959 0 0.133238 -0.0752915 0 + 0.293369 -0.0391166 0 0.206567 0.00343788 0 0.132495 0.00576109 0 0.252768 -0.0255132 0 + 0.246678 0.0573019 0 0.133225 0.00459037 0 0.132442 0.00478315 0 0.0409862 -2.97281e-05 0 + 0.1729 -0.00805259 0 0.297936 -0.0242 0 0.124029 0.00515295 0 0.234328 -0.0476711 0 + 0.304776 -0.0305555 0 0.305212 -0.0404128 0 0.237457 -0.0416953 0 0.207993 0.012121 0 + 0.237131 -0.00718587 0 0.12447 -0.000650944 0 0.234271 0.0288811 0 0.299616 -0.026146 0 + 0.18053 -0.00813572 0 0.257701 0.00734697 0 0.153069 0.00602523 0 0.268548 -0.00776937 0 + 0.172793 -0.0267361 0 0.133019 -0.00383643 0 0.000745104 -0.00548645 0 0.258208 -0.043125 0 + 0.344636 -0.0306426 0 0.26877 0.000865373 0 0.204864 0.00339949 0 0.381167 -0.053096 0 + 0.139348 0.00632108 0 0.16899 -0.00624308 0 0.181514 0.0292817 0 0.210084 -0.046468 0 + 0.228968 0.0338339 0 0.17707 -0.00271843 0 0.234215 -0.0327686 0 0.205316 0.00193257 0 + 0.201825 -0.00901604 0 0.295594 0.0302991 0 0.0612033 0.000125532 0 0.391534 0.0247697 0 + 0.174748 -0.00870066 0 0.326259 -0.0395383 0 0.288625 0.0298534 0 0.269064 -0.000949806 0 + 0.263609 0.0754437 0 0.317086 0.018509 0 0.177622 0.00678741 0 0.204367 0.00794501 0 + 0.19465 -0.0113125 0 0.172527 -0.0108774 0 0.25224 -0.00655487 0 0.165416 -0.115472 0 + 0.310885 -0.0409185 0 0.157642 0.0251803 0 0.190829 -0.0389654 0 0.0687899 0.00756297 0 + 0.145018 -0.00122647 0 0.329638 0.00459198 0 0.312529 0.04592 0 0.124342 -0.016078 0 + 0.387356 0.0339694 0 0.136811 0.00712445 0 0.191521 -0.00563659 0 0.26957 -0.00740454 0 + 0.277017 0.000559286 0 0.233531 -0.0287077 0 0.259237 0.0170192 0 0.188778 -0.0320327 0 + 0.220539 -0.0136049 0 0.235171 0.00821969 0 0.268892 -0.0178533 0 0.0321448 0.0141774 0 + 0.277295 -0.00145978 0 0.1899 -0.00179382 0 0.174306 0.00763453 0 0.138561 0.0110421 0 + 0.149651 0.00484352 0 0.341273 -0.00463735 0 0.0964059 -0.0255391 0 0.252851 -0.00814773 0 + 0.294272 -0.000189644 0 -0.00750589 -0.00626881 0 0.205939 0.00969442 0 0.0660842 0.0196178 0 + 0.284561 0.0456373 0 0.0359965 0.00906065 0 0.234217 -0.0139993 0 0.307163 -0.190513 0 + 0.19134 0.00281863 0 0.369545 -0.00957542 0 0.19666 0.0123807 0 0.285502 0.0355945 0 + 0.211447 0.00680831 0 0.398223 0.0798658 0 0.234023 -0.00281588 0 0.141762 -0.00141672 0 + 0.17764 -0.00773642 0 0.189159 -0.00670756 0 0.290442 -0.0239311 0 0.210936 -0.0109588 0 + 0.217497 -0.0340326 0 0.285434 -0.0879761 0 0.284138 -0.0319273 0 0.256221 -0.000368486 0 + 0.203835 -0.040404 0 0.275085 0.000609023 0 0.00818153 -0.00425722 0 0.202313 -0.032551 0 + 0.134097 -0.00490276 0 0.164892 -0.00261322 0 0.112543 0.0288724 0 0.206405 0.0325426 0 + 0.230711 0.0348372 0 0.117508 0.00971523 0 0.116598 0.00338538 0 0.179625 -0.00560196 0 + 0.257034 0.0714061 0 0.210718 0.00735292 0 0.253367 -0.0351495 0 0.0716529 -0.000190002 0 + 0.301654 -0.189699 0 0.297959 -0.0237852 0 0.0852707 0.0170535 0 0.184841 -0.00961865 0 + 0.25429 0.0141216 0 0.124665 0.00719701 0 0.293724 0.0763265 0 0.12834 -0.00112614 0 + 0.286881 -0.108229 0 0.260834 0.0243885 0 0.0933478 -0.0260186 0 0.294701 0.0431942 0 + 0.397178 0.0777829 0 0.245047 0.0512889 0 0.0053855 -0.00545645 0 0.177815 -0.0243831 0 + 0.252911 0.0361165 0 0.117892 0.0104709 0 0.269403 -0.00779595 0 0.24412 -0.0373094 0 + 0.296436 -0.000216459 0 0.291676 -0.0200589 0 0.305836 0.0415599 0 0.0327033 5.58503e-06 0 + 0.180375 0.00981596 0 0.124253 -0.0181238 0 0.154894 -0.0237766 0 -0.00573369 0.0083677 0 + 0.0997691 -0.00932733 0 0.261183 0.0234698 0 0.309299 -0.0358563 0 0.175952 0.00749217 0 + 0.230695 0.0376951 0 0.146433 0.00108189 0 0.26895 0.0402569 0 0.353923 -0.0347277 0 + 0.114761 0.0175549 0 0.246373 0.0982185 0 0.248085 0.0198115 0 0.348085 -0.0284596 0 + 0.308677 -0.0331026 0 0.307176 -0.0288959 0 0.0886615 0.000158953 0 0.313705 -0.0427087 0 + 0.349341 -0.0113477 0 0.185717 -0.00876285 0 0.213779 0.00293994 0 0.0420372 1.41174e-05 0 + 0.0160151 2.52196e-06 0 0.0167033 6.09688e-06 0 0.299428 -0.0397235 0 0.271582 0.0363581 0 + 0.116378 0.00214898 0 0.0349209 0.0141887 0 0.304417 -0.0272875 0 0.262948 0.0454791 0 + 0.336029 -0.0012585 0 0.236553 -0.0348706 0 0.213283 0.170737 0 0.280872 -0.0139526 0 + 0.0263684 -0.00640943 0 0.350538 0.144162 0 0.228823 0.00730387 0 0.180976 0.0282951 0 + 0.273779 0.00062937 0 0.167955 0.00842767 0 0.276221 0.0348777 0 0.225855 0.00653129 0 + 0.24578 0.0394515 0 0.259017 -0.0188153 0 0.267127 -0.0169596 0 0.241112 0.0418452 0 + 0.302846 -0.0276849 0 0.203581 0.00855752 0 0.0484466 0.0114222 0 0.010471 -0.00162394 0 + 0.264226 -0.00712387 0 0.188613 0.00989162 0 0.310794 -0.0318251 0 0.136297 0.0203426 0 + 0.272439 -0.0113341 0 0.286858 0.0110559 0 0.181112 -0.0132089 0 0.281486 0.0255048 0 + 0.251202 -0.0177045 0 0.262223 0.0211349 0 0.130923 -0.000220999 0 0.145292 -0.00027869 0 + 0.261917 0.0224257 0 -0.00383318 -0.00915273 0 0.260618 0.00274714 0 0.234805 0.00696036 0 + 0.15652 -0.0266047 0 0.224762 0.0135826 0 0.183563 0.0418569 0 0.116688 0.0329359 0 + 0.30754 -0.0425427 0 0.209217 -0.00935211 0 0.288669 0.0318237 0 0.114184 -0.000437278 0 + 0.0670667 0.00407395 0 0.223789 0.0829356 0 0.128265 0.000700977 0 0.292464 -0.0357324 0 + 0.136702 -0.0260388 0 0.213908 0.044843 0 0.343249 -0.0366724 0 0.196514 0.00779999 0 + 0.161037 -0.0306242 0 0.213104 -0.15568 0 0.287614 0.0337677 0 0.343178 0.0337888 0 + 0.147777 0.00657453 0 0.275729 0.138338 0 0.309166 -0.0367498 0 0.277517 0.0143477 0 + 0.145072 -0.00600784 0 0.174144 -0.0243223 0 0.342344 0.0376039 0 0.309432 -0.0340861 0 + 0.312645 0.042166 0 0.122061 -0.00039883 0 0.226356 -0.0966358 0 0.233557 -0.00417763 0 + 0.13533 0.0470642 0 0.268994 -0.00712755 0 0.355352 0.0310724 0 0.253063 0.0694464 0 + 0.0997724 -0.00835185 0 0.2427 0.0299816 0 0.0715958 -0.000392234 0 0.171997 -0.0161954 0 + 0.224691 0.000164798 0 0.224943 -0.052244 0 0.346909 0.057464 0 0.181851 0.00177037 0 + 0.299812 0.0320225 0 0.197093 -0.00699484 0 0.130147 -0.00101941 0 0.280756 -0.0287605 0 + 0.122802 -0.0233003 0 0.244679 0.0192027 0 0.00994286 0.0165861 0 0.183148 -0.00209746 0 + 0.245212 -0.0163744 0 0.10684 0.00108483 0 0.0900012 -0.000121051 0 0.136645 -0.000968773 0 + 0.182657 -0.00687837 0 0.324662 -0.183649 0 0.0973786 -0.00132148 0 0.206639 0.00261787 0 + 0.21191 0.00538008 0 0.263792 -0.0309808 0 -0.00602919 -0.00328254 0 0.33295 0.0445369 0 + 0.102389 -0.010059 0 0.25998 -0.0120797 0 0.168967 -0.00879957 0 0.0661135 0.00836326 0 + 0.347851 -0.0261696 0 0.2165 0.0148686 0 0.313664 0.0467107 0 0.208803 0.0102449 0 + 0.227975 -0.013225 0 0.159619 0.00672028 0 0.24039 -0.0344594 0 0.106848 -0.00067179 0 + 0.259261 0.0120001 0 0.275528 -0.0110536 0 0.130127 0.0095815 0 0.000292822 -0.005826 0 + 0.20823 0.00266599 0 0.122523 -0.00231869 0 0.273835 -0.0112659 0 0.188023 -0.00941083 0 + 0.184906 0.0167105 0 0.398642 0.0714263 0 0.227773 -0.00552408 0 0.142631 -0.0028419 0 + 0.257254 -0.00560173 0 0.26155 0.0225407 0 0.19702 -0.00683626 0 0.374948 -0.0429636 0 + 0.231538 0.0172694 0 0.186966 -0.0138754 0 0.138225 -0.00128377 0 0.256842 0.0152926 0 + 0.239936 0.00469444 0 0.00906111 -1.00897e-06 0 0.173103 -0.00837257 0 0.261936 0.0607337 0 + 0.0700104 0.0117665 0 0.149642 0.00039637 0 0.281868 0.0206752 0 0.196331 0.00918322 0 + 0.377928 0.028646 0 0.231449 0.00714657 0 0.288216 -0.0238312 0 -0.00953345 -0.00136737 0 + 0.221578 -0.0130679 0 0.0730099 0.022674 0 0.303586 -0.0272883 0 0.200751 0.00236503 0 + 0.295965 -0.000264669 0 0.297062 -0.000248319 0 0.297892 0.0416983 0 0.122392 0.000654829 0 + 0.127941 -0.000229419 0 0.119481 -0.000204876 0 0.225911 0.0161747 0 0.28613 0.0197847 0 + 0.152562 -0.00111968 0 0.176232 0.0128503 0 0.309792 -0.0435371 0 0.325123 -0.0407007 0 + 0.18711 0.0113188 0 0.296514 -0.0232308 0 0.073012 -0.000215919 0 0.153588 0.0381255 0 + 0.21518 0.00883242 0 0.243943 -0.000261753 0 0.123269 -0.00399557 0 0.232372 -3.44499e-05 0 + 0.0995428 0.0180216 0 0.296793 0.0438062 0 0.0532126 -2.54724e-05 0 0.283154 -0.00142026 0 + 0.280847 -0.00148207 0 0.20409 0.0131233 0 0.289788 0.0281094 0 0.259152 -0.00733922 0 + 0.183626 0.0103445 0 0.222078 -0.0337738 0 0.217925 -0.0113645 0 0.109662 0.0257827 0 + 0.349291 0.0271562 0 0.107744 -7.49695e-05 0 0.27717 -0.00023841 0 0.215902 -0.00394962 0 + 0.345966 -0.0354894 0 0.14095 0.0172027 0 0.281176 -0.0220987 0 0.0769911 0.00182966 0 + 0.35191 -0.0165578 0 0.149365 -0.0228319 0 0.309469 -0.0436663 0 0.00972332 0.00451214 0 + 0.277901 -0.0131061 0 0.19295 -0.00257788 0 0.31645 0.00194342 0 0.202488 0.00241532 0 + 0.26735 -0.00423057 0 0.107136 0.00386502 0 0.300394 0.0278201 0 0.233788 -0.0239662 0 + 0.362912 -0.023939 0 -0.00242407 -0.00573372 0 0.243915 0.0450197 0 0.109564 -0.0116829 0 + 0.233594 0.0172938 0 0.186101 -0.00698481 0 0.157679 0.0122857 0 0.0243591 0.00726359 0 + 0.344359 0.0367979 0 0.277798 0.0439237 0 0.360072 -0.0246194 0 0.0678672 0.0125121 0 + 0.276009 -0.000135332 0 0.282509 -0.000139948 0 0.36636 -0.000293583 0 0.107105 0.00345407 0 + 0.179962 0.0102193 0 0.11679 -0.000585802 0 0.0710925 0.100258 0 0.217531 -0.0039645 0 + 0.307789 -0.0382864 0 0.157515 0.00748016 0 0.162653 -0.00127489 0 0.116852 -0.00375434 0 + 0.0302561 -1.05287e-05 0 0.191723 0.00895066 0 0.213492 -0.00368207 0 0.0436983 2.09771e-05 0 + 0.152869 0.00109669 0 0.129454 0.00496085 0 0.161749 0.0101866 0 0.242472 -0.111558 0 + 0.0573001 0.0219048 0 0.225004 0.0144518 0 0.147437 -0.012614 0 0.105898 0.135672 0 + 0.150484 -0.00607441 0 0.292906 -0.0228383 0 0.101672 -0.000431706 0 0.228706 -0.00397742 0 + 0.256023 0.0708537 0 0.276161 -0.0182434 0 0.0531185 0.0127747 0 0.367879 -0.0334986 0 + 0.227782 0.00737378 0 0.125382 0.000748834 0 0.394614 0.0322956 0 0.25375 -0.017854 0 + 0.0204022 -0.00419044 0 0.270869 0.0448378 0 0.286958 -0.0106675 0 0.293333 -0.10879 0 + 0.307355 -0.0390686 0 0.255231 -0.00619078 0 0.266764 0.0475654 0 0.239577 -0.0396332 0 + 0.0964543 0.0244997 0 0.213178 -0.0128129 0 0.266129 -0.104532 0 0.215186 -0.00357559 0 + 0.277418 0.013733 0 0.195485 0.00986393 0 0.361058 -0.144446 0 0.0584068 6.68341e-05 0 + 0.272546 0.100773 0 -0.00254025 -0.00630997 0 0.117678 -0.00203878 0 0.299443 -0.162699 0 + 0.201369 -0.0410607 0 0.373249 0.0340968 0 0.112514 -0.00790858 0 0.197602 -0.121035 0 + 0.131855 0.0015586 0 0.173021 0.0281516 0 0.22588 0.004395 0 0.297446 -0.173478 0 + 0.268988 -0.00730154 0 0.200102 -0.0111688 0 0.263671 -0.00778542 0 0.254738 0.0271453 0 + 0.266943 -0.0193857 0 0.200924 0.0033501 0 0.205384 -0.0114155 0 0.196396 -0.00830292 0 + 0.152285 0.0168866 0 0.29518 0.00381821 0 0.367694 0.00526788 0 0.155613 0.00609541 0 + -0.00633593 0.00643871 0 0.324983 -0.0349127 0 0.257371 -0.018653 0 0.089079 -0.000326541 0 + 0.209274 -0.00311272 0 0.241372 -0.0367704 0 0.327359 -0.0373967 0 0.147117 -0.00364229 0 + 0.229913 0.0353394 0 0.262131 0.0222558 0 0.0598365 7.75256e-05 0 0.128384 -0.000705591 0 + 0.281343 -0.0397689 0 0.393761 0.0690566 0 0.135652 0.00587769 0 0.238531 -0.00485205 0 + 0.112177 0.0109317 0 0.146575 0.00773767 0 0.216668 0.00643719 0 0.0470233 -0.000180859 0 + 0.31629 -0.0434014 0 0.041529 1.65898e-05 0 0.0406669 1.37323e-05 0 0.0369812 0.00933512 0 + 0.0788472 -0.00140544 0 0.307867 -0.0312457 0 0.14509 0.000955788 0 0.352108 -0.014652 0 + 0.251234 -0.000359261 0 0.259952 -0.00323464 0 0.192207 0.142644 0 0.136485 0.000820922 0 + 0.18628 0.0310724 0 0.0975637 0.000360756 0 0.20511 -0.01015 0 0.299558 -0.107155 0 + 0.311481 0.0292787 0 0.00841131 -4.32025e-06 0 0.153691 -0.0135103 0 0.259989 -0.000167761 0 + 0.351656 -0.145861 0 0.279937 0.0449068 0 0.120736 0.0139863 0 0.33572 0.121496 0 + 0.0827394 -0.0183703 0 0.251763 0.0573449 0 0.283016 0.0264197 0 0.246831 -0.0171409 0 + 0.230172 0.0171975 0 0.199583 0.0124815 0 0.274744 -0.00147472 0 0.249294 -0.00042474 0 + 0.276654 -0.00142973 0 -0.00428283 -0.00886769 0 0.267665 -0.0187577 0 0.27046 0.00826932 0 + 0.379237 -0.0163136 0 0.0719666 -0.00167447 0 0.151767 -0.17517 0 0.187292 0.0105416 0 + 0.246797 0.0393633 0 0.0143001 -0.00570899 0 0.101452 0.000401907 0 0.0603088 -0.00951534 0 + 0.293989 -0.022843 0 0.0725848 0.0166441 0 0.130175 -0.000745017 0 0.199172 -0.0410607 0 + 0.0133288 0.00524355 0 0.292377 0.0616264 0 0.269371 -0.0323501 0 0.20594 -0.132319 0 + 0.204563 0.0312455 0 0.201228 0.0117115 0 0.00833433 -6.17467e-06 0 0.162614 -0.0348076 0 + 0.121792 0.0133698 0 0.122466 0.0096753 0 0.121334 -0.00736078 0 0.153919 0.0958424 0 + 0.197669 0.0416007 0 0.223635 0.0309279 0 0.274662 0.000562809 0 0.00734696 0.00873277 0 + 0.0140043 0.00781021 0 0.194074 -0.00863495 0 0.158891 -0.149846 0 0.276054 0.000537992 0 + 0.13244 0.00874981 0 0.316384 -0.041226 0 0.21603 -0.0319373 0 0.233652 -0.015197 0 + 0.226884 0.0442603 0 0.135225 0.000820096 0 0.269285 -0.00728185 0 0.396007 0.0398173 0 + 0.0838724 0.0231842 0 0.356551 0.0813949 0 0.0733309 -0.00401737 0 0.0624513 0.0140494 0 + 0.137804 0.0223156 0 0.346033 0.0829588 0 0.241382 -0.00546714 0 0.264168 -0.00234303 0 + 0.282923 -0.0150888 0 -0.00913793 -3.02554e-05 0 0.254116 0.0458737 0 0.0165778 0.0102423 0 + 0.0635757 3.31011e-05 0 0.234543 -0.0371055 0 0.32888 -0.0381457 0 -0.00644998 -0.00704979 0 + 0.261811 -0.00239139 0 0.118277 -0.00175941 0 0.29004 0.0427149 0 0.355522 -0.0209159 0 + -0.00112293 0.00192813 0 0.301569 -0.0266735 0 0.180887 0.0389776 0 0.186926 0.025157 0 + 0.231937 0.0173177 0 0.259711 -0.0366232 0 0.115863 0.0107755 0 0.16188 -0.00738583 0 + 0.306193 -0.0222616 0 0.228063 -0.0135692 0 0.331033 -0.0419217 0 0.203988 -0.00863127 0 + 0.298633 -0.151504 0 0.170146 0.00147973 0 0.208621 -0.00182063 0 -0.0124462 0.00106162 0 + 0.111267 0.0124351 0 0.219629 -0.00534165 0 0.267248 -0.000482495 0 0.272893 -0.000500934 0 + 0.285783 0.00931323 0 0.100521 0.0259323 0 0.113991 0.032668 0 0.284389 0.0789827 0 + 0.0206917 0.0124316 0 0.075013 -0.00902662 0 0.180681 -0.0114839 0 0.118937 0.0148804 0 + 0.258349 -0.00681085 0 0.177219 0.00163003 0 0.240191 0.0537844 0 0.369267 -0.140179 0 + 0.262412 0.0724285 0 0.249324 0.0509088 0 0.256311 -0.00094993 0 0.249376 -0.000909129 0 + 0.0344876 4.42965e-05 0 0.22342 -0.0032047 0 0.168285 -0.178118 0 0.26831 0.201417 0 + 0.272713 -0.0811231 0 0.241681 -0.00111567 0 0.301187 -0.000249027 0 0.0155905 -0.00206113 0 + 0.0569203 0.0112253 0 0.212566 -0.00466229 0 0.19657 -0.0244126 0 0.277595 0.00047556 0 + -0.00145093 -0.00763661 0 0.109162 0.0132931 0 0.303849 -0.0440543 0 0.147648 0.00567017 0 + 0.149037 0.0114814 0 0.118355 -0.0304657 0 0.249142 -0.0205111 0 0.0715724 -0.0118029 0 + 0.256212 -0.00650223 0 0.102015 0.0107216 0 0.315937 -0.0418179 0 0.235257 -0.0145054 0 + 0.268903 0.0971746 0 0.395665 0.0472681 0 0.249304 -0.00580548 0 -0.0119035 0.000649656 0 + 0.300495 0.0422906 0 -0.000444438 0.00115787 0 0.259217 0.0102474 0 0.255252 -0.0113754 0 + 0.139131 0.0337373 0 0.256175 0.15116 0 0.124735 0.00354557 0 0.247327 -0.0296583 0 + 0.252555 0.0461842 0 0.128851 -0.00477171 0 0.279564 0.0742117 0 0.100322 -0.00605906 0 + 0.0879312 -0.00115825 0 0.232639 -0.0321956 0 0.19672 -0.0306085 0 0.263023 -0.0340214 0 + 0.36103 -0.0305687 0 0.309309 -0.0308062 0 0.14434 0.00854347 0 0.0852701 -0.0140626 0 + 0.138296 -0.142506 0 0.149971 -0.00820546 0 0.308605 0.0402134 0 0.26565 0.0460699 0 + 0.0261523 0.0143583 0 0.157867 -0.034835 0 0.103795 0.015784 0 -0.00512718 -0.0056004 0 + 0.193563 -0.0344912 0 0.25983 0.0350499 0 0.239596 -0.0158242 0 0.167908 0.0380383 0 + 0.14618 -0.034509 0 0.354193 -0.0178258 0 0.230226 0.140921 0 0.243054 0.00532044 0 + 0.176046 -0.038021 0 -0.00608701 0.00239 0 0.206555 -0.00252625 0 0.0909837 0.0189751 0 + 0.0777541 0.00564171 0 0.31974 -0.0426381 0 0.188687 -0.0381764 0 0.346974 -0.0236955 0 + 0.32616 0.0137985 0 0.186467 -0.0286689 0 0.260409 -0.0130402 0 0.0951196 0.00312209 0 + 0.27301 0.0237612 0 0.166956 0.0314719 0 0.220155 -0.0237003 0 -0.0120284 -0.00125609 0 + 0.0331721 -1.11158e-05 0 0.154471 0.0297716 0 0.219332 -0.013863 0 0.288367 -0.0429184 0 + 0.0191943 0.00984171 0 0.318 0.0922849 0 0.261618 0.0224038 0 0.327305 -0.0357498 0 + 0.20787 0.0212228 0 0.121207 -0.000891833 0 0.306651 -0.015288 0 0.0627328 0.0119262 0 + 0.295397 0.000954209 0 0.246958 0.0198043 0 0.0722723 0.0218648 0 0.291243 -0.00437814 0 + 0.26299 -0.0260563 0 0.219607 -0.0378021 0 0.249648 -0.00945103 0 0.0790728 8.49305e-05 0 + 0.221245 0.00628003 0 0.265757 0.0924031 0 0.294434 -0.0437076 0 0.0968901 0.114378 0 + 0.239873 0.0449622 0 0.27369 0.011557 0 0.286253 0.0434534 0 0.165343 -0.007232 0 + 0.279424 -0.177729 0 0.245855 0.0195293 0 0.201504 -0.00882411 0 0.288383 0.0230819 0 + 0.287093 -0.0228167 0 0.249738 -0.012095 0 0.256424 -0.042517 0 0.206975 0.0111613 0 + 0.345281 -0.0368699 0 -0.00303003 0.00721685 0 0.0996252 0.0115658 0 0.363246 -0.0528088 0 + 0.119445 0.00168651 0 0.12014 -0.0041331 0 0.27863 -0.00094536 0 0.140134 0.0220565 0 + 0.247045 0.0198615 0 0.265776 -0.00380295 0 0.292041 -0.0395832 0 0.0868649 0.00264921 0 + 0.0862177 0.000103002 0 0.179323 0.0100924 0 0.345525 0.154463 0 0.225899 0.044894 0 + 0.259249 -0.0457684 0 0.174553 -0.00446857 0 0.280457 0.0446019 0 0.120777 -0.00574685 0 + 0.134181 -0.0107675 0 0.14272 0.00599544 0 0.287611 -0.0183242 0 0.0839438 -0.00234789 0 + 0.272805 -0.00108298 0 0.273537 0.0454616 0 0.296179 0.0306536 0 0.214517 -0.038731 0 + 0.259667 -0.0173154 0 0.295114 0.0471821 0 0.212319 -0.0105427 0 -0.00461987 -0.0082889 0 + 0.265421 -0.0196002 0 0.161078 -0.00380712 0 0.186814 -0.1301 0 0.0634886 0.0160266 0 + 0.289971 -0.0192304 0 0.326972 0.0188901 0 0.0877017 0.0626983 0 0.351076 0.0348359 0 + 0.12584 0.0221149 0 0.224733 -0.163194 0 0.302274 -0.135767 0 0.135551 0.0225931 0 + 0.186374 0.0112876 0 0.204589 9.49893e-06 0 0.276663 -0.0117106 0 0.215372 -0.0121852 0 + 0.136358 0.012083 0 0.393325 0.0539882 0 0.280633 0.0468743 0 0.210808 0.0045554 0 + 0.299666 -0.0426632 0 0.168967 0.0305073 0 0.149993 -0.0063425 0 0.203589 -0.0104943 0 + 0.249265 0.0196693 0 0.244116 0.045405 0 0.244253 -0.00468152 0 0.255191 -0.00370457 0 + 0.295239 -0.000418437 0 0.0278078 0.0144786 0 0.164746 0.00294687 0 0.0174645 0.00729031 0 + 0.207511 0.0439075 0 0.14932 0.00344728 0 0.0289448 -4.33302e-05 0 0.028743 -3.33521e-05 0 + 0.171052 -0.00530686 0 0.251609 0.00550884 0 0.0745584 -0.0505806 0 0.210976 0.000806353 0 + 0.305531 -0.146581 0 0.0740637 0.0158865 0 0.260905 -0.143906 0 0.0436666 0.0158282 0 + 0.141707 0.00476733 0 0.0828485 0.0183227 0 0.272264 -0.0392298 0 0.0932399 0.00893826 0 + 0.211559 0.042779 0 0.174294 -0.0075729 0 0.0710164 -0.00013381 0 0.262991 0.0865799 0 + 0.309539 -0.0239277 0 0.27474 -0.0119362 0 0.262246 0.0453716 0 0.131815 0.0159879 0 + 0.281358 -0.0185579 0 0.117292 0.0646964 0 0.0747998 -0.000946729 0 -0.0127851 0.00245826 0 + 0.294189 0.0295322 0 0.233086 0.000999646 0 0.32401 -0.135059 0 0.248409 0.096786 0 + 0.228213 0.00606952 0 0.0696677 -0.00282786 0 0.380435 0.0513322 0 0.0511867 0.0014425 0 + 0.359081 -0.0228158 0 0.343705 0.0316015 0 0.360829 0.019611 0 0.181788 -9.08412e-05 0 + 0.19745 -0.0332574 0 0.140033 0.00233311 0 0.196767 -0.0102627 0 0.322337 -0.0401989 0 + 0.340105 -0.0394815 0 0.287127 0.0461216 0 0.282018 0.026123 0 0.0424313 -0.000148221 0 + 0.234769 -0.0153099 0 0.0334172 0.016251 0 0.0382525 0.00126355 0 0.228383 -0.000305467 0 + 0.337187 -0.0356496 0 0.019527 -2.02424e-05 0 0.0878207 0.0276929 0 0.0826358 0.00831038 0 + 0.142205 0.0187393 0 0.224371 0.0192125 0 0.0510454 0.00869085 0 0.245578 -0.0056439 0 + 0.0850194 -0.0215802 0 0.289518 -0.00762993 0 0.230256 0.0506437 0 0.0851653 0.00721517 0 + 0.30529 -0.104511 0 -0.00861368 0.00505431 0 0.340371 -0.0377291 0 0.0218258 -0.00987177 0 + 0.104597 0.000759857 0 0.306748 -0.0302243 0 0.250968 0.0364695 0 0.193818 -0.00208603 0 + 0.237096 0.03886 0 0.0548548 7.02013e-05 0 0.277059 -0.0213006 0 0.309445 -0.028872 0 + 0.357105 -0.0332682 0 0.224474 0.00558344 0 0.222155 -0.00554551 0 0.341101 -0.0396467 0 + 0.303444 0.0616799 0 0.0907266 0.009807 0 0.2922 0.0467966 0 0.273701 0.0426575 0 + 0.249116 -0.0163283 0 0.276905 -0.0433941 0 0.150974 0.0219952 0 -0.00742807 -0.00518249 0 + 0.192607 0.0133212 0 0.198112 0.0423391 0 0.141946 -0.00530704 0 0.174994 0.00157694 0 + 0.272186 0.000686821 0 0.274082 0.06234 0 0.188684 -0.0375835 0 0.268867 0.0184522 0 + 0.0855502 0.0170644 0 0.242355 -0.0857282 0 0.0187637 1.49444e-05 0 0.258893 0.0370896 0 + 0.0187666 1.67112e-05 0 0.32893 -0.101582 0 0.30645 0.0375561 0 0.350764 -0.0302191 0 + 0.236043 0.0220075 0 0.19904 0.00331093 0 0.170106 -0.00406728 0 0.262459 -0.00340811 0 + 0.33519 -0.137269 0 0.101281 -0.0160081 0 0.319042 -0.0429933 0 0.189491 0.0425184 0 + 0.27573 0.000487235 0 0.0488536 -0.0182297 0 0.28701 -0.00102287 0 0.172014 0.0407706 0 + 0.354678 0.0278738 0 0.27736 -0.00190103 0 0.287124 -0.018636 0 0.026653 0.0117701 0 + 0.223634 -0.0357568 0 0.0390931 -5.40977e-05 0 0.254002 0.135552 0 0.279466 -0.00151321 0 + 0.0679362 -0.0222887 0 0.0335467 -0.0140912 0 0.336047 0.0330251 0 0.143411 -0.00081844 0 + 0.300116 0.033054 0 0.315088 -0.0435656 0 0.144034 0.00691722 0 0.375338 0.0126753 0 + 0.246007 0.0196753 0 0.248607 -0.00307053 0 0.178717 -0.00549159 0 0.0903794 -0.0262552 0 + 0.272794 0.0198789 0 0.289752 -0.0159629 0 0.0660577 -3.05404e-05 0 0.0983177 -0.000399912 0 + 0.249054 -0.0379554 0 0.270833 -0.00252435 0 0.0117311 -1.91918e-05 0 0.0677713 -0.000132268 0 + 0.153737 0.175476 0 0.193563 -0.0323269 0 0.327516 0.0228753 0 0.208596 -0.00661697 0 + 0.029629 2.11125e-05 0 0.227399 -0.052271 0 0.15992 -0.00582201 0 0.0124266 0.00287339 0 + 0.210635 0.0747926 0 0.181058 -0.00898155 0 0.294762 -0.000416607 0 0.301506 0.0325117 0 + 0.271606 -0.00358096 0 0.215133 -0.00490164 0 -0.00316341 0.006615 0 0.0842613 -0.00109022 0 + 0.271025 -0.00371522 0 0.3461 0.171073 0 0.262459 0.0352743 0 0.141493 0.0269463 0 + 0.389765 0.0604241 0 0.0873804 0.0165861 0 0.168301 -0.00316786 0 0.101233 0.00630931 0 + 0.277108 -0.0115681 0 0.243055 -0.00536376 0 0.245321 0.00829842 0 0.108288 -0.00182876 0 + 0.178276 0.185545 0 0.152491 0.0296519 0 0.212449 0.00152121 0 0.166054 -0.00481933 0 + 0.182078 0.039631 0 0.108971 0.000980276 0 0.278905 -0.0205405 0 0.100075 0.0301216 0 + 0.309212 0.0832508 0 -0.0111011 0.00272336 0 0.0113723 0.00552265 0 0.270279 -0.137225 0 + -0.00491478 -0.00744931 0 0.326746 -0.0416772 0 0.0628147 4.40893e-05 0 0.116834 -0.0301965 0 + 0.288573 -0.0442448 0 0.338192 0.178517 0 0.14309 -0.00423914 0 0.153614 -0.0166331 0 + 0.119199 -0.0173554 0 0.112379 0.000328489 0 0.227793 0.0166352 0 0.295955 -0.0223968 0 + 0.151634 0.00881833 0 0.0432713 -0.000197754 0 0.0125206 0.00805943 0 0.301893 -0.0440904 0 + 0.293622 -0.0214004 0 0.0154635 0.0103874 0 0.254143 0.0165848 0 0.299577 -0.0232511 0 + 0.39143 -0.0838647 0 0.239382 0.00193688 0 0.25275 -0.0375238 0 0.152039 0.0072161 0 + 0.198785 0.12564 0 0.248305 -0.00353069 0 0.231304 -0.0478976 0 0.0619964 0.0206924 0 + 0.0197634 0.0124171 0 0.238414 -0.180449 0 0.227129 -0.0142834 0 0.0665702 -1.00376e-05 0 + 0.247957 0.0440243 0 0.317509 -0.0400134 0 0.269538 -0.168971 0 0.214732 -0.0124954 0 + 0.273825 0.024478 0 0.277636 -0.0172856 0 0.34771 -0.00713374 0 0.0667706 4.52002e-05 0 + 0.27485 -0.0111608 0 0.0748447 5.8498e-05 0 0.161812 -0.00687509 0 0.223359 -0.0285372 0 + 0.306418 -0.140963 0 0.345377 -0.0384147 0 0.271256 -0.000882396 0 0.0252733 0.0062901 0 + 0.333931 -0.0337756 0 0.268737 -0.000901558 0 0.222105 -0.0126668 0 0.0216171 -0.00180119 0 + 0.318739 0.154873 0 0.227315 -0.0144856 0 0.296531 -0.000264887 0 0.162068 -0.0138102 0 + 0.195808 0.0853072 0 0.109233 0.00811212 0 0.0351755 -0.0138388 0 0.325527 -0.0258802 0 + 0.201676 -0.0314301 0 0.217069 0.0432629 0 0.171355 -0.00148219 0 0.232416 -0.0108408 0 + 0.025677 0.0142836 0 0.348645 0.0338867 0 0.226808 0.0126411 0 0.24607 -0.0907956 0 + 0.0426763 3.01961e-05 0 0.118066 -0.000808694 0 0.340497 0.0671822 0 0.254434 -0.0586775 0 + 0.268496 -0.0112047 0 0.32959 0.184624 0 0.228145 -0.0354869 0 0.0317377 -0.0498936 0 + 0.228039 0.0396312 0 0.0291732 0.00862848 0 0.139439 -0.0179361 0 0.149218 0.0101595 0 + 0.0305527 3.82638e-05 0 0.107383 -0.000577843 0 0.211552 -0.0321978 0 0.23247 0.0133738 0 + 0.32997 -0.0184385 0 0.230479 -0.0374151 0 0.274143 -0.0192477 0 0.19877 0.00257524 0 + 0.240468 -0.00761002 0 0.339793 -0.0360351 0 0.249656 -0.000864593 0 0.265479 0.0571264 0 + 0.257212 -0.00135701 0 -0.0136195 -0.000920719 0 0.232385 0.00708445 0 0.383918 0.0662584 0 + 0.1145 -0.0015762 0 0.053312 0.0177753 0 0.342162 -0.0380235 0 0.246999 -0.000304338 0 + 0.368896 0.0427476 0 -0.0155948 -6.48992e-05 0 0.36847 0.0493158 0 0.168433 -0.00141354 0 + 0.0738379 0.000199153 0 0.234521 -0.00797471 0 0.197994 0.0368855 0 0.191456 -0.00747156 0 + 0.258672 -0.0546009 0 0.216948 0.0324407 0 0.341601 -0.164814 0 0.25458 -0.0159181 0 + 0.122768 -0.00868693 0 0.213181 -0.0120267 0 0.206231 -0.0291068 0 0.33828 -0.163882 0 + 0.145986 -0.109299 0 0.041947 0.0180052 0 -0.00300441 -0.00173005 0 0.155439 -0.00117837 0 + 0.137214 0.0286267 0 0.279976 -0.0137757 0 0.151679 -0.00106779 0 0.248546 0.18184 0 + 0.343167 -0.0296612 0 0.255813 -0.00554677 0 0.12533 0.0310587 0 0.233309 -0.00707571 0 + 0.345272 -0.13885 0 0.243446 0.00743059 0 0.376823 0.00324002 0 -0.0119166 0.000478075 0 + 0.3105 -0.0286079 0 0.193622 -0.00651254 0 -0.00937335 -0.00439729 0 0.186894 0.00319326 0 + 0.36575 0.0184515 0 0.0192948 2.37451e-06 0 0.236653 0.0299701 0 0.321422 -0.0418701 0 + 0.0232702 0.00592023 0 0.251614 0.0471272 0 0.108812 -0.00322226 0 0.213464 0.00536641 0 + 0.143214 -0.0112916 0 0.353852 0.0276746 0 0.293658 -0.0217744 0 0.326878 -0.0401913 0 + 0.1829 0.0106427 0 0.0421926 0.0184068 0 -0.00995952 0.000138424 0 0.0138076 0.000172538 0 + 0.0317019 4.37193e-05 0 0.15738 0.0125895 0 0.350826 0.0191175 0 0.233339 -0.0148837 0 + 0.309831 -0.0158892 0 0.064496 0.0199693 0 0.117794 -0.000564703 0 0.180224 0.00267637 0 + 0.12485 0.0303129 0 -0.0141637 -0.00028659 0 0.0260369 -0.012428 0 0.298047 0.0315489 0 + 0.109586 -0.000477281 0 0.310689 -0.100953 0 0.0736644 -0.00629943 0 0.227391 0.0321694 0 + -0.00283423 0.00708352 0 0.271183 -0.0261355 0 0.295748 -0.0767088 0 0.157056 -0.00450507 0 + 0.290768 0.0421052 0 0.00898174 2.86958e-06 0 0.0346978 -3.53016e-05 0 0.1292 0.00726091 0 + 0.253194 -0.00637149 0 0.189286 0.0261009 0 0.033318 0.0161048 0 0.248016 0.0198327 0 + 0.274854 -0.0112797 0 0.046924 0.0187952 0 0.338228 -0.0273408 0 0.265877 -0.00145139 0 + 0.297347 0.0437965 0 0.341097 0.0267867 0 0.252284 -0.0179429 0 0.331109 -0.145398 0 + 0.362558 -0.0297992 0 0.152888 0.0356745 0 0.0235233 -0.0124604 0 -0.00522235 -0.00636351 0 + 0.186598 0.00349245 0 0.256147 -0.019491 0 0.336532 0.0912936 0 0.349571 -0.0322305 0 + 0.271474 0.0321192 0 0.252105 0.0639109 0 0.37676 0.0710941 0 0.22582 0.171967 0 + 0.242638 -0.0364574 0 0.00864268 0.00189168 0 0.268255 0.0261998 0 0.221339 0.00526017 0 + 0.260378 -0.0123991 0 0.205989 0.124229 0 0.292835 0.0451278 0 0.0314511 -0.0288947 0 + 0.26003 0.0563141 0 0.0870147 0.00236229 0 0.168842 -0.0750107 0 0.0279721 0.0123556 0 + 0.283598 0.0427688 0 0.383879 -0.00563612 0 0.0765403 0.0254812 0 0.105933 0.0151185 0 + 0.10103 -0.0159584 0 0.276138 -0.0115744 0 0.122618 0.0274554 0 0.279956 -0.00146594 0 + 0.207857 -0.0428365 0 0.109031 0.0189127 0 0.321214 -0.169192 0 0.291978 -0.0203001 0 + 0.224358 0.0210941 0 0.137559 -0.000828481 0 0.248555 0.00311211 0 0.111184 -0.00769987 0 + 0.250334 -0.0436924 0 0.1239 0.0227704 0 0.205181 -0.00247519 0 0.232173 -0.0410734 0 + 0.0219427 -6.89009e-05 0 0.192908 0.0296558 0 0.154364 -0.0220915 0 0.252112 -0.000312105 0 + 0.335108 0.0387782 0 0.0343117 2.55168e-05 0 0.279294 -0.0341824 0 0.242964 -0.000404054 0 + 0.218797 0.0177835 0 0.123513 0.0333308 0 0.228305 0.0168409 0 0.306992 0.0349676 0 + 0.199939 0.0386996 0 0.368412 0.0750056 0 0.276885 0.000501647 0 0.145174 0.00643544 0 + 0.177748 -0.00663365 0 0.191333 0.0388337 0 0.255202 0.0201968 0 0.31307 0.0518495 0 + 0.3434 -0.00394979 0 0.209529 0.0394365 0 0.0806288 0.0198519 0 0.12372 0.000919071 0 + 0.333481 -0.0956191 0 0.20476 0.156162 0 0.118526 -0.0133255 0 0.258014 0.125039 0 + 0.247567 0.0225095 0 0.323124 -0.163841 0 0.206357 -0.0427475 0 0.0854768 0.025436 0 + 0.282006 -0.00141071 0 0.205099 0.013774 0 0.284286 -0.00133804 0 0.273817 0.015312 0 + 0.136675 -0.017545 0 0.20979 0.0428205 0 0.111063 -0.0281134 0 0.335151 0.0342141 0 + 0.261873 0.0221587 0 0.0396196 1.15322e-05 0 0.205539 0.0316049 0 0.154265 0.00953706 0 + 0.209565 0.0186983 0 0.1066 0.00898713 0 0.138914 0.00468984 0 0.295261 -0.000197693 0 + 0.200681 0.0154306 0 0.263607 0.0562565 0 0.260371 0.146527 0 0.219979 0.0468576 0 + 0.1419 0.00914913 0 0.0138616 0.00508083 0 0.186708 -0.0115398 0 0.255283 0.198635 0 + 0.128168 0.00519466 0 0.0327625 -0.00962723 0 0.260122 -0.00286622 0 0.383476 0.0403329 0 + 0.301305 0.0273955 0 0.173671 0.0378986 0 0.281318 -0.0198877 0 -0.0123202 0.00154858 0 + 0.0919311 -0.11131 0 0.13998 0.0351664 0 0.0082101 -4.9612e-05 0 0.230042 -0.0280318 0 + 0.0597366 0.0178739 0 0.0411325 3.13844e-05 0 -0.0079768 0.006574 0 0.250765 0.0351508 0 + 0.249351 0.055184 0 0.341865 -0.0269981 0 0.325525 0.0978307 0 0.104654 -0.00295843 0 + 0.210191 0.115708 0 0.0419062 0.0177352 0 -0.0124217 2.81998e-05 0 0.161354 0.0081338 0 + 0.337393 0.0407118 0 0.123699 -0.00348657 0 0.0214002 -3.29841e-05 0 0.0212696 -3.66288e-05 0 + 0.0144124 -0.00573484 0 0.294646 -0.0415413 0 0.032975 -6.68151e-05 0 0.317356 0.058948 0 + 0.186093 -0.00821986 0 0.146418 0.0128717 0 0.083599 0.000142078 0 0.264051 -0.0377447 0 + 0.215468 0.00957083 0 0.273176 0.0242676 0 0.314613 -0.0240265 0 0.00819318 -2.98471e-06 0 + 0.198075 0.0433231 0 0.167875 0.0399137 0 0.390193 -0.0272041 0 0.207603 0.0128109 0 + 0.0955814 0.0249219 0 0.270287 -0.000145679 0 0.207715 0.0333217 0 0.283208 -0.0217216 0 + -0.00245544 0.00919699 0 0.110547 0.0109313 0 0.138483 0.00609328 0 0.335575 0.0361081 0 + 0.0165385 -0.0105754 0 0.284509 -0.0133044 0 0.156644 0.0366834 0 0.0379665 -1.69799e-05 0 + 0.300318 -0.179743 0 0.232983 -0.0442991 0 0.284121 0.012332 0 0.169486 0.011194 0 + 0.238451 0.00875618 0 0.220922 -0.0037781 0 -0.0042862 0.00560919 0 0.00614325 0.00364181 0 + 0.283676 -0.00748479 0 0.168161 0.0120002 0 0.317493 0.0462747 0 0.3246 0.0737728 0 + 0.110454 -0.0159012 0 0.237638 0.0108793 0 0.239515 0.0341956 0 0.108006 -0.00126411 0 + -0.00830696 0.00252612 0 0.163554 0.00828815 0 0.175948 -0.0367624 0 0.222087 -0.00646184 0 + 0.00729262 0.0229223 0 0.282615 0.0207319 0 0.257106 0.0707987 0 0.10881 0.0262132 0 + 0.289444 0.100536 0 0.012828 0.0100684 0 -0.0109899 -0.00332967 0 0.172306 -0.00604378 0 + 0.218297 0.00531112 0 0.274078 0.000599705 0 0.124085 -0.031151 0 0.324669 -0.173161 0 + 0.0127731 0.0349131 0 -0.00557728 -0.00506515 0 0.151484 -0.00585285 0 -0.0021517 -0.00781299 0 + 0.284774 -0.0158287 0 0.0564688 -0.000613569 0 0.343262 0.0252847 0 0.079396 0.0204861 0 + 0.321919 -0.0395038 0 0.368793 -0.0235812 0 0.25003 -0.0187067 0 0.0948457 0.134904 0 + 0.229088 -0.000130299 0 0.33206 -0.0378123 0 0.0425204 -7.13619e-05 0 0.00203066 -0.00677749 0 + 0.160005 -0.00668916 0 0.15597 0.013442 0 0.086267 -0.000255754 0 0.142865 -0.000267967 0 + 0.238003 -0.0636065 0 0.301257 0.102822 0 0.154207 -0.021245 0 0.207738 0.0127992 0 + 0.0875709 0.0253101 0 0.278133 0.0270952 0 0.189136 0.0192279 0 0.0970147 0.00845614 0 + 0.14616 -0.0337936 0 0.100554 -0.00206689 0 0.0262802 -0.00400817 0 0.141214 0.017691 0 + 0.337161 -0.0891087 0 -0.000483309 0.00110445 0 0.252761 -0.0183516 0 0.207844 -0.00258229 0 + 0.0630148 -0.000179193 0 0.138059 -0.00254111 0 0.285705 -0.0441424 0 0.246012 -0.000231249 0 + 0.266051 -0.0122219 0 0.198891 -0.0107156 0 0.34996 0.0241996 0 0.228433 -0.0248541 0 + 0.251376 0.015873 0 0.0833118 0.0236182 0 0.264843 0.00778824 0 0.314103 -0.0181071 0 + 0.00639104 -0.00160215 0 0.162101 -0.017509 0 0.349358 -0.136687 0 0.21945 -0.00629042 0 + 0.263995 -0.016509 0 0.15634 0.0388727 0 0.357763 -0.158001 0 0.147459 -0.0404456 0 + 0.166172 -0.0336595 0 0.159714 -0.0158347 0 0.117004 -0.00266461 0 0.353683 -0.0835789 0 + 0.273396 0.157452 0 0.167764 0.00987894 0 0.25322 -0.0106392 0 0.174659 0.0315161 0 + -0.0107842 0.000903357 0 0.363492 0.023763 0 0.297983 0.0336939 0 0.207038 -0.0391014 0 + -0.0122965 -0.00216677 0 0.0903892 -0.02478 0 0.207962 0.0103206 0 0.103046 -0.0277495 0 + 0.0919384 0.00219634 0 0.261422 0.0175079 0 0.344076 -0.038351 0 0.32979 -0.0257287 0 + 0.370742 -0.023487 0 -0.00414425 0.00953382 0 0.245921 -0.00043387 0 0.253453 -0.000467816 0 + -0.00363309 -0.00118168 0 -0.0060063 -0.00358871 0 0.229836 0.0170908 0 0.075008 -0.00258565 0 + 0.00458226 -0.00346546 0 0.0649536 5.36952e-05 0 0.128071 -0.0134282 0 0.197765 0.0104256 0 + 0.32534 -0.03821 0 0.120562 0.0133159 0 0.0693702 0.00430705 0 0.317644 -0.0503155 0 + 0.200471 0.00885934 0 0.320114 0.189039 0 0.179712 -0.00878347 0 0.22736 -0.000103773 0 + 0.256663 0.0813478 0 0.0699054 0.018017 0 0.153022 0.0178901 0 0.227209 -0.00767754 0 + 0.285602 0.0129905 0 0.212856 0.0146298 0 0.118783 0.000924014 0 0.0781287 -9.54582e-05 0 + 0.269257 -0.192357 0 0.163083 0.0161676 0 0.38086 -0.0254486 0 0.28552 -0.0583007 0 + 0.071799 7.53603e-05 0 0.209035 -0.00901002 0 -0.00861389 0.00170359 0 0.146612 0.00160175 0 + 0.168925 0.0259152 0 0.371495 -0.00163194 0 0.0284111 0.00245703 0 0.321489 0.0304244 0 + 0.136671 0.0197458 0 0.238466 0.0575913 0 0.0596268 0.0160554 0 0.0607832 0.0216557 0 + 0.0725 0.0224381 0 0.0905901 -0.000238494 0 0.231257 -0.0044233 0 0.278389 8.37024e-05 0 + 0.329993 0.00202046 0 0.280114 -0.0141543 0 0.275532 0.000425762 0 0.253805 0.12825 0 + 0.317136 -0.0366549 0 0.326625 -0.0412144 0 0.179471 -0.0150766 0 0.252639 0.00284065 0 + 0.291525 0.0331665 0 -0.000188363 0.000783227 0 -0.00645064 -0.00201083 0 0.105868 -0.000453784 0 + -0.0132822 -0.000951858 0 0.240892 0.00887246 0 0.291523 0.00869734 0 0.019138 -1.3402e-05 0 + 0.0197298 -1.605e-05 0 0.026838 -0.00854009 0 0.277847 0.0463529 0 -0.000487741 0.000736496 0 + 0.0811183 -0.0686823 0 0.0557566 -0.000559072 0 0.198934 -0.00228332 0 0.270647 -0.0173244 0 + 0.33173 0.0509736 0 0.0685036 0.0185927 0 0.21723 0.0465793 0 0.272613 -0.0199661 0 + 0.386658 0.123535 0 0.357027 0.124803 0 0.133253 0.0201326 0 0.346162 0.0379114 0 + 0.103962 -0.0564533 0 0.0726278 -0.000233184 0 0.0188834 1.18769e-05 0 0.245849 -0.0170292 0 + 0.102658 -0.00040238 0 0.19469 0.0175262 0 0.0458025 0.00789605 0 0.220864 0.0140909 0 + 0.145416 0.0262661 0 0.337252 0.0416869 0 0.0580894 0.0165804 0 0.119977 0.00350312 0 + 0.00410535 0.00520463 0 0.181902 -0.037629 0 0.0500282 0.0140931 0 0.270488 -0.0439293 0 + 0.249591 -0.043643 0 0.254469 -0.152863 0 0.0613103 0.001566 0 0.296801 -0.000258111 0 + 0.261912 -0.0378591 0 0.180218 -0.00752995 0 0.0355234 0.0730536 0 0.344587 -0.036276 0 + 0.166956 0.0395564 0 0.179906 -0.0163239 0 0.129296 -0.000237082 0 0.301425 -0.0174684 0 + 0.375315 -0.0157562 0 0.0889811 -0.0229413 0 0.249098 -0.060151 0 0.0454201 6.35591e-05 0 + 0.0228628 -7.28457e-05 0 0.0860593 -0.0181523 0 0.0621438 -2.79848e-05 0 0.282663 -0.0153636 0 + 0.139357 0.000868156 0 0.24227 -0.000239999 0 0.221906 0.108292 0 0.267972 -0.0239279 0 + 0.261441 0.00277499 0 0.372764 0.0619776 0 0.326196 -0.041482 0 0.0656271 -0.0189926 0 + -0.013906 0.000221013 0 0.215573 0.0147962 0 0.296332 0.00949497 0 0.282011 -0.0155969 0 + 0.375562 -0.0261961 0 0.281216 -0.00149019 0 -0.00138427 0.00617091 0 0.165752 -0.127016 0 + 0.240144 -0.0162686 0 0.276941 0.000476191 0 0.301342 0.026262 0 0.36775 -0.0754545 0 + 0.102768 0.0205615 0 0.380002 0.126242 0 0.256319 -0.0272987 0 0.387152 -0.0225686 0 + 0.0896345 -0.0859709 0 0.0648444 0.0118557 0 0.232955 -0.0511115 0 0.197341 0.0348637 0 + 0.250039 -0.0431073 0 0.177924 -0.00945318 0 0.326985 -0.00978547 0 0.196056 -0.00999384 0 + 0.244247 -0.0218511 0 0.0512983 0.0192072 0 0.0511587 0.0195506 0 0.111332 -0.000328062 0 + 0.104871 -6.35489e-05 0 0.331863 -0.0438626 0 0.170455 0.175091 0 0.055811 0.000580814 0 + 0.330483 -0.0148018 0 0.0484952 0.0146446 0 0.256257 0.033056 0 0.0531391 0.00936982 0 + 0.282134 0.00565782 0 0.329163 0.0327403 0 0.0835707 -0.00204176 0 0.289165 -0.0849613 0 + 0.346208 0.0135756 0 0.26669 -0.0436837 0 0.136842 0.00228869 0 0.34356 0.0156803 0 + 0.369029 0.0119312 0 0.284766 -0.016125 0 0.246505 0.0123479 0 0.330851 0.0066394 0 + 0.290248 0.0445324 0 0.0413365 0.0122523 0 0.0162604 4.75059e-06 0 0.339356 0.0363196 0 + 0.198491 0.0377531 0 0.206582 0.183136 0 0.218781 0.0165607 0 0.284818 -0.0230082 0 + 0.279492 -0.0347396 0 0.0848673 0.0064269 0 0.186432 0.000227367 0 0.251904 -0.0109543 0 + 0.227964 -0.0334293 0 0.249381 -0.0123311 0 0.260412 -0.0185909 0 0.0396681 0.012732 0 + 0.0421454 -0.0118083 0 0.22428 0.00617979 0 0.203892 0.0439753 0 0.0805071 0.026273 0 + 0.140185 -0.00105769 0 0.245613 -0.0427136 0 0.314224 0.0954705 0 0.0117739 0.0103593 0 + 0.2225 0.0950221 0 0.149607 -0.0279119 0 0.0956987 0.000483094 0 -0.00691569 0.00595782 0 + -0.000431812 0.00108109 0 -0.00304744 -0.00443673 0 0.16341 -0.00566845 0 0.268827 -0.00471301 0 + 0.19905 0.170231 0 0.251296 0.00270728 0 0.234405 -0.000216713 0 0.276573 -0.00481552 0 + 0.222716 0.12213 0 0.278788 -0.000133065 0 0.257008 -0.0575138 0 -0.0140705 0.00119795 0 + 0.279026 -0.0012198 0 0.174797 0.0144732 0 0.2469 -0.00552874 0 0.178728 -0.0016515 0 + 0.125508 0.0338939 0 0.262928 -0.0722938 0 0.293666 0.00151239 0 -0.00130174 -0.00845282 0 + 0.227951 -0.0417558 0 0.282762 8.08865e-05 0 0.143905 0.021436 0 0.253694 -0.059522 0 + -0.000513324 0.00106684 0 0.112768 0.0322862 0 0.111973 0.00409463 0 0.22373 -0.00777987 0 + 0.0424548 6.51979e-05 0 0.00928039 -0.000659653 0 0.00859287 0.000587655 0 0.0990965 -0.0267678 0 + 0.173176 -0.00918065 0 0.298067 0.032482 0 0.116693 0.0124383 0 0.296762 0.0490221 0 + 0.126945 0.0134892 0 0.274608 0.0212003 0 0.108208 -0.0272985 0 0.0332699 0.0104017 0 + -5.03324e-05 0.000239498 0 0.277518 -0.0021 0 0.175832 -0.00157772 0 0.00540556 -0.0130582 0 + -0.0161351 0.000247545 0 0.272735 -0.011971 0 0.190229 -0.0351686 0 0.131003 0.0158642 0 + 0.112674 0.0320902 0 0.251597 -0.183355 0 0.185032 -0.169798 0 0.029898 0.000320054 0 + 0.345426 -0.021058 0 0.0762258 6.45721e-05 0 0.254913 -0.00466899 0 -0.000593896 -0.00116247 0 + 0.069908 -0.00172677 0 0.0539965 0.00995201 0 0.325791 -0.0342984 0 0.353184 0.127754 0 + 0.0194212 0.00701344 0 0.113181 0.00414844 0 0.0400164 -4.1779e-05 0 0.231416 0.0500567 0 + -0.000376499 -0.00105878 0 0.0825398 0.000266194 0 0.321623 -0.0413375 0 0.382397 0.0873122 0 + 0.0457037 0.000470988 0 0.272582 -0.134248 0 0.000430796 -0.00228981 0 0.278455 0.000417803 0 + 0.379315 -0.0654622 0 0.223085 -0.0412218 0 0.369412 0.0147855 0 0.121096 -0.0243619 0 + 0.250519 0.00453727 0 0.254262 -0.0127224 0 0.236081 0.0123417 0 0.312497 0.0287138 0 + 0.113687 0.0108579 0 0.0397353 -3.70509e-05 0 -0.00466486 0.0048855 0 0.19279 0.0354884 0 + 0.248839 0.0618537 0 0.000140888 -5.65588e-06 0 0.137744 -0.00380051 0 0.152178 -0.00308972 0 + 0.256443 0.00450166 0 0.223005 0.0148675 0 0.219991 -0.0395424 0 0.346766 0.0349553 0 + -0.000298932 -0.000447243 0 0.102797 0.00867528 0 0.281909 0.152759 0 0.00246614 0.00651289 0 + 0.213487 0.0147227 0 0.276386 0.000365702 0 0.279759 0.00030018 0 0.313402 0.0737961 0 + 0.255855 0.0045411 0 0.378958 -0.00669601 0 0.268717 -0.00371323 0 0.290524 -0.000814407 0 + 0.181276 -0.0335057 0 0.288787 -0.00065393 0 0.188692 -0.0187712 0 0.0618274 0.0211157 0 + 0.189588 -0.0211675 0 0.231441 0.0226342 0 0.123913 0.019892 0 -0.00989532 -0.00168273 0 + 0.267297 0.0309802 0 0.231139 0.0193024 0 0.0687097 0.0167066 0 0.031269 9.33682e-06 0 + 0.386998 -0.0530793 0 0.239898 0.0459362 0 0.201938 -0.000436309 0 0.325118 -0.0425995 0 + 0.143307 -0.000928636 0 0.0191861 -0.00177189 0 0.364492 0.106117 0 0.178927 -0.0140076 0 + 0.163861 0.0301732 0 0.276021 -0.0787471 0 0.218511 0.0355225 0 0.247295 0.01334 0 + 0.205366 -0.0399322 0 -0.00777419 -0.000591943 0 0.296033 0.088034 0 0.309835 0.191741 0 + 0.236348 0.0147112 0 0.259792 -0.0429286 0 -0.000356502 0.000996963 0 0.179222 -0.00736317 0 + 0.327767 -0.0238035 0 -0.000476639 -0.00108174 0 0.239768 -0.0108405 0 0.236673 0.0358342 0 + 0.138773 0.0358698 0 0.224533 -0.00932974 0 0.15306 0.0215945 0 0.276528 -0.00220239 0 + 0.0228006 -0.000374348 0 0.100523 0.00323944 0 0.0644637 -6.93996e-05 0 -0.00350934 -0.00443958 0 + 0.0314636 0.0108164 0 0.374235 0.0142156 0 0.107304 0.0188057 0 -0.000436601 -0.00109636 0 + 0.278641 -0.143649 0 0.26527 -0.0122393 0 0.257906 -0.000869481 0 0.0225596 0.0122064 0 + 0.288636 0.0710993 0 0.296804 -0.0438409 0 0.125898 0.0341983 0 -6.58458e-05 0.000382345 0 + -0.000100883 0.000539786 0 0.270339 -0.0118784 0 0.348772 -0.0200472 0 0.325536 -0.0423234 0 + 0.0203651 -0.00159433 0 -0.000516109 -0.000913428 0 0.363622 -0.0281671 0 0.0035783 0.00725348 0 + -0.000432625 0.000621953 0 0.200035 -0.039234 0 -0.000521087 0.0010027 0 0.334021 0.0124169 0 + 0.1897 -0.00921203 0 0.243802 0.019062 0 0.214389 0.0150097 0 0.20927 -0.000250795 0 + 0.171649 -0.00707173 0 0.134847 -0.000790146 0 0.164295 -0.00563998 0 0.01014 -0.0156656 0 + 0.129075 0.0251785 0 0.190996 -0.00199623 0 0.390492 -0.0401928 0 0.246228 0.0246657 0 + 0.289128 0.147134 0 0.0897876 -0.00167556 0 -0.00844185 -0.00399228 0 0.168968 0.00173209 0 + 0.0328736 9.66425e-06 0 0.0536354 0.0136543 0 0.396302 0.0592159 0 0.263782 -0.00303252 0 + 0.174017 0.0284042 0 0.343894 0.0208095 0 0.13289 0.00986846 0 0.250405 0.00472113 0 + 0.0693811 -0.069819 0 0.0400352 -4.09087e-05 0 0.240905 0.00277082 0 -0.00373566 0.00775979 0 + 0.278558 0.000151977 0 0.19868 -0.0262912 0 0.277133 -0.0210845 0 0.226189 -0.00422901 0 + 0.217701 -0.149324 0 0.0169683 -3.50125e-06 0 0.0174112 -7.25459e-06 0 0.242404 0.053377 0 + 0.00134423 -0.00184012 0 0.319901 0.031489 0 0.0679476 0.0131017 0 0.0178458 1.93945e-06 0 + 0.211133 -0.0263042 0 0.0190019 -2.19318e-05 0 0.0185338 -3.15983e-06 0 0.32474 0.0440044 0 + -0.000898464 0.00214052 0 0.265059 -0.000189841 0 0.0682784 -0.000112793 0 0.224569 -0.0378296 0 + 0.372332 -0.0161643 0 0.235177 0.0562352 0 0.246353 0.0634628 0 0.170319 -0.00715262 0 + 0.197595 -0.023766 0 0.0369039 -0.0228986 0 -0.000232797 -0.000905907 0 -0.000158412 -0.000237658 0 + 0.277354 -0.00144026 0 0.244805 -0.0155929 0 0.284329 0.000129785 0 0.286927 1.08566e-05 0 + 0.388643 -0.0211642 0 -0.00097087 0.00212068 0 0.134045 -0.00503287 0 0.0550138 0.0121276 0 + 0.0643972 0.0140887 0 0.273557 -0.124818 0 0.207619 -0.0118669 0 0.216961 -0.0259817 0 + 0.285675 -0.152803 0 0.0207378 0.00961574 0 0.142235 0.0369576 0 0.299074 -0.178979 0 + 0.381648 -0.119576 0 0.215065 0.0113672 0 0.19711 -0.0403855 0 -0.00264363 -0.00658332 0 + 0.378507 -0.12821 0 0.249314 0.00402044 0 0.340815 -0.0248441 0 0.298002 -0.0303497 0 + -0.00125453 0.00151279 0 0.0889056 0.00030879 0 0.229913 -0.165497 0 0.3617 0.00389092 0 + 0.0259739 0.00868746 0 0.0176058 -1.01892e-05 0 0.306671 0.0439529 0 0.124819 0.0090068 0 + 0.174981 -0.0216837 0 0.265051 -0.0386351 0 0.00929283 -0.00347038 0 0.161203 0.140215 0 + 0.318592 -0.0174533 0 0.0666165 7.20471e-05 0 0.281221 -0.174234 0 0.00814687 6.9944e-06 0 + 0.058293 -4.19858e-05 0 0.256828 -0.0161258 0 0.247704 -0.0654585 0 0.0016082 -0.00718391 0 + -0.00495813 0.000438655 0 0.0241882 0.00908909 0 -0.000561403 -0.000934492 0 -0.00043286 -0.000634117 0 + 0.341872 -0.020722 0 0.212754 -0.0398749 0 0.284626 0.158515 0 0.0146164 -0.00279157 0 + 0.222334 -0.022541 0 0.241898 0.0462914 0 0.257566 0.0110717 0 0.0537541 -4.34159e-05 0 + 0.189124 0.003233 0 0.210503 0.0247045 0 0.25603 -0.070564 0 0.191964 -0.0103859 0 + 0.349046 0.0798755 0 0.301732 -0.0552605 0 0.29552 -0.014816 0 0.273089 0.0112371 0 + 0.321546 -0.0381387 0 0.157796 0.0242462 0 -0.015549 -6.96635e-05 0 0.266814 -0.0120942 0 + 0.340513 -0.0111621 0 0.257855 0.0618678 0 0.268431 -0.099509 0 0.0569677 -0.0096989 0 + 0.275029 0.000533186 0 0.13744 0.0130328 0 0.271373 0.0361414 0 0.114748 -0.146031 0 + 0.184928 -0.0309893 0 0.243129 0.130195 0 0.155183 -0.00805678 0 0.295917 -0.00399041 0 + 0.275652 0.0604186 0 0.19296 -0.0371746 0 0.260793 -0.00234919 0 0.221502 0.0468659 0 + 0.0100894 0.00439336 0 0.200911 0.0390891 0 0.00165815 -0.000944104 0 0.373247 -0.0081474 0 + 0.237773 -0.0316803 0 0.254764 -0.0480141 0 0.141817 0.0185391 0 0.234508 -0.0608497 0 + 0.265197 -0.00441526 0 0.312658 -0.0388788 0 -0.000355087 0.000480288 0 0.154231 0.00168731 0 + 0.287047 0.135697 0 0.141118 -0.00548551 0 0.255288 0.0727767 0 0.00106799 0.00758109 0 + 0.274613 0.0459881 0 0.0887554 -0.00516965 0 0.123257 -0.0240516 0 0.266942 -0.00466313 0 + 0.396347 0.086925 0 0.0505702 -9.67026e-05 0 0.268816 0.0432705 0 0.248637 0.0304579 0 + 0.0534292 -0.0191073 0 0.306528 0.0974797 0 0.028966 0.0041805 0 0.260966 -0.0014377 0 + 0.249806 0.0581649 0 0.309498 -0.0277276 0 0.153215 -0.0063487 0 0.271818 -0.000491528 0 + 0.0416344 -0.00580206 0 0.229814 0.0287336 0 0.105952 0.0186706 0 0.293763 0.0339175 0 + 0.147782 -0.00278546 0 0.196988 -0.0150414 0 0.169362 -0.00675978 0 0.0413171 -0.00611363 0 + 0.389841 0.0954008 0 0.252202 -0.0285709 0 0.0146386 -0.0151066 0 0.00416721 -0.0113487 0 + 0.383323 -0.111039 0 0.301206 -0.191565 0 0.295823 0.0330355 0 0.36029 -0.131069 0 + 0.131261 -0.00440129 0 0.211335 0.0163531 0 0.171339 -0.00790531 0 0.273586 0.0157966 0 + 0.0969439 0.00758705 0 0.377121 0.13487 0 0.0965532 -0.0273564 0 0.235005 -0.00272526 0 + 0.24204 0.0219373 0 0.250586 -0.000926247 0 0.242872 0.0474099 0 0.000472657 -0.000275825 0 + 0.275352 -0.00230804 0 -0.000116736 0.000174012 0 0.0739728 -0.0212238 0 0.196504 -0.00815313 0 + 0.299647 0.192103 0 0.318073 0.0221279 0 0.290131 -0.0215105 0 0.0397505 5.33352e-05 0 + 0.199407 0.0220991 0 0.127993 -0.160922 0 0.103734 -0.0101632 0 0.186449 0.0409879 0 + 0.207105 0.00444534 0 0.281831 0.0970873 0 0.39294 0.105008 0 0.313199 -0.0297321 0 + 0.167815 -0.00173058 0 0.282716 0.123579 0 0.163676 0.0250978 0 0.286375 0.0156021 0 + 0.254736 0.0694441 0 0.0770054 0.000263032 0 0.231985 -0.0161824 0 0.306108 0.0396929 0 + 0.211753 0.0504844 0 0.339891 0.0887925 0 0.310079 -0.0131687 0 0.251096 -0.0632868 0 + 0.336543 -0.040602 0 0.129144 -0.000798889 0 0.249688 -0.0173995 0 -0.00189424 0.00479747 0 + 0.359028 0.0779212 0 0.0130409 0.00243549 0 0.213978 0.0427584 0 0.142826 -0.125529 0 + 0.309932 0.142433 0 0.146636 0.0227735 0 0.10096 0.02526 0 0.28915 0.190321 0 + 0.260074 0.0325592 0 0.02142 -0.00019305 0 0.185693 0.00853989 0 0.211055 0.0430402 0 + 0.188265 0.111364 0 0.277431 0.00554181 0 0.273041 0.000386918 0 0.203599 -0.00480253 0 + 0.29315 0.101751 0 0.122667 0.0104659 0 0.0826132 -0.0233515 0 0.302302 0.0406156 0 + 0.235583 0.0403875 0 0.308149 -0.0283186 0 0.296001 -0.0218376 0 -0.00811004 -0.0014661 0 + -0.00617224 0.00717422 0 -0.012038 0.00215294 0 0.282519 -0.190926 0 0.124859 -0.000657844 0 + -0.00410146 -0.00265112 0 0.129863 -0.00203317 0 0.20041 -0.000194155 0 0.0321299 -0.0142236 0 + 0.302305 -0.157391 0 0.14409 0.0231114 0 0.0525103 0.000874377 0 0.331094 -0.0417455 0 + 0.0168193 0.0011196 0 0.289115 -0.000936071 0 0.212359 -0.0439046 0 0.0321681 0.00710307 0 + 0.246628 -0.0360505 0 0.173269 0.0284487 0 0.136025 0.0101895 0 -0.012148 -0.00143026 0 + 0.268373 -0.0247913 0 0.204991 0.00378992 0 0.267724 -0.0246717 0 0.233432 -0.200159 0 + -0.00106928 0.00221722 0 0.0561781 0.0158147 0 0.0270307 -0.00784998 0 0.122905 0.0164565 0 + 0.23909 -0.0639813 0 0.156498 0.011078 0 0.332016 0.00439114 0 0.122061 -0.0139211 0 + 0.181526 -0.00866514 0 0.348866 0.0798881 0 -0.000863676 0.00132212 0 0.255177 -0.172546 0 + 0.264131 -0.0128531 0 0.217904 -0.00356597 0 0.00397375 -0.0014322 0 0.152759 -0.0046237 0 + 0.266308 -0.0151139 0 0.226396 -0.00556195 0 0.265604 0.190663 0 0.275585 0.000667765 0 + 0.110455 -0.0109914 0 0.238166 0.0303956 0 0.244715 0.0276004 0 0.083269 0.000979178 0 + -0.00385566 0.00415299 0 0.25584 0.00574468 0 0.0272538 0.00830323 0 0.20086 -0.0110241 0 + 0.0566069 5.20743e-05 0 0.118197 0.00849879 0 0.209099 -0.179131 0 0.00648118 -0.0129953 0 + 0.254837 0.0638276 0 0.100943 0.0134152 0 0.298752 0.00900637 0 0.0523361 -0.0895117 0 + 0.0420328 -1.10695e-05 0 0.0535287 7.92938e-07 0 -0.000672993 -0.00507916 0 0.318197 0.00391466 0 + -0.00473601 0.00932562 0 0.0407305 -0.00562139 0 0.105128 -0.126151 0 0.322462 0.00944665 0 + -0.0136131 0.00194254 0 0.238104 -0.00885064 0 0.307217 0.146948 0 0.319216 -0.1865 0 + 0.0410626 2.83238e-05 0 0.231733 0.0463763 0 0.270367 0.0298288 0 0.336776 -0.0200746 0 + 0.162985 -0.00732094 0 0.325244 -0.027714 0 0.269079 -0.00409412 0 0.241512 -0.0230785 0 + 0.249496 0.00354869 0 0.247378 0.0334604 0 -0.0134378 -0.000922408 0 0.315547 -0.0965422 0 + 0.0789292 0.0178334 0 -0.00287779 -0.00908254 0 0.0367707 0.01036 0 0.260203 0.0478588 0 + 0.30276 0.0978584 0 0.247771 -0.000253221 0 0.0608439 -6.84193e-05 0 0.0175345 -0.00622523 0 + 0.00334256 -0.0101519 0 0.222173 -0.0197185 0 0.0128292 0.0166885 0 0.160994 -0.00169165 0 + -0.013612 -0.000109439 0 0.305265 0.102974 0 0.0601378 0.00315227 0 0.300129 -0.0247938 0 + 0.140509 -0.0181915 0 0.281365 -0.019678 0 0.255212 0.0679403 0 0.0552046 0.0175257 0 + 0.327343 -0.0287322 0 0.253901 -0.000428446 0 0.260912 -0.000458253 0 0.0457456 -0.0152518 0 + 0.25832 -0.0824412 0 0.000570208 -0.000412485 0 0.309833 0.013827 0 0.0410363 -7.66376e-06 0 + 0.276348 0.000563808 0 0.265196 -0.0694798 0 0.0915595 0.0214783 0 0.273476 -0.0113182 0 + 0.233819 -0.0209518 0 0.253007 -0.069347 0 0.303372 0.0015468 0 0.165875 0.0367642 0 + 0.277554 -0.00232519 0 0.274113 -0.0171089 0 0.0314982 1.44031e-05 0 0.130908 -0.0265584 0 + 0.267939 0.0287167 0 0.220967 -0.0132008 0 0.302363 -0.025861 0 0.106665 0.00508266 0 + 0.0152019 -0.00346272 0 0.183263 0.031964 0 -0.000777181 0.0020326 0 0.00467206 -0.000904673 0 + 0.0905116 0.0222093 0 0.115171 0.00273589 0 0.27165 0.0703451 0 0.259333 -0.0249126 0 + 0.245148 0.0369196 0 0.291038 -0.000756948 0 0.0259909 0.00848768 0 -0.00543236 0.00881223 0 + 0.325999 -0.00207527 0 0.371878 0.0121792 0 0.331147 0.0409285 0 0.280029 0.0200224 0 + 0.12743 -0.016691 0 -0.0125709 -0.000724208 0 0.302883 -0.0261859 0 0.142152 0.0235274 0 + 0.0165286 7.52422e-05 0 -0.00778736 -0.00202355 0 0.294867 0.0595929 0 0.276016 0.000323733 0 + 0.0173888 3.28819e-06 0 0.0172541 1.0503e-05 0 0.0307107 0.0142301 0 0.0261379 -0.0606819 0 + 0.391045 0.0905056 0 0.373538 0.108476 0 0.0370808 -0.0157985 0 0.306767 0.0914468 0 + 0.326051 0.045129 0 0.0168088 -0.0118027 0 0.0432471 -4.19804e-05 0 0.0634296 -1.59411e-05 0 + 0.245238 -0.0125234 0 0.312465 -0.0396413 0 0.280845 5.25087e-05 0 0.206715 0.0161838 0 + 0.000272078 -0.000825493 0 0.093449 0.0256362 0 0.200975 -0.188477 0 0.154756 -0.00112241 0 + 0.000195489 0.000100081 0 0.236047 0.0171802 0 0.0224826 -0.000455238 0 0.00883301 -0.0148465 0 + 0.371763 0.00213107 0 0.31735 -0.0392871 0 0.200751 -0.0419895 0 0.232065 0.05346 0 + 0.253431 0.0665992 0 0.00822654 -0.00130342 0 0.250236 0.0663123 0 0.360102 0.0328582 0 + 0.336052 0.0220346 0 0.170831 0.0385244 0 0.207237 -0.0334543 0 -0.00100631 0.00202501 0 + 0.0310227 0.00335932 0 -0.000138573 0.000610608 0 0.119508 -0.00909663 0 0.039597 0.000115236 0 + 0.39152 0.110698 0 0.263372 0.186433 0 0.00407297 -0.00160615 0 -0.000800027 -0.00210952 0 + 0.0957536 0.0023085 0 0.23145 -0.000249998 0 0.184415 0.0420967 0 0.209263 0.00454663 0 + 0.202667 4.32535e-05 0 0.00864436 0.00493215 0 -0.0104716 -0.00131486 0 0.304693 0.0467328 0 + -0.00107029 -0.00202224 0 0.193117 0.00324731 0 -0.00118683 0.00376405 0 0.0965345 0.0166006 0 + -0.000121424 -0.000622877 0 0.0144284 -0.0186301 0 0.109139 0.0496731 0 0.237957 -0.0174904 0 + 0.23381 -0.0153958 0 0.246169 0.0125696 0 0.105474 -0.0126597 0 0.164405 0.0391574 0 + 0.110607 -0.00229578 0 0.0164491 -0.00582528 0 0.248732 -0.116905 0 0.30281 0.0861889 0 + 0.0546251 -0.000484657 0 0.0143652 -0.0161387 0 0.135933 -0.0129199 0 0.316196 0.0461293 0 + 0.0237592 0.0120721 0 0.334178 0.0417488 0 0.0331118 -0.0141589 0 0.377379 0.00750442 0 + -0.00595907 0.00334281 0 0.0061559 -0.0134908 0 0.366128 0.0215257 0 0.398445 0.0762206 0 + 0.159645 0.0063331 0 0.340238 -0.0821371 0 0.329346 0.0959641 0 -4.05049e-05 -0.000256225 0 + -0.000299844 0.0013009 0 0.0105944 0.00666468 0 0.213997 -0.0160768 0 0.242562 -0.0150485 0 + 0.294724 -0.00178429 0 0.00596789 0.00142611 0 0.235099 -0.0614532 0 0.113905 -0.0293301 0 + 0.216764 0.0322586 0 0.171724 -0.026927 0 0.267054 -0.0106283 0 0.223308 -0.0227865 0 + 0.102835 0.0193792 0 0.134868 0.029446 0 -0.00050198 0.0017945 0 0.266413 0.0545908 0 + 0.222631 0.0430054 0 0.0388649 -0.0130306 0 0.0682487 0.0128364 0 0.348343 0.0369887 0 + 0.256358 0.00427182 0 0.112163 0.0274142 0 0.106607 -0.000162343 0 0.226562 0.0339667 0 + 0.254107 0.0566025 0 0.378599 0.114714 0 0.27999 -0.000258355 0 0.0571347 5.16726e-05 0 + 0.1952 -0.0161542 0 -7.15469e-05 -0.000423519 0 -0.000891734 -0.00213079 0 0.376866 0.00538363 0 + 0.26722 -0.00429705 0 0.124967 -0.00564543 0 0.124191 -0.0716508 0 0.279892 -0.0443438 0 + -0.00648593 -0.00719133 0 0.246993 -0.0573869 0 0.0510388 0.0200873 0 0.218762 -0.0283204 0 + 0.0185447 0.0130034 0 -0.000671283 -0.00197984 0 0.278348 0.000142665 0 0.339142 -0.022524 0 + 0.138556 0.00638377 0 0.0946471 0.0171379 0 0.0775347 0.0259871 0 -0.00707239 0.00603658 0 + 0.252945 0.0671702 0 0.197443 -0.0383576 0 0.153667 -0.0060786 0 0.27125 -0.128026 0 + 0.0164807 -0.00445572 0 0.368764 0.113894 0 0.310623 0.0317245 0 0.199246 0.0211725 0 + 0.153657 -0.00463837 0 -0.000388101 -0.000648552 0 0.336572 0.0416148 0 -0.000188208 0.000905014 0 + 0.0410375 -0.0110593 0 0.0626561 0.0147889 0 0.00627489 0.0137098 0 -0.00379872 0.00254108 0 + 0.215056 0.00165028 0 0.183542 0.00057828 0 0.00303078 -0.00143757 0 0.095111 -0.0205621 0 + 0.2709 -0.00950999 0 0.0402337 -4.89357e-05 0 0.000250485 -0.00280526 0 0.354848 0.0573624 0 + 0.00333129 -0.011259 0 0.028633 0.0144175 0 0.375365 -0.0140636 0 0.0168459 0.00747228 0 + -0.00305774 0.00608796 0 0.0110922 0.00049602 0 0.205649 0.0403623 0 0.138343 0.00918791 0 + 0.140842 0.155448 0 0.181325 -0.0023286 0 0.0887069 0.000300141 0 0.0870415 -0.0402605 0 + 0.358922 -0.0116893 0 0.0327042 -0.0108159 0 0.270632 -0.0152122 0 0.343846 0.0238558 0 + 0.171318 -0.000380846 0 0.268823 0.0648965 0 0.0354006 2.67379e-05 0 0.0984509 -0.000380272 0 + 0.148504 -0.0191718 0 0.225465 0.00614979 0 0.0165897 0.00587671 0 0.191072 -0.0348336 0 + 0.258049 0.0569624 0 0.155532 -0.142439 0 0.00504695 0.00137105 0 0.283085 -0.115861 0 + 0.333603 -0.0134547 0 0.209671 2.27039e-05 0 -0.0143538 -0.000484204 0 0.193134 -0.0103617 0 + 0.0162151 0.00556696 0 0.255015 -0.0175102 0 0.253527 -0.0999265 0 0.195222 -0.00125599 0 + 0.198351 -0.0426443 0 0.266566 -0.00951113 0 0.239994 0.059194 0 0.187554 -0.0362179 0 + 0.228816 0.148606 0 0.110581 -0.000635513 0 0.100733 0.00871423 0 0.298207 0.0314522 0 + 0.276751 0.000284511 0 0.00265452 0.00899589 0 0.0120938 0.000400898 0 0.255052 0.00249115 0 + 0.0578822 3.2426e-05 0 0.23453 -0.00586986 0 0.125868 -0.00182515 0 0.0739077 -0.0163356 0 + 0.317133 0.019761 0 0.247147 -0.00290147 0 0.262264 0.0529904 0 0.340221 -0.0276043 0 + 0.0117054 -5.37205e-05 0 0.293197 0.0318022 0 0.327601 0.0215731 0 0.33587 -0.00675861 0 + 0.0096039 -0.0240084 0 0.170639 -0.0294546 0 0.0422481 2.82381e-05 0 0.264255 -0.0928801 0 + -0.00372441 0.00839527 0 0.0199132 -0.00733789 0 0.366501 0.0937512 0 0.297622 -0.00131781 0 + 0.185434 -0.0103054 0 0.191792 0.0119384 0 0.102799 0.0199283 0 0.0146778 0.0152596 0 + 0.0159806 0.00634556 0 0.27773 0.000440665 0 0.0397848 -0.0159987 0 0.127343 0.0347774 0 + 0.386487 0.113876 0 0.0179608 0.00422772 0 0.315182 0.00826828 0 0.260582 0.00252944 0 + 0.241248 0.0406871 0 0.346787 -0.0172175 0 0.389928 0.0819907 0 0.0167677 -0.0148187 0 + 0.387224 0.0275925 0 0.253831 -0.0524649 0 0.29353 -0.0141349 0 0.266409 -0.00443287 0 + 0.364516 -0.0271112 0 0.260115 -0.000848406 0 0.253196 -0.0234202 0 -0.00102346 -0.00181121 0 + 0.338141 0.0809428 0 0.00956684 9.2926e-06 0 0.209495 0.0420831 0 0.249727 -0.128532 0 + 0.398667 0.0683742 0 0.234062 -0.00467082 0 0.27911 -0.00201134 0 -0.00695502 -0.00170419 0 + 0.158529 -0.022771 0 0.0188596 -3.73947e-06 0 0.280676 -0.116836 0 0.0453583 0.0715574 0 + 0.101576 0.134963 0 0.284328 1.56728e-05 0 0.07574 -0.0210269 0 0.0107687 -0.00323625 0 + 0.256732 0.0507165 0 0.162032 -0.177051 0 0.183651 -0.00507102 0 0.257748 -0.0399988 0 + -0.00966246 -0.00107649 0 0.276057 0.000463459 0 0.147583 -0.00416744 0 0.263751 0.0775671 0 + 0.340632 0.0183064 0 0.256201 0.183937 0 0.33855 0.0346908 0 0.318003 0.0942017 0 + 0.00071169 -0.000303391 0 9.60009e-05 0.000151262 0 0.00514982 0.00165278 0 0.221221 0.198482 0 + 0.160625 0.0244068 0 0.344198 0.0191537 0 0.277628 0.0124479 0 0.0390022 -0.000362038 0 + 0.0678787 0.0156466 0 0.282532 0.0734818 0 0.191976 0.0193373 0 0.227068 -0.03899 0 + 0.000427606 0.0002957 0 0.0403187 0.0106114 0 0.264698 -0.127828 0 0.015259 0.00285413 0 + 0.0163614 0.00503116 0 -0.00679112 -0.001771 0 0.300479 -0.146277 0 0.00603107 -0.00165317 0 + 0.291616 0.0296591 0 0.0830226 0.0172417 0 0.0115003 0.000902945 0 0.250112 -0.165851 0 + 0.288875 -0.000676244 0 0.27272 -0.0997155 0 0.0153583 0.00228866 0 0.00951113 0.00114624 0 + 0.36402 -0.016935 0 0.0376138 -0.0005806 0 0.228182 -0.00731107 0 0.164414 -0.00160645 0 + 0.306848 0.047023 0 0.285925 -0.0200697 0 0.297953 -0.0367189 0 0.212576 -0.00579754 0 + 0.262583 -0.0191678 0 0.158179 0.172273 0 0.279282 -0.00125802 0 0.248686 0.179695 0 + 0.165722 0.0313715 0 -0.000718809 0.00106654 0 0.362442 0.0217048 0 0.0842024 0.0164138 0 + 0.129036 -0.0229982 0 0.236464 0.0865672 0 0.312117 0.0226438 0 0.0155984 -0.00105264 0 + 0.0134278 -0.00102013 0 0.26008 0.0570573 0 0.0722421 -0.0117202 0 0.13982 0.0156743 0 + 0.154159 0.0383805 0 0.224839 0.0372759 0 0.2078 5.52215e-05 0 0.29262 -0.0810913 0 + 0.0945636 0.000336803 0 0.337006 -0.0252966 0 0.290446 0.141423 0 0.293509 -0.000457057 0 + 0.120368 0.0200351 0 0.271683 -0.00358492 0 -0.010144 0.00236197 0 0.00232592 0.00128498 0 + 0.0947971 0.0277903 0 0.0349751 -2.9532e-05 0 0.171999 0.00626178 0 0.118863 -0.0291402 0 + 0.248912 0.0169541 0 0.0158639 -0.00091736 0 -0.0123898 0.00235085 0 0.263878 0.0211294 0 + 0.13002 -0.118194 0 0.302604 -0.130531 0 0.0496949 -7.95285e-05 0 0.263154 -0.0391637 0 + 0.252145 -0.0573924 0 -0.000935027 -0.00151873 0 0.0436234 -8.33419e-05 0 0.110294 -0.125494 0 + 0.18106 0.0106971 0 0.254982 0.11492 0 0.241014 -0.174172 0 0.295119 0.0823029 0 + 0.334037 -0.0175564 0 0.201998 0.0168095 0 0.156301 0.0371393 0 0.26253 0.0459174 0 + -0.00692921 0.00206386 0 0.195408 0.0122563 0 0.337698 -0.169945 0 -0.0119016 -0.000518486 0 + 0.00512078 0.0124506 0 0.314683 -0.00199156 0 0.257609 -0.00466338 0 0.356354 -0.14252 0 + 0.274486 0.0399707 0 0.365351 -0.140259 0 0.105127 0.0185903 0 0.308016 -0.0914399 0 + 0.00889766 -0.00481767 0 0.155373 0.0105052 0 0.281389 -0.0798601 0 -0.0101435 -0.00214482 0 + 0.273531 -0.00145332 0 -0.00110829 0.00207424 0 0.232589 -0.127352 0 0.0188425 0.0121726 0 + -0.000974262 0.00155976 0 0.282574 0.0204629 0 0.373125 -0.00110461 0 -0.0129432 0.00104067 0 + 0.00827124 -0.00533762 0 0.264516 -0.0485461 0 0.00697926 -0.000820497 0 0.27674 0.098247 0 + 0.324872 0.012866 0 0.25424 0.0304665 0 0.000301864 0.00063073 0 0.00931258 -4.47367e-06 0 + 0.277661 0.000247411 0 0.287985 -0.037909 0 0.331741 -0.0412671 0 0.323648 0.0452014 0 + 0.133684 -0.0263371 0 0.0657418 4.55316e-05 0 0.0172796 0.0132046 0 0.120108 -0.0291988 0 + 0.25735 -0.00426897 0 0.327265 0.033239 0 0.0336587 -0.0103615 0 0.278856 0.000393472 0 + 0.216477 -0.0231449 0 0.385753 0.011513 0 0.0181375 -0.00724966 0 -0.00179088 -0.00359938 0 + 0.347022 -0.142922 0 0.18869 0.000616416 0 0.10936 0.000312819 0 0.335207 0.0426882 0 + 0.256456 0.0224117 0 0.196619 -0.00261157 0 0.322362 -0.0197003 0 0.263903 0.0823947 0 + 0.17942 -0.0304855 0 0.256359 0.002041 0 0.286023 -0.0386013 0 0.136809 0.0037626 0 + 0.137706 0.0323492 0 0.183154 0.0103624 0 0.179978 0.022367 0 0.372381 -0.0198409 0 + 0.037554 0.00956275 0 0.294906 0.030951 0 0.276479 -0.00225019 0 0.0794098 0.0148549 0 + 0.247281 0.0519708 0 0.233219 0.175978 0 0.0676934 0.0128642 0 0.000637408 0.000449074 0 + 0.0955287 -0.00197299 0 0.381994 -0.0983728 0 0.290554 0.0772611 0 0.163469 0.0110187 0 + 0.269409 -0.0342086 0 0.286387 -0.000357197 0 0.15792 0.00806749 0 0.0410562 -1.88101e-05 0 + 0.0397235 -2.72867e-05 0 -0.005774 -0.00269307 0 0.0100535 -0.000814471 0 0.00490837 0.0132979 0 + 0.0598338 -0.000901551 0 0.0126017 0.000891177 0 0.268013 -0.0735866 0 -0.000540143 0.000860852 0 + 0.237667 -0.000351561 0 0.275007 0.00036295 0 0.231034 0.0204866 0 0.152287 0.0350371 0 + 0.358884 0.027772 0 0.26282 0.0601593 0 0.0278212 -0.00264147 0 0.00206164 -0.00452635 0 + 0.0544899 -0.017206 0 0.20614 -0.00519348 0 0.277278 0.0686056 0 0.364985 0.135105 0 + 0.0846114 -0.0232393 0 0.0778723 6.3679e-05 0 0.253168 0.0302312 0 0.10492 0.000119787 0 + 0.0971218 0.000100517 0 0.000914862 -0.00304137 0 0.265381 0.0793892 0 0.37388 0.107045 0 + 0.111054 -0.000424089 0 0.146199 -0.17168 0 0.25341 -0.041946 0 0.125677 0.012755 0 + 0.266566 0.00178077 0 0.250696 0.159575 0 0.272248 -0.000892981 0 0.0172126 4.84202e-06 0 + 0.163316 0.0328223 0 0.164141 -0.00742733 0 0.229199 0.00603391 0 0.267747 -0.00358558 0 + 0.263487 0.197651 0 0.27138 0.0958813 0 0.115416 0.00756721 0 0.0502991 -0.0842283 0 + 0.0255717 0.00534951 0 0.367235 0.0318853 0 0.31096 0.0545141 0 0.136064 -0.104495 0 + 0.272412 -0.010073 0 0.244091 0.0208604 0 0.155957 0.00776338 0 0.312988 0.011606 0 + 0.290313 -0.000839495 0 0.29148 0.0183089 0 0.231604 0.0153239 0 0.184931 -0.181334 0 + 0.199127 -0.02911 0 0.216323 0.0155053 0 0.0115607 -0.0261225 0 -0.000157651 0.00836019 0 + 0.389183 -0.0290124 0 0.296915 0.000801937 0 0.0184218 -0.0473175 0 0.0852079 -0.0496951 0 + 0.018475 0.0109149 0 0.113275 0.00215291 0 0.255676 0.0415109 0 0.264094 -0.000755151 0 + 0.22739 -0.0144953 0 0.270345 0.0415809 0 0.255457 0.000953703 0 0.00958956 0.0040047 0 + 0.00197041 0.00898229 0 0.330345 -0.180285 0 0.142237 0.0217731 0 0.253827 -0.110453 0 + 0.273397 -0.0109673 0 0.0393922 0.0056228 0 -4.43837e-05 6.23231e-05 0 0.266506 0.0146744 0 + 0.286978 -0.0719086 0 0.25846 -0.0454801 0 0.0322602 0.00357581 0 0.186617 -0.0158696 0 + 0.0937901 -0.0253557 0 0.302312 -0.0908881 0 0.127083 0.0206842 0 0.200045 -0.00767493 0 + 0.33634 0.0247573 0 0.00204975 0.00796446 0 0.0962384 0.000170585 0 0.102945 0.000206105 0 + 0.164507 0.0231528 0 0.301438 0.0118403 0 0.279337 0.000363953 0 0.0168874 0.0139655 0 + 0.0469602 -0.0149429 0 0.190497 -0.0100909 0 0.277034 -0.0443095 0 0.0580209 0.0106931 0 + 0.169103 -0.00724547 0 0.181078 -0.00993339 0 0.283094 -0.00155703 0 0.296247 -0.0254103 0 + 0.171421 0.000836853 0 0.243112 0.0158346 0 0.0176632 -4.24448e-06 0 0.0161789 7.03876e-07 0 + 0.106816 -0.0472908 0 -0.000118809 0.00029603 0 0.21468 0.0143411 0 0.0186352 -0.0110439 0 + 0.0189977 -1.94753e-05 0 0.0172623 -1.04579e-05 0 0.0176332 -2.2079e-06 0 0.0166931 -9.73632e-06 0 + -0.0152025 0.000727409 0 0.270782 -0.011538 0 0.186858 0.187914 0 0.285774 -0.00102221 0 + 0.293717 -0.101379 0 0.237704 -0.000396311 0 0.228773 -0.000353137 0 0.130097 0.00544964 0 + 0.272524 0.010478 0 0.276463 0.0229183 0 0.0969473 -0.0202493 0 0.0868546 0.00653752 0 + 0.148976 0.0224028 0 0.321255 0.0421662 0 0.275113 -0.020801 0 0.0314403 -0.00628135 0 + 0.278444 0.000208572 0 0.282342 0.000134451 0 0.224273 0.020891 0 0.301338 0.133893 0 + 0.0238763 0.00192875 0 0.336334 0.0205827 0 0.013862 0.00152634 0 0.261022 -0.00294004 0 + 0.0188555 -0.0301238 0 0.0109669 0.0307805 0 -0.00629097 -0.00131882 0 0.248802 0.00281797 0 + 0.248057 -0.0168184 0 0.199397 0.0168694 0 0.208585 0.0221882 0 0.214379 -0.0343056 0 + 0.286728 0.0105627 0 0.14327 -0.0896275 0 0.0952665 -0.00756567 0 0.179721 0.00338414 0 + 0.343566 0.0749942 0 0.33043 -0.139186 0 0.00194205 -0.00779468 0 -0.00197728 -0.00878831 0 + 0.193796 -0.0208293 0 0.275187 0.0218277 0 0.217992 -0.1286 0 0.019809 3.11941e-05 0 + 0.0192685 2.29984e-05 0 0.188548 -0.0632395 0 0.163218 0.054223 0 0.314831 0.0462094 0 + 0.252962 0.0600686 0 0.0350467 0.0585722 0 0.00224539 0.0034895 0 0.291647 0.0029555 0 + 0.000374682 0.00206658 0 0.0512541 -8.89856e-05 0 0.28057 -0.00198895 0 0.206799 0.0230206 0 + 0.388912 0.0152691 0 0.205627 0.00233225 0 0.321436 0.00766332 0 0.211358 0.162079 0 + 0.269377 0.0176049 0 0.0164357 -0.000701915 0 0.0160233 -1.5636e-06 0 0.206837 0.0147715 0 + 0.374488 0.0421654 0 0.25949 0.0018725 0 0.342826 0.0721292 0 0.0182567 -0.0080888 0 + 0.273356 -0.0100222 0 0.263394 0.0571438 0 0.219087 0.016788 0 0.0725546 -0.000206549 0 + 0.276346 0.16658 0 0.0297232 -0.0063664 0 0.389743 0.105462 0 0.273314 -0.013943 0 + 0.0206061 -0.00602166 0 0.266847 0.0503503 0 0.260888 -0.0433025 0 0.183899 -0.023243 0 + 0.253872 0.0327271 0 0.0446122 -6.29412e-05 0 0.324303 0.044383 0 0.0962487 -0.000326548 0 + 0.207097 0.00315033 0 0.258165 0.0699045 0 0.390405 0.115293 0 0.265969 0.0163584 0 + 0.029992 0.0076738 0 0.374106 0.0485905 0 0.0579985 -0.0161944 0 -0.00884532 -0.00248558 0 + 0.275502 -0.0144517 0 0.183008 -0.000184704 0 0.190527 0.0346023 0 0.240256 -0.0028264 0 + 0.293239 -0.00353391 0 0.257558 -0.104052 0 0.261448 0.0107524 0 0.0513102 0.020358 0 + 0.252483 0.163407 0 0.211038 -0.0243335 0 0.270342 -0.0241585 0 0.285609 0.0169562 0 + 0.083559 0.0013885 0 -0.00334675 -0.000522003 0 0.298732 0.0409115 0 0.00758602 -0.0211355 0 + 0.000262636 -0.000299674 0 0.250121 0.0371643 0 0.286394 3.77268e-05 0 0.289043 -5.19817e-05 0 + 0.261461 0.0288399 0 0.335848 -0.040316 0 -0.0146961 0.000141454 0 0.182871 0.0188221 0 + 0.379086 -0.0238817 0 0.270069 -0.187283 0 0.0305011 -0.00529833 0 0.36924 -0.00479547 0 + 0.0170738 1.80482e-05 0 0.110943 -0.000490522 0 0.0174272 2.69441e-06 0 0.215808 0.124871 0 + 0.0185625 -0.0100023 0 0.289589 0.0243939 0 0.00871316 -2.60456e-06 0 0.312494 0.0370527 0 + 0.252547 0.0090749 0 0.25911 0.0778278 0 0.0335013 -0.00491864 0 0.289424 0.0249443 0 + 0.131465 0.00293364 0 0.000679165 0.00373797 0 0.0157756 0.00536248 0 0.0294205 -0.0292244 0 + 0.16125 0.179005 0 0.00702466 0.0141028 0 -0.00176441 0.00415251 0 0.0902708 0.0177875 0 + 0.161433 -0.00297704 0 0.280741 0.000302424 0 0.214612 -0.000270419 0 0.10973 0.021328 0 + -0.0146777 0.000884851 0 0.060759 0.0219623 0 0.00115582 -0.000712666 0 0.261022 0.0798369 0 + 0.250049 0.00321162 0 0.269577 -0.0154482 0 0.385126 -0.0381614 0 0.393958 0.0754291 0 + 0.221909 0.0488161 0 0.188038 -0.0254604 0 0.287416 0.00133961 0 0.304265 0.147425 0 + 0.00156857 0.00690289 0 0.274718 -0.0372449 0 0.270839 -0.0203961 0 0.0183914 -0.00905673 0 + 0.174644 -0.0207213 0 0.329277 0.0227772 0 0.259534 0.0646014 0 0.235022 -0.0382489 0 + 0.294942 -0.188104 0 0.129453 0.00178271 0 0.265195 0.0548236 0 0.379171 0.0630255 0 + 0.00313932 0.00140501 0 0.124965 0.00508819 0 0.335798 -0.127813 0 0.290111 -0.000813342 0 + 0.0400296 -0.0126624 0 0.259198 0.139442 0 0.258679 0.00172555 0 0.290772 -0.000796713 0 + 0.287735 -0.00106867 0 0.259364 0.00291438 0 0.302915 -0.0149036 0 0.197358 0.00384975 0 + 0.263908 0.0184298 0 0.0322659 -4.00177e-05 0 0.236737 0.0171397 0 0.14467 -0.012985 0 + 0.289537 -0.000890121 0 0.241657 0.0362456 0 0.223396 0.00353158 0 0.394996 0.0390959 0 + 0.0399633 0.0164924 0 0.222756 -0.000298715 0 0.282897 -0.102665 0 0.131117 0.011321 0 + 0.234173 -0.0241862 0 0.0139581 0.0156168 0 0.0415046 -0.00503942 0 -0.00379306 -0.00916905 0 + 0.24747 -0.00978982 0 0.287577 -0.00106764 0 0.270954 -0.000837409 0 0.212133 -0.0100348 0 + 0.31517 0.144152 0 0.00912517 0.00342821 0 0.216363 -0.0079399 0 0.0854247 0.0157938 0 + 0.106574 -0.0226241 0 0.143063 0.0037882 0 0.0191113 7.59391e-06 0 0.328822 0.0885101 0 + 0.260975 0.0035291 0 0.155464 0.0387354 0 0.0263837 0.000514846 0 0.018833 -1.14002e-05 0 + 0.239194 -0.0198764 0 0.0601406 -0.000152246 0 0.281275 0.00027244 0 0.258141 0.032849 0 + 0.000998339 0.00077625 0 0.380726 0.0963724 0 0.0672952 -0.0459644 0 0.248344 0.0649846 0 + 0.185001 -0.024924 0 0.221735 -0.0381595 0 0.07429 -0.00166805 0 0.011531 -0.00235434 0 + 0.261035 -0.136725 0 0.277437 0.000202737 0 0.0287013 -0.0308206 0 0.0120495 -0.00134106 0 + 0.266755 -0.00396601 0 0.332926 -0.0208496 0 0.178635 0.00393646 0 0.295805 -0.00023123 0 + 0.0522804 0.00897122 0 0.249602 0.0517982 0 0.232048 -0.00929744 0 0.257711 0.200907 0 + 0.259434 -0.00157167 0 0.203998 -0.0237089 0 0.244469 -0.148597 0 0.256505 -0.0500075 0 + 0.264836 -0.00359613 0 0.030108 -0.0140932 0 -0.0126174 -0.00208604 0 0.158141 -0.0168134 0 + 0.185289 -0.0118302 0 0.192583 0.0935495 0 0.339364 0.0390217 0 0.261872 0.0620049 0 + 0.264938 -0.00161355 0 0.256775 -0.080429 0 0.234557 -0.00630816 0 -0.00859836 -0.000521339 0 + 0.326381 -0.0797094 0 0.335314 -0.0231437 0 0.278868 -0.0232957 0 0.203077 0.00387918 0 + 0.0891889 0.0160157 0 0.265115 0.0286457 0 0.119036 -0.0508827 0 0.0849609 0.0179558 0 + 0.0558444 0.0210059 0 0.115958 -0.000483543 0 0.239301 0.00749243 0 0.283505 -0.0110032 0 + 0.274214 0.0201167 0 -0.0108081 0.00409633 0 0.353151 0.162568 0 0.251702 -0.140469 0 + 0.284257 0.00976444 0 0.0147041 5.89657e-06 0 0.258031 -0.0206233 0 0.260178 0.00300917 0 + 0.121997 -0.0119051 0 -0.00137257 0.00240066 0 0.362635 0.158431 0 0.377545 -0.0113007 0 + 0.262829 -0.0267938 0 0.361807 0.00416548 0 -0.00758558 -0.00307674 0 0.164223 -0.180589 0 + 0.257321 -0.132206 0 0.0326592 -0.0109481 0 0.272319 -0.0233345 0 0.0586221 -0.000810615 0 + 0.191089 0.0351019 0 0.178403 -0.1702 0 0.0777273 -0.000319946 0 0.0609218 -0.000116516 0 + 0.149746 -0.00647954 0 0.0545682 -0.0194973 0 0.269944 0.0218473 0 0.0905947 -0.0059805 0 + 0.271822 -0.00234189 0 0.0945035 0.00813798 0 0.268794 -0.0374142 0 0.275668 0.00255875 0 + 0.339314 0.0556523 0 0.0394929 5.82566e-05 0 -0.0162211 0.000224122 0 0.204172 0.0702451 0 + 0.36747 -0.02484 0 0.165906 0.0188955 0 0.285936 7.07185e-05 0 -0.00386577 0.00954361 0 + 0.389084 -0.0331314 0 -0.000607281 0.00193446 0 0.352339 -0.0932196 0 0.101018 -0.110325 0 + 0.271821 0.0328224 0 0.390738 -0.0927092 0 0.20142 0.141463 0 0.390018 0.0521004 0 + 0.295856 -0.000238592 0 0.280426 -0.00147275 0 0.0589222 -5.79078e-05 0 0.275104 -0.0116672 0 + 0.0539323 -6.37685e-05 0 -0.00498796 -0.00838915 0 0.315054 -0.0418128 0 0.314292 -0.0705453 0 + 0.0408895 -3.09016e-05 0 0.300782 -0.0614267 0 0.199824 0.0120784 0 0.0631294 -0.000242692 0 + 0.00814431 -0.00298814 0 0.0731416 0.0142291 0 -0.00652636 0.00752763 0 0.134225 -0.024535 0 + 0.126168 -0.00294797 0 0.229979 0.0061896 0 0.0997816 0.140063 0 0.282339 0.000219723 0 + 0.25105 0.00292831 0 0.243996 0.0151793 0 0.244971 -0.10597 0 0.348514 -0.163328 0 + 0.0433794 0.0156219 0 0.149066 -0.00120687 0 0.335539 0.0731808 0 0.214497 3.1874e-05 0 + 0.276751 -0.137197 0 0.266235 0.0656205 0 0.210555 -0.123269 0 -0.00179609 0.00394861 0 + 0.2416 0.0030011 0 0.0343943 -0.00817025 0 0.0431142 -0.0156898 0 0.26442 0.0744626 0 + 0.215211 -0.141969 0 0.125486 0.0208049 0 0.27953 0.000344511 0 0.294486 -0.000417599 0 + 0.194372 0.040307 0 0.0125966 -0.026057 0 0.0154615 8.49284e-06 0 0.0161166 -4.22101e-06 0 + 0.0280646 -0.00225797 0 0.270571 -0.0364381 0 0.0321587 -0.00579112 0 0.18993 0.0110577 0 + 0.115745 0.0121645 0 0.115901 -0.000607293 0 0.0438873 5.34352e-05 0 0.126738 0.0346179 0 + 0.279165 -0.133346 0 0.0488298 -0.00811312 0 0.39323 0.0252148 0 0.160335 -0.0351228 0 + 0.161917 0.00729763 0 0.0912304 0.0141169 0 0.310503 0.185706 0 0.165765 -0.0162207 0 + 0.153117 0.172914 0 0.300613 -0.0168702 0 0.250398 0.00304067 0 0.253465 0.00336832 0 + 0.215017 -0.00629854 0 0.235469 -0.156255 0 -0.00589238 -0.00650437 0 0.294687 -0.0857522 0 + 0.084349 -6.4276e-05 0 0.280173 -0.0374981 0 0.241299 0.0136266 0 0.278105 0.000177607 0 + 0.0349912 -0.0235747 0 0.337348 0.0398887 0 0.186261 0.0423859 0 0.370895 -0.0212785 0 + 0.303606 -0.0955971 0 -0.0153891 -0.000196316 0 0.0173434 -0.00228473 0 0.104349 -0.0199053 0 + 0.250302 -0.111088 0 0.230341 0.0171869 0 0.226574 0.0108048 0 0.159171 -0.0060012 0 + 0.242809 0.060175 0 0.367289 0.0488855 0 0.124763 -0.00436191 0 0.325556 0.00771934 0 + 0.255176 -0.00715384 0 0.283934 -0.00133807 0 0.329017 -0.0850778 0 0.221829 0.0451683 0 + 0.389967 0.0969979 0 0.335172 0.0835724 0 0.280055 0.00031534 0 0.268507 -0.012493 0 + 0.394934 0.0958886 0 0.228043 -0.0189035 0 0.321447 -0.0966995 0 0.118645 0.00131592 0 + 0.000217301 0.00817801 0 0.00375306 -0.0147363 0 0.139259 0.0149184 0 0.392423 -0.0746305 0 + 0.133009 -0.00300637 0 0.279472 0.000774514 0 0.264279 0.04613 0 0.304547 0.0373138 0 + 0.162812 -0.0289499 0 0.212881 0.0163673 0 0.274973 -0.0386543 0 0.365116 0.0194312 0 + -0.0136998 0.00110968 0 0.387378 -0.0229723 0 0.30836 -0.0205162 0 0.0572219 0.0102255 0 + 0.101197 0.000403395 0 0.293161 -0.000288552 0 0.017394 0.000843547 0 0.261651 0.00233264 0 + 0.276582 0.152001 0 0.366928 0.127869 0 0.292829 -0.00049892 0 0.0192254 0.00133369 0 + 0.101822 -0.000145508 0 0.383305 -0.0065123 0 0.245961 0.00539222 0 -0.00624436 0.00802115 0 + 0.306002 0.0594133 0 0.0157275 0.00100678 0 0.0716902 -0.000849075 0 0.262249 0.00182629 0 + 0.0334217 -0.0284584 0 0.129661 0.0152031 0 0.385287 -0.0208482 0 0.0947124 -0.0157123 0 + -0.0107366 0.00174091 0 0.24793 0.0470019 0 0.360405 0.00807301 0 0.225288 0.101371 0 + 0.162768 -0.00658365 0 0.225396 0.114735 0 0.00681442 -0.021007 0 0.321215 0.0662987 0 + 0.017903 -1.24957e-05 0 0.317804 0.0423382 0 -0.00656395 0.00745041 0 0.385996 -0.0122152 0 + 0.264077 0.0676952 0 0.0544563 0.0183068 0 0.338693 -0.0389613 0 0.228078 0.0141255 0 + 0.343791 -0.0141584 0 0.252072 -0.0237472 0 0.284551 -0.0170705 0 0.393443 0.0801494 0 + 0.182643 -0.185721 0 0.362923 -0.0193577 0 0.0172067 0.00083973 0 0.332701 0.0353869 0 + 0.126377 0.00174648 0 0.248782 0.0109787 0 0.0314701 -0.00797768 0 0.0427227 -8.89908e-05 0 + 0.205222 0.0250065 0 0.393398 0.106144 0 -0.00735851 0.00711602 0 0.128987 0.0148115 0 + 0.207241 0.148171 0 0.241965 -0.0157082 0 0.0289005 -1.64246e-05 0 0.252038 -0.0119143 0 + 0.307811 0.131932 0 0.273522 -0.0108839 0 0.0816451 -0.0139479 0 -0.00754294 0.00631919 0 + 0.268531 -0.0288208 0 0.239355 -0.000186769 0 0.236505 -0.168738 0 -0.00687654 -0.00377669 0 + -0.000504713 -0.00167043 0 0.374039 0.112132 0 0.0588357 -0.0122276 0 0.259465 -0.0126771 0 + 0.397571 0.0847643 0 0.240725 -0.0162248 0 0.345802 -0.0803904 0 0.284139 0.147017 0 + 0.363525 0.0282808 0 0.119427 -0.139681 0 0.162278 0.126264 0 0.249864 -0.0879644 0 + -0.00104452 -0.00320779 0 0.236529 -0.00604661 0 0.373682 -0.0174385 0 0.222104 -0.0330844 0 + 0.171173 -0.00812812 0 0.261613 0.00171202 0 0.0986519 0.0178384 0 0.125005 0.0135395 0 + 0.268167 -0.00982468 0 -0.000210794 -0.00102587 0 0.105895 -0.000143367 0 0.226333 0.0886711 0 + 0.283385 -0.146356 0 0.236176 -0.0137945 0 0.0835656 0.00362937 0 0.258959 -0.0142541 0 + 0.363159 0.0707653 0 0.279795 -0.00175215 0 0.193809 -0.0166678 0 0.263613 -0.100609 0 + 0.00812852 0.0147892 0 0.292879 -0.000505226 0 0.278206 0.000382215 0 0.293791 0.0418377 0 + 0.34343 -0.0183756 0 0.112422 -0.0169664 0 0.243911 0.0314074 0 0.337233 0.0369936 0 + 0.266303 -0.0236 0 -0.00322 -0.00909131 0 -0.000131763 -0.000663283 0 0.0563358 -0.00203401 0 + 0.081556 -0.00151355 0 0.0131802 0.0159128 0 0.329748 0.0682979 0 0.0376142 -5.85326e-05 0 + 0.0649477 -0.0116262 0 0.378231 -0.0195402 0 0.210618 -0.0290302 0 0.0178945 8.36106e-06 0 + 0.0164429 -7.17256e-06 0 0.0156243 -2.39288e-06 0 0.266681 -0.000834286 0 0.246095 -0.160724 0 + 0.161474 0.00206351 0 0.387237 -0.0549205 0 0.379153 -0.125009 0 0.224466 -0.00935139 0 + 0.255255 -0.0129092 0 0.22908 0.0182335 0 0.0211212 -0.00115052 0 0.267392 -0.0318479 0 + 0.262449 0.021859 0 -0.0134622 0.000676664 0 0.376633 -0.0360449 0 0.232339 -0.000345023 0 + 0.211433 -0.0410362 0 0.199118 -0.0404563 0 0.1066 0.00380938 0 0.250884 -0.017335 0 + 0.259142 -0.0122413 0 0.367386 0.0386907 0 0.0104681 -9.9523e-06 0 0.290658 -0.057523 0 + 0.246165 -0.000391666 0 -0.00726155 -0.00456626 0 0.239397 0.016483 0 0.255637 0.00590565 0 + 0.151696 -0.000524742 0 0.0641128 -9.86003e-05 0 0.225058 -0.149999 0 0.190855 0.016443 0 + 0.382969 0.112287 0 0.358018 -0.137196 0 0.106744 0.0104051 0 0.161533 -0.0204711 0 + 0.383036 0.0465157 0 0.331921 -0.0785036 0 0.0694298 -0.0111425 0 0.202138 0.0439072 0 + 0.102595 -0.0295933 0 0.314941 0.061554 0 0.260022 0.00307254 0 0.278796 0.000355075 0 + 0.23948 -0.0168531 0 0.226302 -0.0149043 0 0.268939 0.157396 0 0.304885 -0.0665931 0 + 0.255622 0.00555885 0 0.219945 0.0451993 0 0.283358 -0.0355836 0 0.260281 0.00306613 0 + -0.00827907 0.00581165 0 0.0635353 -0.0136034 0 -0.00666881 0.00188705 0 0.369981 -0.135519 0 + 0.252672 -0.00222317 0 0.0316847 -5.10193e-06 0 0.321416 -0.0548958 0 0.282729 0.0107044 0 + 0.103773 0.0098353 0 -0.00951105 0.00011168 0 0.377341 -0.000584362 0 0.281286 0.141157 0 + 0.107331 0.000637328 0 0.38156 -0.10753 0 0.188797 0.182195 0 0.121872 0.0109706 0 + 0.24262 0.0490207 0 0.27317 0.000194416 0 0.275201 0.000178131 0 0.0564334 0.0216919 0 + 0.266588 -0.00147431 0 0.381172 -0.116291 0 0.0600421 0.00304515 0 0.193052 -0.016827 0 + 0.335638 -0.0255336 0 0.232267 0.0887893 0 0.11542 0.0115364 0 0.244821 -0.0159369 0 + 0.0589391 5.33509e-06 0 0.0489521 0.0093922 0 0.0179147 0.0096344 0 0.260921 0.0141407 0 + -0.00774537 -0.00466297 0 0.0980562 -6.31533e-05 0 0.251081 -0.122292 0 0.143205 -0.0042881 0 + -0.0010115 -0.00207029 0 0.39715 0.0885824 0 0.000705319 0.000409648 0 0.23706 0.0153459 0 + 0.315709 0.0127964 0 0.132898 0.0135161 0 0.325342 0.0905311 0 0.0186959 0.000334653 0 + 0.284132 -0.0231346 0 0.26498 -0.0345861 0 0.216451 0.0276247 0 0.207862 -0.00654617 0 + 0.28378 0.0127109 0 0.242862 -0.19944 0 0.0156243 -7.33982e-06 0 0.219182 0.136917 0 + -0.00927678 0.00535642 0 0.0339579 -0.00451244 0 0.254826 -0.104845 0 0.29392 0.0308251 0 + 0.27147 0.186178 0 0.205258 -0.011877 0 0.368221 0.00535982 0 0.390482 0.0401105 0 + 0.247424 0.00980119 0 0.0562048 -0.00295947 0 0.0386802 -0.0159555 0 0.329972 0.0184762 0 + 0.199892 -0.00278351 0 0.264301 -0.184441 0 0.377053 -0.117373 0 0.213688 -0.0285525 0 + 0.284045 -0.00198581 0 0.0693567 -5.85846e-05 0 0.260465 0.053273 0 0.0120503 0.017028 0 + 0.333567 -0.0244675 0 0.37582 -0.0132062 0 0.36746 -0.130978 0 0.29063 -0.000491286 0 + 0.0438725 0.00684094 0 0.00582108 -0.0149822 0 0.25707 0.0179824 0 0.11004 -0.0271304 0 + 0.296505 -0.139921 0 0.258073 0.0615552 0 0.0764873 9.96328e-05 0 0.038838 4.40362e-05 0 + 0.375915 0.0988951 0 0.317643 -0.0757452 0 0.251666 -0.0389871 0 0.286247 0.0102726 0 + 0.304326 -0.0267912 0 0.0401672 -2.1614e-05 0 0.217488 0.0261896 0 0.301114 0.0267733 0 + 0.22227 -0.166798 0 0.256926 -0.000812672 0 0.0467292 -0.0163554 0 0.23778 0.0153608 0 + 0.056007 -0.000294566 0 -0.000911741 -0.00200092 0 0.389732 0.110422 0 -0.00937006 0.00123345 0 + 0.27523 0.000171739 0 0.277116 0.000407032 0 0.194129 -0.00372257 0 0.233003 0.0166222 0 + 0.0326035 0.0138149 0 0.261966 -0.00986588 0 0.31783 0.043116 0 0.251974 0.066925 0 + 0.0462957 -7.97677e-05 0 0.293435 -0.161181 0 0.237968 0.0460754 0 -0.0156214 0.000393395 0 + 0.0698036 0.107402 0 0.247412 -0.000449333 0 -0.00808856 5.62111e-06 0 0.0154654 1.55464e-07 0 + 0.0161588 6.98252e-07 0 -0.00991669 0.000659445 0 0.000790125 -0.000192776 0 0.306431 0.136455 0 + 0.374031 0.1216 0 0.291763 -0.171984 0 0.333666 0.0447062 0 0.0323461 0.0122443 0 + 0.192639 -0.00353691 0 -0.00322434 0.00945985 0 0.129941 -0.00643691 0 0.192705 -0.0147346 0 + 0.293499 -0.150225 0 0.168565 -0.0012866 0 0.0237877 0.000481498 0 0.174925 -0.0175731 0 + 0.303202 0.0922411 0 0.257971 0.0186149 0 0.229609 -0.0716305 0 0.0856886 0.0161189 0 + 0.0631398 -0.000153253 0 0.124111 0.0010933 0 0.321478 -0.178146 0 0.00203781 0.000920535 0 + 0.259488 0.0401663 0 0.290546 -0.000748943 0 0.127647 -0.000224426 0 0.215721 0.146127 0 + 0.123187 0.0859807 0 0.380623 -0.00823138 0 0.04582 -7.61717e-05 0 0.279179 -0.00172944 0 + 0.0623256 -0.0193861 0 0.00143008 0.000890939 0 0.0245729 0.0331347 0 0.120364 -0.0365405 0 + 0.0932158 -0.000329752 0 0.378369 -0.00359589 0 0.228303 -0.15664 0 0.0852106 -0.00690794 0 + 0.0152177 0.000564585 0 0.361841 0.0862258 0 0.0823319 9.6619e-05 0 0.193222 -0.0372482 0 + 0.0226046 0.00125489 0 0.105594 0.0525265 0 0.00292001 -0.00545904 0 0.116712 0.00389715 0 + 0.280196 0.067439 0 0.271507 -0.0179729 0 0.138051 -0.00336405 0 -0.00459389 0.00933033 0 + -0.0087833 0.00311454 0 0.0343951 -0.0130903 0 0.123015 0.0159576 0 0.016267 -4.36095e-06 0 + 0.260137 0.193501 0 0.0534882 -0.00773992 0 0.25042 0.00685583 0 0.26587 -0.0379801 0 + 0.0327347 0.0109588 0 0.318747 0.00951974 0 0.0428247 -6.30582e-05 0 0.275194 -0.0542937 0 + 0.260821 -0.00400436 0 0.29643 -0.000325267 0 0.285657 -0.000161374 0 0.379424 4.67706e-06 0 + 0.352092 0.0419068 0 0.268216 -0.0113938 0 0.212305 0.0115454 0 0.288527 -0.0327304 0 + 0.381715 -0.0220131 0 0.268543 0.0214877 0 -0.000385931 -0.00156968 0 0.380867 -0.00216883 0 + 0.0938725 -0.000261804 0 0.384083 -0.0279687 0 0.197973 -0.103907 0 0.05287 0.000521205 0 + 0.0604545 -0.000153441 0 0.0689456 0.0127701 0 0.154291 -0.0340173 0 0.278718 0.0147147 0 + 0.260142 -0.0114006 0 0.278861 0.186456 0 0.254605 -0.0672064 0 -0.00841234 -0.00321397 0 + 0.00237095 0.00525471 0 0.209643 -0.0207541 0 0.290463 0.00419719 0 0.0371304 0.0250477 0 + 0.373916 -0.136587 0 0.29763 -0.134683 0 0.00541001 -0.0187186 0 0.37233 -0.0202313 0 + 0.27592 0.000401055 0 0.211424 -0.126667 0 0.195086 -0.0452872 0 -0.00855073 0.00594719 0 + 0.1251 -0.00746338 0 0.130894 0.005648 0 0.252823 -0.133897 0 0.0113575 0.0256834 0 + 0.0354479 0.0259706 0 0.0730752 -0.0232489 0 0.279973 0.129512 0 0.265481 0.00123164 0 + 0.396128 0.0854746 0 0.187376 0.0231595 0 0.275278 -0.000728347 0 0.03237 0.000329048 0 + 0.281988 -0.000704912 0 0.00347589 0.0069248 0 0.122564 0.00059248 0 0.246345 -0.141837 0 + 0.0330344 0.00714257 0 0.268194 -0.00483948 0 -0.0024285 -0.00428952 0 0.226511 0.164476 0 + 0.160126 0.177315 0 0.00289582 -0.00164906 0 0.135571 -0.163011 0 0.392708 0.0680475 0 + 0.00933737 -2.14898e-06 0 0.265028 0.00109199 0 0.311172 -0.0150818 0 0.287358 -0.000551845 0 + 0.250448 -0.00116171 0 0.262738 -0.00337139 0 0.377265 -0.00872108 0 0.0116155 -0.00778103 0 + 0.296289 -0.000330093 0 0.00136863 -0.000905736 0 0.247262 0.0218021 0 0.155062 -0.0676058 0 + 0.235805 0.0613759 0 0.373601 0.0553217 0 0.00824209 3.51888e-06 0 0.201447 0.00386628 0 + 0.212152 -0.000249359 0 0.021165 -0.0311842 0 0.276537 -0.0602889 0 0.214207 0.0121678 0 + 0.249412 0.0195893 0 0.154862 -0.00674207 0 0.353329 0.157387 0 0.372712 -0.0191526 0 + 0.0338515 3.25848e-05 0 -0.00787608 0.00650447 0 0.372868 -0.134946 0 0.182644 0.0317805 0 + 0.271761 -0.0109535 0 0.267717 -0.0314334 0 0.251607 0.00244357 0 0.0415312 -0.00976476 0 + 0.281875 -0.0151222 0 0.262896 0.135025 0 0.029711 -0.0532865 0 0.0745523 -0.0231237 0 + 0.174646 -0.00356675 0 0.188807 0.00226689 0 0.289968 0.181007 0 0.31201 0.0100589 0 + 0.0453323 -7.10508e-05 0 0.00159542 0.00770432 0 0.253115 -0.177182 0 0.290124 -0.0153117 0 + 0.225262 0.135807 0 0.0305405 0.00528735 0 0.283521 -0.000260368 0 0.0106692 0.0163889 0 + 0.255916 0.0293601 0 0.309035 0.0392072 0 0.271562 -0.0160006 0 0.313102 -0.186778 0 + 0.0210656 0.00191124 0 0.292155 -0.0336225 0 0.386805 0.0454057 0 0.121774 -0.000237623 0 + 0.284796 -0.00156114 0 0.226956 0.011288 0 0.282284 7.95515e-05 0 0.265581 -0.0101865 0 + 0.0834551 -0.000183805 0 0.32827 0.0102248 0 0.318862 -0.185173 0 0.193767 0.0355488 0 + 0.256095 -0.0642369 0 0.053308 0.0129969 0 0.300941 -0.188319 0 0.0794936 -0.0200382 0 + 0.393155 0.0995542 0 0.199058 -0.0401973 0 0.382144 -0.00238841 0 0.0173715 1.1273e-05 0 + 0.0417106 -3.04596e-05 0 0.203258 -0.0210829 0 0.0560244 -5.30315e-05 0 0.0343291 -0.0151033 0 + 0.26391 0.00209443 0 0.18795 0.00910906 0 0.349496 -0.16543 0 0.322607 -0.0319779 0 + 0.270541 -0.00147392 0 0.12369 0.0111911 0 0.279943 -0.0140096 0 0.233742 0.126161 0 + 0.383087 -0.0153846 0 0.303796 -0.00825903 0 0.282269 -0.00615104 0 0.382358 -0.00146533 0 + 0.289214 0.0134907 0 0.239166 -0.0145485 0 0.323459 0.186228 0 0.247389 -0.174271 0 + 0.282243 -0.157189 0 0.277028 -0.127452 0 -0.00726934 0.00522205 0 0.242611 0.0333908 0 + 0.288255 -0.182098 0 0.386804 0.10017 0 0.203343 -0.00028766 0 0.290345 0.00418678 0 + 0.343061 -0.0220096 0 0.195657 -0.190045 0 0.284596 0.00672151 0 0.118421 0.0263147 0 + 0.282258 0.00245672 0 0.254112 -0.00359886 0 0.254415 0.0474421 0 0.0531061 -0.0174326 0 + 0.02467 0.00142617 0 0.00284321 0.0120874 0 0.273624 -0.0142242 0 0.382512 0.0601712 0 + 0.126796 0.000484844 0 0.0644633 -2.52296e-05 0 0.26209 0.00465393 0 0.297212 -0.000234075 0 + 0.026565 -0.00537274 0 0.274001 0.17641 0 0.249782 -0.00158947 0 0.38238 -0.00339011 0 + 0.0495491 -0.0763138 0 0.258778 0.00275398 0 0.213569 -0.0125495 0 0.0806051 -0.00114768 0 + 0.0426254 6.46749e-05 0 0.276829 0.000117871 0 -0.0013953 0.00886888 0 0.325593 -0.146919 0 + 0.255935 -0.0602146 0 0.157531 -0.00715246 0 0.293378 0.185412 0 0.0651157 -0.0216074 0 + 0.0191355 -9.49814e-06 0 0.0201375 -1.45447e-05 0 0.241453 0.118534 0 0.276319 0.0788768 0 + 0.118584 0.0129922 0 0.0614 -0.0149691 0 0.167948 -0.0750188 0 0.202014 -0.179751 0 + 0.309073 0.0323219 0 0.258395 0.0122646 0 0.08739 -0.0258534 0 0.271464 -0.00272225 0 + 0.32518 -0.153028 0 -0.00320623 0.00857589 0 0.206753 -0.0165079 0 0.261712 -0.0439435 0 + 0.342413 0.177237 0 0.219088 -0.000308514 0 0.189833 0.0333425 0 0.0346841 0.0136774 0 + 0.248055 0.00645976 0 0.100222 -0.024972 0 0.212017 0.0341643 0 0.267629 0.155852 0 + 0.29087 -0.154952 0 0.364922 -0.135068 0 0.348578 -0.0729709 0 0.304884 0.00218117 0 + 0.24053 -0.00804588 0 0.112706 -0.0217038 0 0.331388 -0.0408803 0 0.366726 -0.1175 0 + 0.00114995 0.000752365 0 0.259304 -0.000921115 0 0.356034 0.050731 0 0.157792 0.000912777 0 + 0.211712 0.0360496 0 0.22477 -0.186943 0 0.0284619 -1.42493e-05 0 0.238195 -0.149582 0 + 0.36021 0.0360436 0 0.290973 -0.0893531 0 0.270538 -0.179178 0 0.00480582 0.0166563 0 + 0.262182 0.179341 0 0.184944 -0.0348137 0 0.238385 0.0304607 0 0.0550728 0.000625262 0 + 0.0442792 6.50588e-05 0 0.254465 -0.182289 0 0.30146 0.00506781 0 0.328687 -0.162646 0 + -0.00971959 -0.00244272 0 0.136495 0.000868451 0 0.0457909 -7.21891e-05 0 -0.000525753 0.00111076 0 + 0.197007 -0.00513011 0 0.33999 -0.173379 0 0.120359 -0.000391848 0 0.0164154 -0.0378648 0 + 0.289838 -0.165861 0 0.276573 -0.00818894 0 0.235863 0.0316755 0 -0.00216679 0.00493407 0 + 0.0567626 -0.00928592 0 0.079687 -0.000218209 0 0.143982 0.00102428 0 0.259857 0.0724726 0 + 0.0476856 7.08072e-05 0 0.329251 -0.178918 0 0.239455 -0.00464354 0 0.378631 0.105846 0 + 0.329808 -0.156949 0 0.0145341 5.10118e-06 0 0.0162608 -1.36612e-05 0 0.290885 -0.000169129 0 + 0.032315 -0.0254989 0 0.26426 0.0616125 0 0.08817 -0.0400637 0 0.00850341 4.80548e-07 0 + -0.00458511 -0.00282735 0 0.196375 0.00015399 0 0.192443 -0.0260492 0 0.271425 -0.00108164 0 + 0.126088 -0.000494171 0 0.111522 -0.000380774 0 0.0173619 -1.47647e-05 0 0.236603 0.0167965 0 + -0.0125085 0.00187269 0 0.313338 -0.0365072 0 0.265828 0.149096 0 0.0154113 -0.000832043 0 + 0.306238 -0.0379353 0 0.147929 0.0100271 0 0.337089 -0.0125699 0 0.143815 -0.00188783 0 + 0.254205 0.00118119 0 0.146383 -0.0207012 0 0.367928 0.0561886 0 0.0387173 0.0110022 0 + 0.306972 0.0384665 0 0.332716 -0.166251 0 0.00113698 -0.00071123 0 0.0780988 0.000377237 0 + 0.189568 -0.0275961 0 0.0845821 0.0160939 0 0.279542 -0.00264135 0 0.25817 -0.0488279 0 + 0.110677 0.00822993 0 0.0412552 0.00640082 0 0.00315016 0.00688644 0 0.0101062 0.0252775 0 + 0.2591 -0.024604 0 0.217848 0.138135 0 0.256516 0.0202477 0 0.241376 0.160114 0 + 0.227214 0.12814 0 0.301142 -0.0313175 0 0.275447 0.000106316 0 0.350495 -0.0164481 0 + 0.255833 0.00411245 0 0.268298 -0.000810927 0 0.0677155 -0.000167811 0 0.268185 0.00156874 0 + 0.247657 0.175236 0 0.262971 -0.159513 0 0.330721 0.0412839 0 0.227436 -0.000237908 0 + 0.151576 0.00164094 0 0.0158385 0.0278846 0 0.0133019 0.0274266 0 0.00962852 0.00273317 0 + 0.212988 -3.76816e-05 0 0.246818 -0.00196323 0 0.397029 0.0645273 0 0.282698 0.135213 0 + 0.282491 -0.186017 0 0.270656 -0.00139298 0 0.0998403 -0.101836 0 0.0313747 7.64401e-06 0 + 0.350787 0.031644 0 0.111469 0.00200205 0 0.0109141 -2.20397e-05 0 0.0980867 0.0177154 0 + 0.356167 0.0110178 0 0.00633784 -0.00367813 0 0.261906 0.128311 0 0.397439 0.0699444 0 + 0.0205971 0.000341522 0 0.0291767 0.00394885 0 0.343703 -0.0801962 0 0.0628896 -9.09955e-05 0 + 0.291937 0.00659662 0 0.0256598 0.0320214 0 0.0502256 -0.0137693 0 0.189799 -0.0289375 0 + 0.0460593 0.077231 0 0.0558958 0.000273595 0 -0.00028602 -0.00130121 0 0.0715727 0.0132905 0 + 0.0189598 -0.000437969 0 0.0162791 0.000336061 0 0.317232 -0.042933 0 0.0179183 0.0308809 0 + 0.0128916 -0.00932945 0 0.136227 -2.70581e-05 0 0.0369931 0.0229459 0 0.261022 0.0103036 0 + 0.00340995 -0.00564415 0 0.133956 0.00371242 0 0.341498 -0.166677 0 0.332837 0.0759208 0 + 0.238398 -0.0575339 0 0.259746 0.00278146 0 0.28816 -0.00100691 0 0.264606 0.0146978 0 + 0.255436 -0.0665327 0 0.0162581 -8.89198e-06 0 0.0153718 1.99355e-09 0 0.263493 0.161027 0 + 0.248971 -0.0704823 0 0.103061 0.138058 0 0.387307 -0.0267402 0 0.248197 -0.172612 0 + 0.278641 -0.00194276 0 0.231418 0.100961 0 0.29098 -0.00683211 0 0.156074 0.00205902 0 + 0.0937799 0.000349174 0 0.0641778 4.62276e-05 0 0.200001 -0.0155781 0 0.293679 -0.000439341 0 + 0.374295 -0.133767 0 0.291524 -0.0453118 0 0.0686393 -7.48512e-05 0 0.0774904 -9.50225e-05 0 + 0.0623897 0.000132585 0 0.231672 0.0327012 0 0.0161744 4.03081e-06 0 0.0419581 -0.0158543 0 + 0.282479 3.40032e-05 0 0.278071 7.72417e-05 0 0.285696 -0.0192629 0 0.287133 -0.176396 0 + 0.21233 -0.0214272 0 0.0338599 0.0269069 0 0.0197091 -0.0456597 0 0.255144 -0.0696274 0 + 0.198063 0.0339301 0 0.132448 -0.0172029 0 0.217166 -0.0332655 0 0.124588 -0.130207 0 + 0.280617 0.0176795 0 0.0875901 -0.0484773 0 0.184757 -0.00385516 0 0.375698 -0.13363 0 + 0.0656615 0.000140475 0 0.348618 0.0510145 0 0.0822276 0.000225518 0 0.00388042 0.00216086 0 + 0.327128 0.0440562 0 0.0957718 0.000881365 0 0.287436 0.0267494 0 0.393407 -0.0672033 0 + 0.147408 -0.0343702 0 0.323615 0.0052525 0 0.3579 0.162842 0 0.00304924 0.00162635 0 + 0.0111635 -0.0159378 0 0.218924 0.0333788 0 0.237302 0.0243809 0 0.163067 -0.0254581 0 + 0.0507372 -7.7211e-05 0 0.150504 0.0305555 0 0.028418 0.0305341 0 0.275862 -0.000144624 0 + 0.267566 -0.000152291 0 0.0568011 0.00110911 0 0.0569588 -0.00128971 0 0.251319 0.0420773 0 + 0.0186586 -2.97398e-06 0 0.0165363 -0.0013972 0 0.255819 -0.00465346 0 0.0252676 -0.0340772 0 + 0.23092 -1.52211e-05 0 0.261999 0.0216409 0 0.201856 0.112223 0 0.139833 -0.00511494 0 + 0.000899387 0.00266017 0 0.0296287 1.12593e-05 0 0.262493 0.0762017 0 0.130963 -0.157998 0 + -0.00660498 0.00479316 0 0.129108 -0.016171 0 0.384557 0.10954 0 0.0958753 -0.0208199 0 + -0.0016827 -0.00321352 0 0.257468 -0.0312818 0 0.287832 -0.000943244 0 0.142541 -0.130953 0 + 0.193954 -0.0284297 0 0.250598 -0.100357 0 0.248775 -0.105881 0 0.353867 -0.162339 0 + 0.0447478 0.0579541 0 0.0815165 0.00159548 0 0.350931 -0.0179172 0 0.276759 0.000345666 0 + 0.333087 -0.174386 0 0.083274 -0.00276191 0 0.1946 -0.0139875 0 0.340562 -0.0154827 0 + 0.0794099 0.0150592 0 0.266544 -0.0032956 0 0.0361746 -0.0153618 0 0.0263897 0.00253563 0 + 0.289372 -0.000891037 0 0.288699 -0.000643556 0 0.284368 -0.000699233 0 0.250554 -0.0111844 0 + 0.268424 -0.00367105 0 0.188703 -0.189912 0 0.0248585 0.000210565 0 0.307559 -0.0332525 0 + 0.337409 -0.0369283 0 -9.77877e-05 -0.000361286 0 0.366785 0.0627737 0 0.265325 0.167799 0 + -0.00119321 -0.00140212 0 0.263006 -0.0218047 0 0.281757 0.000242571 0 0.264158 -0.000849799 0 + 0.0364581 4.49809e-05 0 0.0637746 0.0981354 0 0.341549 0.016111 0 0.27324 0.0011615 0 + 0.0959587 0.0161916 0 0.0579796 0.00218262 0 0.113876 -0.0113961 0 0.269859 0.00035632 0 + 0.186673 0.00690196 0 0.24097 0.149016 0 0.271433 9.05566e-06 0 0.0457008 -4.12297e-05 0 + 0.294748 -0.000391845 0 0.330364 -0.17157 0 0.12003 -0.0301497 0 0.27737 -0.000229461 0 + 0.110763 -0.0220184 0 0.290943 -8.45294e-05 0 0.25642 0.00465004 0 0.293622 0.148498 0 + 0.189699 -0.0024141 0 0.262133 -0.000147961 0 0.326716 0.0441845 0 0.0828207 7.49949e-05 0 + 0.279446 0.011629 0 0.10037 0.00010468 0 0.137723 -0.113731 0 0.0551334 0.050482 0 + 0.254157 0.0168303 0 0.260589 -0.0875416 0 0.0814112 -7.67634e-05 0 0.143092 0.0125838 0 + 0.0812203 0.0249297 0 0.254356 0.00403927 0 0.365009 0.0266324 0 0.0983185 -0.0173337 0 + -0.000100935 -5.25209e-05 0 0.0322359 0.0264845 0 0.332067 0.0390822 0 0.278266 -0.00210874 0 + 0.265317 -0.0304671 0 0.0151724 1.06557e-05 0 0.0163959 -4.07657e-06 0 0.198766 0.0268587 0 + 0.369706 -0.0211853 0 0.140487 0.0366424 0 0.293362 -0.00577218 0 0.316127 -0.0307297 0 + 0.289434 0.0473983 0 0.219715 -0.135881 0 0.248516 0.0644718 0 0.294467 -0.000392309 0 + 0.25679 -0.000855934 0 0.301682 0.16902 0 0.270482 0.00061516 0 0.268596 -0.00485663 0 + 0.204568 0.0390925 0 0.260438 0.172888 0 0.206732 -0.0402327 0 0.279857 -0.167938 0 + 0.210494 -0.187864 0 0.273769 -0.00108645 0 -0.0156247 0.000350469 0 0.113783 -0.00211794 0 + 0.247057 -0.0487807 0 0.268233 -0.0968002 0 0.150725 -0.00973083 0 0.065575 0.0228017 0 + 0.0951382 -0.00405032 0 0.195149 -0.0390924 0 0.272343 -0.00179741 0 0.096229 0.000353092 0 + 0.0448999 -0.0174883 0 0.24121 -0.0256621 0 0.173604 -0.00273165 0 0.0740811 0.00020378 0 + 0.0846379 0.000120767 0 0.0473756 -7.70591e-05 0 0.0369865 -3.9368e-05 0 0.231528 -0.0127722 0 + 0.26382 -0.000803109 0 0.160563 -0.0360181 0 0.225131 0.0344024 0 0.0912994 -0.0673423 0 + 0.0940879 0.000321784 0 0.232639 -0.00625483 0 0.143981 -0.099215 0 0.109142 0.00125257 0 + 0.203266 0.0391723 0 0.311986 -0.0866663 0 0.267972 0.168352 0 0.220759 -0.0487228 0 + 0.366755 -0.00636794 0 0.057144 0.000728368 0 0.322291 0.134468 0 0.293175 0.175323 0 + -0.00562833 0.00401093 0 0.219919 0.159559 0 0.390942 0.108731 0 -0.000146771 -0.000701653 0 + 0.133078 -0.0152998 0 -0.00421132 0.00181909 0 0.000191908 0.00518115 0 0.296104 -0.000265521 0 + 0.295317 -0.000215456 0 0.250485 0.0192943 0 0.181195 -0.0183719 0 0.122855 -0.146317 0 + 0.0406092 3.26739e-05 0 0.129563 -0.0148726 0 -0.0099156 0.00293493 0 0.248506 -0.0734514 0 + 0.265349 -0.019257 0 0.00597651 0.00599341 0 0.0101702 -0.000152096 0 0.0880337 0.00529399 0 + 0.124837 0.000705242 0 0.275892 -0.00217055 0 0.113669 -0.124711 0 0.268258 0.00139248 0 + 0.244545 -0.00640132 0 0.283424 -0.0952011 0 0.036842 -0.0209238 0 0.379958 0.00489248 0 + 0.0984796 0.000382964 0 0.0152456 0.0134251 0 0.0712025 0.00172245 0 0.145865 -0.000548099 0 + 0.00819509 1.34128e-07 0 0.256128 -0.0345882 0 0.277878 0.000358531 0 0.368813 0.0362361 0 + 0.00378097 0.0145966 0 0.12396 0.0121189 0 0.0335825 2.16313e-05 0 0.227112 0.0271801 0 + 0.262367 0.00214419 0 0.186985 -0.0145035 0 0.270574 -0.0705152 0 0.0863424 -0.000244666 0 + 0.0735157 0.0139 0 0.28052 0.000145185 0 0.119709 -0.0139754 0 0.247026 0.00518242 0 + 0.00920427 -6.00495e-06 0 0.0839466 -0.000172464 0 0.250469 0.0646978 0 0.0931846 -0.0578451 0 + 0.265023 0.124055 0 0.304412 0.0385221 0 0.000632308 2.59044e-05 0 0.151202 -0.0194098 0 + 0.183034 0.0150855 0 0.214857 0.00665436 0 0.199015 -0.0245115 0 0.317348 0.0451344 0 + 0.0481386 0.0126454 0 0.133461 0.00520119 0 0.296257 -0.000253637 0 0.29536 -0.000205526 0 + 0.00974016 2.39839e-05 0 0.163675 0.0249763 0 0.182476 -0.0289247 0 0.223503 -0.000202741 0 + 0.320554 0.0336879 0 0.00127519 0.0057016 0 0.286439 3.65009e-05 0 0.264378 -0.011242 0 + -0.000842036 0.00310802 0 0.377639 -0.00456752 0 0.0360926 0.0204543 0 0.253589 -0.000775097 0 + 0.179704 -0.0300183 0 0.152804 -0.172909 0 0.0370628 3.90057e-05 0 0.0428967 0.0614803 0 + 0.237632 -0.136776 0 0.290934 -0.000680158 0 0.387719 0.00895674 0 0.25254 -0.00197106 0 + 0.257002 -0.000769775 0 0.0749453 0.0253645 0 0.0515617 -8.00382e-05 0 0.0383397 -2.48562e-05 0 + 0.143717 -0.0233111 0 0.0184058 -0.0110044 0 -0.00401848 0.00941212 0 0.036326 -0.0170904 0 + 0.0497334 6.71543e-05 0 0.232811 -0.00314014 0 0.228279 -0.0143126 0 0.256101 -0.0373394 0 + 0.040828 -0.00156548 0 0.169765 -0.183461 0 0.29942 0.158337 0 0.201295 -0.194238 0 + 0.295965 -0.000357022 0 0.296325 -0.000311406 0 0.0849046 -3.85262e-05 0 -0.00865593 -0.00530025 0 + 0.00366935 0.00170993 0 0.0395301 1.5128e-05 0 0.306649 -0.0277243 0 -0.000460531 -0.000964782 0 + 0.0808803 4.23981e-05 0 0.33543 -0.177128 0 0.269493 -0.043771 0 0.242099 -0.00796849 0 + 0.0346412 -3.43474e-05 0 0.317266 -0.00110134 0 0.114204 0.00374164 0 0.277971 0.000293069 0 + 0.26871 0.0191802 0 0.0165604 -5.02562e-06 0 0.0700633 -0.000192429 0 0.0920713 -0.00235418 0 + 0.275542 0.163806 0 0.0825448 -0.0187965 0 0.0457843 6.64834e-05 0 0.19556 -0.035729 0 + 0.0162692 4.6088e-06 0 0.390131 0.0182468 0 0.236333 0.0236486 0 0.0367223 -0.0190315 0 + -0.00422789 -0.00265115 0 0.12348 0.00933367 0 0.218543 0.0445065 0 0.289774 0.0130365 0 + 0.268821 -0.0110898 0 0.281594 -0.0716339 0 0.283703 7.00153e-05 0 0.00793363 0.00657119 0 + 0.0902013 -5.50776e-05 0 0.00988324 -0.00251009 0 0.133117 0.162105 0 0.0204957 0.0325262 0 + 0.284481 -0.0762248 0 0.22492 -0.000318107 0 0.138879 0.000748396 0 0.256459 0.0408684 0 + 0.232009 -0.0071795 0 0.299439 -0.0189307 0 0.210362 -0.0252283 0 0.154984 -0.0341869 0 + 0.0679009 0.0125957 0 0.296568 -0.000298225 0 0.296301 -0.000342367 0 0.258409 -0.000395782 0 + 0.291527 0.0973194 0 0.145338 -0.00111012 0 0.155889 -0.00143272 0 -3.34185e-05 -0.000112904 0 + 0.258499 -0.0828064 0 0.188157 -0.00185158 0 0.30077 -0.0101937 0 0.123673 -0.00460248 0 + 0.278156 0.0301054 0 0.26254 -0.00441419 0 0.331427 0.00706719 0 0.046976 1.79258e-05 0 + 0.276525 -0.183975 0 0.290623 0.0280597 0 0.263127 0.00214756 0 0.27428 0.0979161 0 + 0.256436 0.0270707 0 0.0881423 0.000314873 0 0.166941 -0.00267495 0 0.0862062 0.0255083 0 + 0.181031 -0.00965127 0 0.359009 -0.0133377 0 0.363168 0.137916 0 0.3018 -0.0421473 0 + 0.269825 0.0147958 0 0.270871 -0.00322506 0 -0.00548254 0.00448044 0 0.0414958 3.47193e-05 0 + 0.235266 0.00712182 0 0.0405931 -1.65045e-05 0 0.293348 -0.000457643 0 0.130735 -0.00042822 0 + -0.0115629 -0.00157408 0 0.0630487 0.0150901 0 0.132366 -0.12673 0 0.287211 -0.000662449 0 + 0.290849 -0.000597626 0 0.0343438 -5.1432e-05 0 0.131588 -0.0048753 0 0.180103 -0.0033452 0 + 0.266467 -0.00468683 0 0.318677 -0.0316615 0 0.293494 -0.000420133 0 0.295031 -0.000390113 0 + 0.191934 -0.00889965 0 0.279528 0.000307977 0 0.186726 0.135438 0 0.00832288 0.00487855 0 + -0.00719724 0.00700848 0 0.0526236 -0.00079606 0 0.205338 0.0361284 0 0.0309224 -2.31692e-05 0 + 0.0168911 -8.95754e-06 0 0.269793 -0.00394414 0 0.183961 0.0108671 0 0.357574 0.0410091 0 + 0.0346683 -0.00355289 0 0.361594 -0.124421 0 0.160598 -0.00886745 0 0.113206 -0.0283757 0 + 0.0546499 6.955e-05 0 0.202584 -0.0332481 0 0.269544 -0.000864932 0 0.207489 0.013868 0 + 0.294169 -0.183407 0 0.268793 0.00147611 0 0.236733 0.0573831 0 -0.00445887 -0.008934 0 + 0.0665053 -2.93792e-05 0 0.0305906 -0.00986187 0 0.276014 -0.178111 0 0.259908 -0.00141597 0 + 0.266967 -0.0031154 0 0.0556532 -4.09369e-05 0 0.186696 0.0149136 0 0.29113 0.031072 0 + 0.130547 -0.034785 0 0.111553 -0.116541 0 0.303086 0.045257 0 0.254626 -0.0449741 0 + 0.260502 -0.00259164 0 0.0611867 -0.000115778 0 0.394842 0.0321984 0 0.28798 -0.00103714 0 + 0.295502 -0.000371456 0 0.106141 -0.000502954 0 0.172803 0.18169 0 0.101866 -9.57253e-05 0 + 0.0935285 -8.95968e-05 0 0.396447 0.0723401 0 0.0118721 0.0038717 0 0.150828 -0.000595766 0 + 0.239376 -7.69643e-05 0 0.134708 -0.00352787 0 0.269891 0.0440561 0 0.290107 -0.000842837 0 + -0.00713962 0.00122185 0 0.00155447 0.00131636 0 0.115796 0.145341 0 0.0489528 0.0125295 0 + 0.267644 -0.00236849 0 0.0723921 -0.0166849 0 0.171998 0.0211584 0 0.0152963 -2.29801e-06 0 + 0.0536939 -4.69184e-05 0 0.352051 -0.158182 0 0.250252 0.0113595 0 0.0647817 8.10015e-05 0 + 0.115289 -0.00294491 0 0.279043 -0.0017139 0 -0.000179043 -0.00136955 0 0.277706 -0.101697 0 + 0.066301 -0.0012821 0 0.0380793 0.00539663 0 0.230722 -0.197545 0 0.239243 -0.162102 0 + 0.0390209 -1.03393e-06 0 0.143553 -0.000278938 0 0.137747 -0.000262669 0 0.26525 -0.00414841 0 + 0.181669 0.00756665 0 0.149333 0.0309675 0 0.0562103 0.000391742 0 0.161806 -0.000133221 0 + 0.38798 0.106305 0 0.317563 0.043203 0 0.128012 -0.000691712 0 0.0602211 -0.0153865 0 + 0.287449 0.0457761 0 -0.00117049 0.00271233 0 0.26128 -0.088035 0 0.35589 0.106638 0 + -0.0033966 0.00791957 0 0.121663 -0.00264595 0 -0.00359756 0.00133503 0 0.295093 -0.000399778 0 + 0.0978184 -0.0251044 0 0.369877 -0.0272847 0 0.265313 -0.0868428 0 0.278919 0.000409919 0 + 0.120845 0.0281206 0 0.0345808 -0.00382796 0 0.127272 -0.0233535 0 0.302607 0.0446944 0 + 0.265425 0.0773565 0 0.184296 -0.0346983 0 0.0248165 0.00148621 0 0.275409 0.0249886 0 + 0.378564 0.0037767 0 0.27029 0.00126128 0 0.265155 -0.0927916 0 0.193306 -0.0326469 0 + 0.0178844 9.12328e-06 0 0.286211 -0.000153092 0 0.287526 0.182104 0 -0.000472164 -0.00327031 0 + 0.0266329 -0.00357607 0 0.232025 0.0324182 0 0.177262 0.0238813 0 0.298975 -0.0989952 0 + 0.349099 -0.154236 0 0.291334 -0.000529017 0 0.127396 -0.137871 0 0.195702 -0.0186836 0 + 0.121955 -0.00969432 0 0.267899 -0.106624 0 -0.0155139 7.18927e-05 0 0.0203761 3.63142e-05 0 + 0.330175 0.0427116 0 0.0597736 -0.000131608 0 0.0854005 0.0158937 0 0.385409 0.0578996 0 + 0.095472 0.000392168 0 0.329192 -0.0353601 0 0.267743 0.0504224 0 0.0306483 -5.78979e-06 0 + 0.240548 0.172216 0 0.368618 -0.143788 0 0.188978 -0.0299591 0 0.0127406 0.00139283 0 + 0.0249737 -0.00946902 0 0.0345411 0.00990001 0 0.0544053 0.00065466 0 0.0146051 1.55337e-05 0 + 0.306312 0.0851594 0 0.0817815 -6.53891e-05 0 0.0966013 -9.16552e-05 0 0.268117 0.0481843 0 + 0.277996 -0.020369 0 0.0176769 -0.000613137 0 0.203734 -0.0290825 0 0.252634 0.00650074 0 + 0.277359 -0.0011039 0 0.0675009 0.000175214 0 0.349586 0.0314099 0 0.277695 -0.00120207 0 + 0.335156 -0.176663 0 0.0422335 -0.000157992 0 0.274345 0.000354017 0 0.290945 0.00747364 0 + 0.0398309 0.000430727 0 0.321736 0.139955 0 0.0318525 0.0271894 0 0.252414 -0.0498127 0 + 0.0177564 0.000272108 0 0.163387 -0.180633 0 0.284142 0.000117445 0 0.266445 -0.00203936 0 + 0.290426 -0.0237806 0 0.273628 -0.00105494 0 0.264101 -0.00206699 0 0.270176 -0.0105613 0 + 0.256335 -0.0499248 0 0.19075 -0.000163282 0 0.0918346 -0.00773166 0 0.12572 -0.00976836 0 + 0.157878 0.00594741 0 0.00557356 0.00360008 0 -0.00672275 0.00388297 0 0.267425 -0.034891 0 + 0.275175 -0.0167201 0 0.273319 -0.00128548 0 0.222504 -0.021021 0 0.01755 -6.97012e-06 0 + 0.290047 -0.000861537 0 0.0990876 0.00153303 0 0.189785 -0.000349736 0 0.0506348 -0.00199591 0 + 0.0150685 0.0284503 0 0.281074 -0.0219355 0 0.27908 -0.0755552 0 -0.00127843 -0.00715285 0 + 0.0348588 -2.64715e-05 0 0.0189913 -2.32723e-05 0 0.00320918 -0.00444587 0 0.366711 -0.008189 0 + 0.161379 -0.0257201 0 0.11844 -0.000199234 0 0.269124 -0.0959982 0 -0.00141712 0.00217864 0 + 0.168707 0.00215014 0 0.0438633 -7.66509e-05 0 -0.00118195 0.00237074 0 0.035423 2.76545e-05 0 + 0.165381 -0.0205785 0 0.244344 0.023005 0 0.210901 0.0144527 0 0.0373172 -0.000164266 0 + 0.0491577 -0.0141883 0 0.278109 -0.00152399 0 0.187311 -0.0352774 0 0.0390436 2.12777e-05 0 + 0.220949 -0.013582 0 0.32792 0.0410474 0 -0.00545313 -0.00757516 0 0.00892258 0.0276958 0 + 0.29425 -0.000185736 0 0.182371 -0.0329229 0 -0.00275318 -0.00377246 0 0.120661 0.0213379 0 + 0.00491986 -0.00363422 0 -0.0118583 -0.00160123 0 0.026886 0.0311392 0 0.0812006 0.00101189 0 + 0.130393 0.0203708 0 0.288646 -0.000552043 0 0.140022 0.0364503 0 0.273268 -0.0222858 0 + 0.230411 -0.132272 0 -0.00054387 -0.000856398 0 0.028597 -8.23193e-06 0 0.273131 -0.00246681 0 + 0.0898191 -0.000118372 0 0.137296 -0.00024695 0 0.129397 0.0115237 0 0.139751 -0.0280804 0 + 0.0148234 -0.00181019 0 0.292102 -0.00058057 0 0.294316 -0.000490598 0 0.0637466 -0.00742694 0 + 0.067587 0.0229615 0 0.261253 -0.000771949 0 0.264326 -0.023573 0 0.364888 -0.119115 0 + 0.0805774 0.000937223 0 0.310693 0.0356314 0 0.256299 -0.0119713 0 0.140747 -0.00900951 0 + 0.0489609 0.000169733 0 0.0752418 0.000326695 0 0.363641 0.0776374 0 0.0393234 1.03824e-05 0 + 0.274391 0.0477648 0 0.269303 -0.00244939 0 0.254442 -0.00182622 0 0.00394617 -0.0020794 0 + 0.0515567 -0.000178638 0 0.290021 -0.000857313 0 0.37291 -0.0100273 0 0.277975 -0.00210059 0 + 0.279039 -0.0017304 0 0.278983 -0.0114748 0 0.279513 -0.0157111 0 0.144583 -0.00503361 0 + 0.165141 0.0318744 0 0.0598021 0.000137427 0 0.0332293 2.26284e-05 0 0.269298 0.180605 0 + 0.382528 -0.0453292 0 0.314068 0.0888155 0 0.177661 0.179881 0 0.277614 0.000519548 0 + 0.274935 0.000577965 0 0.376218 0.00672108 0 0.291418 -0.00634273 0 0.0750643 -0.00311533 0 + 0.102939 -0.000404834 0 0.0424617 0.000197006 0 0.0570039 2.2582e-05 0 0.030943 -3.45951e-05 0 + 0.0960779 -0.01533 0 0.387709 -0.0172867 0 0.27186 -0.000415565 0 0.263824 -0.00141955 0 + 0.277209 -0.00189462 0 0.250572 0.0314088 0 0.281479 0.00935239 0 0.390687 -0.064821 0 + 0.25344 0.00359603 0 0.136853 -0.0103218 0 0.100796 -0.00133658 0 0.0654636 -8.36467e-05 0 + 0.248955 -0.0520752 0 0.0426011 0.00653268 0 0.372881 -0.00304268 0 0.271042 0.184927 0 + 0.378532 0.00223265 0 0.274322 0.0953492 0 0.0646015 -0.010756 0 0.121806 0.019979 0 + 0.0254355 0.0569352 0 0.113625 -0.0036986 0 0.12857 0.020542 0 0.273369 -0.00186017 0 + 0.276744 -0.00182839 0 0.0415826 5.32272e-05 0 0.0359969 3.50474e-05 0 0.273581 -0.0982531 0 + 0.259474 -0.000444391 0 0.00185575 0.00759518 0 0.26297 -0.000398873 0 0.268594 -0.00321145 0 + 0.205118 -0.00383924 0 0.051178 0.000211055 0 0.0329801 -5.28596e-06 0 0.0154348 -3.93726e-06 0 + 0.0159215 8.44458e-07 0 0.122222 0.124169 0 0.250688 0.147824 0 0.265168 -0.00042373 0 + 0.0153206 -0.00260881 0 0.319554 0.0372211 0 0.255571 0.00364968 0 0.300931 -0.0252664 0 + 0.0756296 0.000231357 0 0.0990073 0.000314192 0 0.27674 -0.00247966 0 0.0558665 -0.0133877 0 + 0.0890552 0.0151901 0 0.261104 -0.000816491 0 -0.000699324 -0.00105697 0 0.0778328 0.00355798 0 + 0.251565 0.00347569 0 0.325144 0.0206574 0 0.266041 -0.000388746 0 0.0406362 2.32608e-06 0 + 0.359466 -0.10628 0 0.191809 0.0549073 0 0.305446 -0.0103303 0 0.384364 0.00849361 0 + 0.306968 -0.0283556 0 0.326224 0.0385354 0 -0.0100496 -0.00231238 0 0.194693 0.19186 0 + 0.012906 -0.00674283 0 0.0115977 0.00414108 0 0.102486 -0.00306005 0 0.205525 0.0346014 0 + 0.385246 0.115604 0 0.255106 0.00751327 0 0.279968 0.00722733 0 0.270209 -0.0169393 0 + 0.189016 -0.186438 0 0.244416 0.00262641 0 0.114422 -0.0135546 0 0.277804 0.000246907 0 + 0.369468 -0.124812 0 0.281566 9.27727e-05 0 0.325473 0.0144778 0 0.181324 -0.179537 0 + 0.272865 0.000683177 0 0.278816 -0.0163558 0 0.262456 -0.000337639 0 0.309932 0.0363333 0 + 0.370458 0.118089 0 0.234403 0.0949762 0 0.28791 -0.000792927 0 0.219333 0.0139206 0 + 0.256165 -0.00195831 0 0.126011 0.0327476 0 0.0276273 7.38957e-06 0 0.276365 0.000303143 0 + 0.00855886 4.77265e-06 0 0.200126 0.0202364 0 0.139658 0.0165759 0 0.0708464 0.0405217 0 + 0.319481 0.000958852 0 0.0348651 -3.02038e-05 0 0.0989862 -0.0390032 0 0.155062 0.0253885 0 + 0.0638743 0.0574634 0 0.356108 0.0296143 0 0.148857 -0.0155661 0 0.274057 0.000864687 0 + 0.0249114 0.00470685 0 0.296901 -0.0375128 0 0.00543983 0.0167179 0 0.181654 0.0305862 0 + 0.123831 0.0206942 0 0.255844 -0.115354 0 0.152655 -0.0275765 0 0.130348 -0.000590603 0 + 0.269691 -0.00109004 0 0.0980054 -0.000388158 0 0.274587 0.000783627 0 0.0777978 -0.00459704 0 + 0.258647 -0.000283234 0 0.278803 0.0476166 0 0.0704898 -0.0214788 0 0.063269 -0.000160348 0 + 0.321574 0.00623239 0 0.323696 -0.181016 0 0.033062 -2.96008e-05 0 0.25457 0.00549118 0 + 0.00879347 0.0239344 0 0.237016 0.0244191 0 0.250299 0.0190854 0 0.138477 0.00284884 0 + 0.272172 0.0946049 0 0.00927434 2.07247e-05 0 0.250513 0.107359 0 0.273706 -0.0940134 0 + 0.270766 -0.00356325 0 0.165952 -0.0839415 0 0.288468 -0.000917634 0 0.299146 -0.0353978 0 + 0.219469 -5.88338e-05 0 0.249319 0.0187331 0 0.0386895 -1.9865e-05 0 0.239894 -0.0107441 0 + 0.335602 0.0159062 0 0.317602 0.0873251 0 0.277253 0.000462816 0 0.266185 -0.0108932 0 + 0.372188 0.0676104 0 0.388858 0.0150818 0 0.277614 0.000358335 0 0.235755 -0.00130929 0 + 0.335752 0.0175468 0 0.0190651 -0.0078282 0 0.169515 0.0404019 0 0.0908041 -0.0209983 0 + 0.0538365 2.34079e-05 0 0.356887 0.0313354 0 0.0393823 -0.00720885 0 0.0579921 2.53882e-05 0 + 0.00194127 0.00278324 0 0.286987 -0.00934053 0 0.311046 -0.0377782 0 0.0562433 -6.50916e-05 0 + 0.198535 -0.00807468 0 0.333255 -0.0672042 0 0.0633241 0.0117355 0 0.29149 -0.0365391 0 + -0.0143608 -6.87981e-05 0 0.242505 -0.000182876 0 0.273362 0.000933382 0 0.293478 -0.0974821 0 + 0.0655143 0.000105671 0 0.240531 0.00521762 0 0.217969 -0.101843 0 0.290094 0.0452182 0 + 0.079945 -9.1427e-05 0 0.275358 -0.0021449 0 0.0965723 -0.000361776 0 0.38198 0.121621 0 + 0.147472 -0.168317 0 0.0470771 6.73186e-05 0 0.275909 -0.000754287 0 0.228077 -0.0102599 0 + 0.12287 -0.00378242 0 0.0271482 0.00321364 0 0.115944 -0.0290167 0 0.282897 0.000168097 0 + 0.242193 -0.00488825 0 0.0182339 0.00495179 0 0.344971 0.0644804 0 0.378807 -0.0268966 0 + 0.271702 -0.00241474 0 0.29169 -0.000582262 0 -0.00635411 -0.00522849 0 0.309172 0.0464449 0 + 0.0357489 5.07686e-05 0 0.249896 -0.0658141 0 0.31764 0.0317149 0 0.232979 -0.000180944 0 + 0.0541165 -0.00143642 0 0.122662 0.0232426 0 0.00532135 -0.00255945 0 0.221547 0.151818 0 + 0.243536 0.00490396 0 0.287092 -0.00113779 0 0.255418 0.00378646 0 0.252147 0.00626571 0 + 0.0207768 -6.59575e-05 0 0.173077 0.0273723 0 0.325645 -0.0911558 0 0.0682063 -0.000150489 0 + -0.000670364 -0.00186778 0 0.170623 -0.00177802 0 0.292077 -0.000465041 0 0.375738 0.115311 0 + 0.335739 -0.149601 0 0.0594339 9.2161e-05 0 0.015843 9.9827e-06 0 0.250938 -0.0689719 0 + 0.00760301 0.00121243 0 0.0400567 -0.00680353 0 0.269021 0.0151462 0 -0.00400433 0.00830669 0 + 0.269048 -0.0045491 0 0.226484 -0.0198358 0 0.283368 0.000156812 0 0.154867 -9.25246e-05 0 + 0.27701 0.000602924 0 0.216209 -0.142145 0 0.0773612 -0.0149428 0 0.212121 -0.0412268 0 + 0.0686344 0.000127071 0 0.163846 0.00210185 0 0.0815144 0.000204089 0 0.241495 0.0145819 0 + 0.261748 0.0292685 0 0.0975988 -0.000340778 0 0.352004 -0.148514 0 0.263624 0.00140596 0 + 0.119946 -0.113425 0 0.346759 0.0329976 0 0.0951935 -0.000271478 0 0.255531 0.0464719 0 + 0.0769793 0.00010332 0 0.359322 0.103665 0 0.302168 -0.0487154 0 0.291121 -0.102588 0 + 0.0415801 -0.00522351 0 0.392385 0.101741 0 0.274669 -0.00275527 0 0.232554 -0.00020049 0 + 0.276568 -0.00244276 0 0.238248 0.00445545 0 0.154503 0.0335692 0 0.215609 -0.00665521 0 + 0.277362 0.000573097 0 0.00490758 0.00576417 0 0.0380253 0.000150832 0 -0.00200454 0.00485827 0 + 0.075003 -1.80902e-05 0 0.187304 -0.027755 0 0.295523 -0.000382176 0 0.206446 0.0564785 0 + 0.25542 0.00232301 0 0.205871 -0.0258616 0 0.118491 0.000582219 0 0.00271399 -0.0120008 0 + 0.0926153 -0.000331317 0 0.326928 0.0174714 0 0.269679 0.00110318 0 0.228822 -0.0250975 0 + 0.272233 -0.00976846 0 0.214029 0.0170393 0 0.281277 6.1237e-05 0 0.281529 -4.3799e-05 0 + 0.285788 -0.0525237 0 0.203895 -0.1162 0 0.0794607 -0.014855 0 0.118534 -0.090797 0 + 0.0667895 -0.000135186 0 0.17692 0.135473 0 0.182492 -0.0319548 0 0.0501072 -8.48053e-05 0 + 0.378448 0.00444571 0 0.255595 0.00728173 0 0.323205 0.0336092 0 0.379956 0.0589586 0 + 0.275255 -0.00156406 0 0.269491 -0.000210559 0 0.281616 0.000223844 0 0.254641 -0.0950656 0 + 0.291251 -0.0515739 0 0.198256 0.101134 0 0.0795765 0.00012427 0 0.253465 -0.0709411 0 + 0.273217 0.0328913 0 0.265182 0.00174921 0 0.278021 0.000492945 0 0.0296547 0.00280017 0 + 0.0495616 -0.000528306 0 0.169436 -0.182592 0 0.353834 -0.0880545 0 0.284751 0.017815 0 + 0.16028 -0.000401591 0 0.344718 -0.170027 0 0.350646 0.170499 0 0.220367 0.0411479 0 + 0.320554 -0.0336858 0 0.225379 -0.0276018 0 0.0195902 -0.00343069 0 0.283225 0.181321 0 + 0.349393 0.0188097 0 0.0624711 -0.0488863 0 0.39414 0.0351427 0 0.143015 -0.0264615 0 + 0.183584 -0.000153199 0 0.0987581 0.000378972 0 0.307796 -0.15741 0 0.210124 0.0142685 0 + 0.278394 -0.0996259 0 0.0174515 1.97227e-06 0 0.0169705 -1.60202e-05 0 0.149529 -0.000572697 0 + 0.241539 -0.00563291 0 0.119386 0.154424 0 0.0511699 -0.0117723 0 0.190311 0.127188 0 + 0.0999872 0.000392617 0 -0.00413106 -0.00904329 0 0.0335714 0.00402908 0 0.282201 0.000199009 0 + 0.259226 0.0476572 0 0.282359 1.20966e-05 0 0.282581 -8.18449e-05 0 0.182477 0.0159413 0 + 0.0507708 0.0622003 0 0.264969 0.013186 0 -0.00826178 0.00389992 0 0.275058 -0.0486552 0 + 0.339675 -0.172456 0 0.376141 0.00122976 0 0.0609775 0.00221215 0 0.115948 0.136797 0 + 0.295208 0.0980332 0 0.0123891 0.00306342 0 0.280814 0.000221821 0 0.27716 0.000264181 0 + 0.231087 0.0230396 0 0.156462 -0.0260093 0 0.376339 0.14284 0 0.262964 -0.0014 0 + 0.107817 0.00495729 0 -0.00224232 0.00447819 0 0.0879889 0.00278537 0 0.0920913 -0.0023278 0 + 0.292223 -0.000112995 0 0.269213 0.0155418 0 0.0891987 0.00030202 0 0.111603 0.000540839 0 + 0.269322 0.00141033 0 0.0451271 -1.23915e-05 0 0.0330301 -0.00754763 0 0.0151885 -1.02527e-05 0 + -0.00152545 -0.00392634 0 0.00614298 -0.00125833 0 0.0165249 1.78681e-05 0 -0.0159463 0.000206536 0 + 0.010065 -0.0179922 0 0.125917 0.00858402 0 -0.00483102 -0.00868077 0 0.256359 -0.0187211 0 + 0.275829 -0.0135428 0 0.392047 0.0633197 0 0.291103 -0.000167055 0 0.0616317 -0.000146759 0 + 0.254995 -0.161179 0 0.268824 -0.00237813 0 0.274863 0.000731362 0 0.245126 -0.0220665 0 + 0.343516 0.020302 0 0.275848 0.000679289 0 0.261822 -0.000384638 0 0.391933 0.0217248 0 + 0.328908 0.0277403 0 0.284157 -0.163709 0 0.0592537 5.87108e-05 0 0.0567055 0.000107434 0 + 0.139907 -0.000884771 0 0.270017 -0.00332149 0 0.231912 -0.185899 0 0.119701 -0.000671702 0 + 0.373902 -0.00630073 0 0.194393 -0.0246617 0 0.00532777 0.00295613 0 0.385526 0.05367 0 + 0.0332156 1.46595e-05 0 0.0969579 -0.00823895 0 0.258287 -0.0268635 0 0.0150327 -6.2742e-06 0 + 0.0156921 7.44089e-06 0 0.00901028 0.00286283 0 0.230299 0.026885 0 0.381429 0.118841 0 + 0.269749 0.0193018 0 0.29812 -0.0946312 0 0.020143 -0.00295822 0 0.296563 -0.0236111 0 + 0.239113 0.0548791 0 0.35386 0.0733853 0 0.177188 0.0163226 0 0.2751 0.0205836 0 + 0.292125 0.131391 0 0.0827137 -0.0151957 0 0.0948173 -0.00807395 0 0.239496 -0.0201624 0 + -0.0092613 -0.00255188 0 0.338978 0.170257 0 0.232545 0.0301002 0 0.0398139 -0.000152175 0 + 0.281512 0.000194971 0 0.250275 -0.0828758 0 0.273897 -0.0362582 0 -0.000646837 0.00187831 0 + -0.00872985 0.000560032 0 0.260512 -0.000761757 0 0.191701 0.188753 0 0.00464987 0.00632825 0 + 0.0789579 -0.000220641 0 0.253498 0.0103348 0 0.257831 -0.125982 0 0.380122 -0.00399813 0 + 0.287681 -0.000985569 0 0.235882 -0.0222632 0 0.372629 -0.0143539 0 0.240615 0.00777202 0 + 0.249443 0.00972418 0 0.141714 -0.00957456 0 0.178357 -0.0317986 0 0.280038 0.000348201 0 + 0.263095 -0.0126963 0 0.364028 0.154578 0 0.233444 -0.0570308 0 0.253546 0.00907329 0 + 0.153512 -0.0489259 0 0.277964 -0.0826408 0 0.00837721 -8.90655e-06 0 0.351187 0.0715852 0 + 0.279374 -0.00201086 0 0.333243 0.182536 0 0.0356471 -2.5363e-05 0 0.0548492 0.00966567 0 + 0.0800386 -9.56172e-05 0 0.253673 0.170703 0 -0.00542092 -0.00801824 0 0.27622 -0.00244869 0 + 0.373329 0.063779 0 0.224141 -0.177736 0 0.0524477 3.1811e-05 0 0.0612243 -0.000129547 0 + 0.305616 -0.0431553 0 0.0224799 0.0329151 0 0.0855127 0.00202049 0 0.101412 0.000397178 0 + 0.239676 -0.00189897 0 0.0765424 -7.98842e-05 0 0.274009 -0.0229269 0 -0.0059464 -0.00709341 0 + 0.246422 0.00777225 0 0.293542 0.00449511 0 -0.00181681 0.00374492 0 0.041337 3.35917e-05 0 + 0.267818 -0.00413464 0 0.0853698 -0.000296918 0 0.104752 0.00275652 0 0.237573 0.041164 0 + 0.396217 0.0933092 0 0.0597931 0.000134002 0 0.061314 -0.106262 0 0.28196 0.000217171 0 + 0.12678 -0.000213733 0 0.346167 0.0720242 0 0.0115798 0.0033048 0 0.0768267 -0.000116305 0 + 0.113318 0.0699468 0 0.0321966 -0.0234862 0 0.27123 0.00117946 0 0.272325 0.0464008 0 + 0.276649 -0.0024676 0 0.275556 0.000599335 0 0.0531911 3.69323e-05 0 0.270672 -0.00216005 0 + 0.343928 0.0148244 0 0.1141 0.0146283 0 0.26673 0.00224503 0 0.0639761 3.07111e-05 0 + 0.252565 -0.00177856 0 0.0654082 -0.00350804 0 0.249381 -0.00177668 0 0.280582 0.000335979 0 + -0.011523 0.00342273 0 0.280093 -0.000264165 0 0.253242 0.00419772 0 0.288897 -0.000809414 0 + 0.0897404 -0.000296555 0 0.0379515 3.14246e-05 0 0.0449848 -6.40355e-05 0 0.0720855 -0.000184372 0 + 0.204758 -0.0374045 0 0.0165284 -1.71964e-05 0 0.00697937 -1.83571e-05 0 0.393719 0.0284985 0 + -0.0140248 0.00147615 0 0.0165269 1.8364e-05 0 0.00698375 2.54074e-05 0 0.0212967 -0.00147872 0 + 0.0115601 -5.31887e-05 0 0.0214753 0.00146832 0 0.0116507 7.84141e-05 0 0.28478 5.09174e-05 0 + 0.286031 3.53129e-05 0 0.19951 0.0144725 0 0.15953 -0.000663201 0 0.107217 -0.000156795 0 + 0.181132 0.164015 0 0.101389 0.00634807 0 0.117939 0.00422991 0 0.275396 0.00062827 0 + 0.0191697 -3.33977e-05 0 0.0197616 -3.71993e-05 0 0.0630596 0.000133776 0 0.190269 -0.0370335 0 + 0.295155 -0.000434328 0 0.295749 -0.000373999 0 0.0913737 -0.000200909 0 0.271442 -0.003464 0 + 0.166484 -0.00793119 0 0.00446576 0.00230325 0 0.395606 0.0972825 0 0.0480956 -0.00840527 0 + 0.0737573 -0.0050319 0 0.150824 0.000595201 0 0.0547245 0.0581452 0 0.286866 1.64713e-05 0 + 0.316636 0.139108 0 0.249713 -0.0296361 0 0.207278 0.0772464 0 0.0575026 0.000114813 0 + 0.0180037 -1.2075e-05 0 0.018076 2.65504e-06 0 0.278704 0.000448681 0 0.0246588 0.00288203 0 + 0.255883 -0.0726933 0 0.246238 0.0113753 0 0.281265 -0.00113547 0 0.382787 0.0532531 0 + 0.094196 -0.000237602 0 0.0165152 2.35467e-05 0 0.045525 5.33402e-05 0 0.257917 -0.000781714 0 + 0.291909 -0.138541 0 0.170358 0.0245448 0 0.277348 -0.00211995 0 0.358792 0.147726 0 + 0.250674 -0.00317125 0 0.267089 0.0016385 0 0.255281 -0.0864229 0 -0.0142261 0.00150994 0 + 0.25846 0.00297816 0 0.280357 0.000361875 0 0.242063 0.00464703 0 0.319627 0.0398753 0 + 0.0429701 -1.37052e-05 0 0.0893563 0.000199584 0 0.0934341 -0.000265 0 0.161996 0.00962569 0 + 0.0436141 -5.18894e-05 0 0.283191 -0.135723 0 0.0596562 -0.000137542 0 0.0867058 0.0115997 0 + 0.11691 -0.000425742 0 0.265334 0.00192619 0 0.225161 0.0144155 0 0.256758 0.00182863 0 + 0.211777 -0.0576587 0 0.28465 0.000102144 0 0.368373 0.134441 0 0.0764813 -7.51112e-05 0 + 0.250143 0.00512087 0 0.0885308 0.000298949 0 0.266018 0.00181247 0 0.153291 -0.00700467 0 + 0.0189717 -0.014104 0 0.0160855 1.76885e-05 0 0.232228 0.0114118 0 0.280545 0.0202347 0 + 0.0858443 0.123309 0 0.281164 0.000308677 0 0.240373 -0.00351032 0 0.258092 -0.0003355 0 + 0.271188 -0.01177 0 0.0492566 -7.81212e-05 0 0.0594777 -0.000113389 0 0.256759 0.00333685 0 + 0.276136 -0.00106962 0 0.30669 0.0202656 0 0.263308 -0.0018563 0 0.347667 0.0227924 0 + 0.0101521 0.000138567 0 0.283934 0.000134171 0 0.261144 -0.0439587 0 0.329703 0.00538909 0 + 0.253622 0.00781346 0 0.0356353 4.7127e-05 0 0.135548 -0.0181271 0 0.0790026 0.000130256 0 + 0.249665 -0.0603951 0 0.228028 -0.00119886 0 0.053921 2.6959e-05 0 0.014765 -7.67041e-06 0 + 0.0148868 6.21598e-06 0 0.102266 0.0002914 0 0.291342 -0.000540454 0 0.293206 -0.000498155 0 + 0.284613 0.000113626 0 0.266867 -0.00195528 0 0.0564865 -1.75602e-05 0 0.276685 0.000338937 0 + 0.323486 -0.0858273 0 0.286271 -0.000583352 0 0.288925 -0.0005576 0 0.370556 -0.024415 0 + 0.00704977 1.23652e-05 0 0.277914 -0.00144759 0 0.271748 -0.00352974 0 0.119108 0.00107975 0 + -0.000443463 -0.00161392 0 0.0754009 0.00182061 0 0.0973408 0.0158138 0 0.135216 0.100284 0 + 0.283331 0.000162614 0 0.312434 0.133211 0 0.283002 0.000167433 0 0.035733 3.51444e-05 0 + 0.258554 -0.00111359 0 0.0167354 1.70918e-05 0 0.268935 -0.00384999 0 0.270676 -0.00385799 0 + 0.280496 0.00535346 0 0.353014 0.0641208 0 0.263764 0.00226269 0 0.281648 0.000207246 0 + 0.269947 -0.00383668 0 0.07646 2.86642e-05 0 0.0152895 -9.96501e-06 0 0.0481262 8.81305e-05 0 + -0.00645615 -0.0059325 0 0.0143464 5.64973e-06 0 0.0144563 -1.02741e-05 0 0.386427 0.0589804 0 + 0.0382566 1.14131e-05 0 0.0518499 -4.9572e-05 0 0.0986944 0.000193023 0 0.0144233 -5.31245e-06 0 + 0.016705 -1.52448e-05 0 0.017214 3.29833e-06 0 0.0152684 -1.54091e-05 0 0.0151473 5.55737e-06 0 + 0.29723 -0.000231083 0 0.296852 -0.000263004 0 0.131982 0.000757235 0 0.262938 -0.00258191 0 + 0.0517704 -2.54672e-05 0 0.110779 -0.000321253 0 0.282441 0.000221652 0 0.292559 -0.000512866 0 + 0.294134 -0.000462669 0 0.015277 6.60437e-06 0 0.0148849 -8.20547e-06 0 0.109659 -0.0167432 0 + 0.277044 -0.000848733 0 0.283955 -0.00146538 0 0.0918894 -0.000290049 0 0.133433 -0.0042923 0 + 0.278781 0.000322775 0 -0.00699933 -0.0045878 0 0.269227 -0.00416015 0 0.276793 -0.00103021 0 + 0.275447 -0.00157193 0 0.00450744 0.00240221 0 0.0542505 9.75811e-05 0 0.0339332 0.0163114 0 + 0.257334 0.0021418 0 0.360618 -0.100483 0 0.209725 -0.0374749 0 -0.0112838 -0.00209126 0 + 0.365342 0.0674488 0 0.0982542 0.131783 0 0.10636 0.000291773 0 0.255793 0.00590672 0 + 0.376888 -0.0326865 0 0.38655 0.0519965 0 0.0184565 -1.39958e-05 0 0.278443 0.000221806 0 + 0.18419 -0.0381256 0 0.0123454 0.000968501 0 0.361197 0.0178084 0 0.116192 -0.0210053 0 + 0.171657 0.0237558 0 0.129974 0.0238863 0 0.19964 -0.015434 0 0.372156 0.124758 0 + 0.0552434 7.45573e-05 0 0.382081 0.132472 0 -0.00912344 -0.00400988 0 0.0748863 -0.0175742 0 + 0.39263 -0.0699806 0 0.286026 -0.00124125 0 0.0701009 -0.000341403 0 0.177189 0.0201521 0 + 0.254081 0.00568132 0 0.126741 -0.0999692 0 0.205103 -0.0370352 0 0.0981014 0.014769 0 + 0.334295 -0.00972545 0 0.0912137 0.0274626 0 0.22678 -0.000225441 0 0.0386947 1.33827e-05 0 + 0.187097 -0.000841818 0 0.0999859 0.034511 0 0.0449869 0.00729701 0 0.282211 0.197644 0 + 0.356052 0.165995 0 0.301 0.0294324 0 0.119621 -0.00131709 0 0.187832 -0.179653 0 + 0.283598 0.0135911 0 0.145225 -0.000984011 0 0.290491 -0.143999 0 0.247835 0.0114378 0 + -0.0111498 0.000485862 0 0.25505 -0.121282 0 0.0412024 -0.000321733 0 0.0815737 -0.00516403 0 + 0.319884 -0.0914697 0 0.0382732 -0.0150657 0 0.0874117 0.0204854 0 0.210135 -0.0873708 0 + 0.258781 -0.00471851 0 0.284639 -0.0164527 0 0.270459 -0.0102734 0 0.0578924 -0.000124677 0 + 0.280389 0.000345675 0 0.0637824 -0.0100247 0 0.0273301 -0.05006 0 0.242389 0.0104877 0 + 0.0946127 -0.00231256 0 0.209112 0.195267 0 0.0319227 -1.81393e-05 0 0.382585 -0.0416568 0 + 0.00547425 0.0172701 0 0.261431 -0.11826 0 0.387315 -0.0508969 0 0.26757 0.137419 0 + 0.257741 0.00202309 0 0.0634613 6.31997e-05 0 0.146168 0.00383976 0 0.0764922 0.00942204 0 + 0.0609886 -0.0195641 0 0.390607 -0.0604064 0 0.254072 -0.000279805 0 0.174935 -0.0374302 0 + 0.309067 0.00679787 0 0.0330667 -0.0709143 0 0.106441 0.00346302 0 0.226858 0.00535989 0 + -0.0148132 0.001056 0 0.0504887 -0.0177495 0 0.288095 0.130831 0 0.139921 -0.0334346 0 + 0.151921 -0.0183044 0 0.0419808 0.0120161 0 0.27229 -0.00159407 0 0.170109 0.0405573 0 + 0.0449735 6.38281e-05 0 0.107319 0.000121478 0 0.267287 -0.00354321 0 0.00686463 0.00443582 0 + 0.213611 0.0120207 0 0.377193 0.0212961 0 0.128857 0.0163014 0 0.0919155 -0.0218077 0 + 0.126925 -0.000681825 0 0.135634 -0.00531469 0 0.0943483 0.000349127 0 0.39421 0.101883 0 + 0.276656 0.140257 0 0.248205 -0.153976 0 0.323757 -0.00408888 0 0.211763 0.101227 0 + 0.00160678 0.0010549 0 0.26872 0.0927643 0 0.258589 -0.00146216 0 0.0946817 -0.0873814 0 + 0.24921 0.00621201 0 0.243381 0.112491 0 0.0597867 -9.42999e-05 0 0.175876 -0.0370239 0 + 0.189744 0.0324044 0 0.235684 0.11945 0 0.0865657 -0.00935456 0 -0.00617624 -0.00110965 0 + 0.0860548 0.000975732 0 0.126602 -0.00147713 0 0.257468 0.105184 0 0.274321 0.145649 0 + 0.256935 -0.0781784 0 0.173515 -0.000126022 0 0.180331 0.0410722 0 0.372982 -0.0422936 0 + 0.215639 0.0110058 0 0.00700492 -0.00140005 0 0.298439 -0.0109687 0 0.263663 -0.0139074 0 + 0.269241 0.144013 0 0.255157 0.00324342 0 0.191521 0.0156833 0 0.0550295 -0.00178868 0 + 0.24208 0.0203821 0 0.223196 -0.0456882 0 0.0429982 -0.0842313 0 0.374416 -0.122043 0 + 0.268183 -0.000753144 0 0.355946 0.070017 0 -0.00540813 0.00883781 0 0.28583 -0.141975 0 + 0.0606596 0.0115722 0 0.184935 0.0397671 0 0.0186692 0.00184839 0 0.368345 -0.130758 0 + 0.169358 -0.0267638 0 0.251834 0.0053301 0 0.239765 -0.100317 0 0.215484 -0.113855 0 + 0.139066 -0.00476286 0 -0.00149637 0.00380804 0 0.0642053 -7.08017e-05 0 0.263334 -0.0837063 0 + 0.008209 -3.39987e-06 0 0.106965 0.000218774 0 0.362637 -0.0194238 0 0.119049 0.0200861 0 + 0.174875 -0.00738833 0 0.231986 0.113681 0 0.0742572 -0.00516288 0 0.130201 0.0350573 0 + 0.276025 0.0270636 0 0.0076167 0.0213949 0 0.269313 -0.00946921 0 0.209087 0.0638819 0 + 0.132966 0.000728171 0 0.0342455 3.64567e-05 0 -0.0146727 -0.000528416 0 0.334632 -0.0629391 0 + 0.25917 0.0266234 0 0.037605 0.0416504 0 0.0520973 -0.00220635 0 0.26287 -0.0143048 0 + 0.0835978 0.000176245 0 0.00804427 -4.9322e-06 0 0.253631 0.00708083 0 0.356186 -0.0758017 0 + 0.0800487 -0.000248862 0 0.363609 0.0257719 0 0.267207 0.0182985 0 0.199863 -0.0064108 0 + 0.00868385 -5.54204e-06 0 0.00846842 -5.76322e-06 0 0.291327 -0.000487427 0 0.0148806 0.00242305 0 + 0.283698 -0.00107302 0 0.230656 -0.000370923 0 0.345261 -0.169754 0 0.368054 -0.144257 0 + 0.306695 0.0244787 0 -0.0113159 0.00203158 0 0.207632 -0.0145198 0 0.277619 0.00051791 0 + 0.0652377 8.3333e-05 0 0.266719 -0.00139431 0 0.31788 -0.00566792 0 0.117511 -0.0460007 0 + 0.299332 0.0462763 0 0.190274 -0.0767395 0 0.279081 0.000191938 0 0.201803 0.0181639 0 + 0.0841951 -0.000856997 0 0.388705 0.021262 0 0.366232 -0.0134774 0 0.372648 -0.130948 0 + 0.075512 0.019065 0 0.131127 -0.00263595 0 0.163558 -0.0198107 0 0.30761 0.00511868 0 + 0.0680724 0.000162745 0 0.261992 -0.0466816 0 0.262956 -0.0151315 0 0.290347 -0.0631137 0 + 0.234114 -0.012007 0 0.37016 -0.0457727 0 0.0181223 0.00293375 0 0.234453 0.107123 0 + 0.0336539 0.0157905 0 0.24583 0.00501499 0 0.288672 -0.0202141 0 0.222114 0.0406285 0 + 0.133086 0.00916465 0 0.172201 0.128003 0 0.20887 0.000122346 0 0.241059 0.170748 0 + 0.0691672 -0.000185545 0 0.0750992 -0.014711 0 0.196285 -0.0280754 0 0.234072 0.0457896 0 + 0.0617491 -0.013189 0 0.0118923 0.00516946 0 0.27645 0.000556747 0 0.31537 0.0145632 0 + 0.271604 -0.0192182 0 0.243911 -0.0614268 0 0.275472 -0.0025813 0 0.302225 0.144113 0 + 0.273635 -0.0103539 0 0.308002 0.11876 0 0.074539 0.000178144 0 0.348665 -0.0373916 0 + 0.193034 0.0354946 0 -0.0151479 -0.000169634 0 0.0412887 -3.54077e-05 0 0.229218 -0.0424275 0 + 0.00241735 0.00148675 0 0.06077 0.000113452 0 0.113544 0.149367 0 0.0309559 0.00787034 0 + 0.270069 -0.00362399 0 0.253941 0.0505286 0 0.13192 0.0712818 0 0.164055 9.62281e-05 0 + 0.254039 0.044291 0 0.208264 0.0362322 0 0.2405 0.0589853 0 0.265488 0.028465 0 + 0.0627672 0.0001456 0 0.031664 -0.0536117 0 0.00126645 -0.000828858 0 0.32636 -0.0416948 0 + 0.169399 -0.0181715 0 0.101587 0.0297214 0 0.387564 0.0414781 0 0.26878 0.0173568 0 + 0.00950919 5.63675e-06 0 0.270248 0.132426 0 0.0294008 0.00863809 0 0.26464 -0.00385107 0 + 0.318634 -0.0439746 0 0.259102 0.00153325 0 0.293038 0.0104039 0 0.130444 -0.00371881 0 + 0.160068 0.0202818 0 -0.00280611 0.00620587 0 0.105133 0.00101757 0 0.215716 -0.0175787 0 + 0.0908559 -0.0156882 0 0.169731 0.0387945 0 0.201521 0.0151302 0 0.261247 -0.0334509 0 + 0.00118675 -0.00566335 0 0.292481 0.0260467 0 0.0990134 -0.0837295 0 0.210401 -0.119135 0 + 0.345275 -0.0754851 0 0.38474 0.00226014 0 0.282696 0.0317472 0 0.125895 -0.0143993 0 + 0.0415206 0.0182969 0 0.375649 -0.126121 0 0.310761 0.0757416 0 0.253442 0.0566637 0 + 0.114623 -0.00371345 0 0.102518 0.00352266 0 0.0835288 0.0172759 0 0.0991025 0.0216526 0 + 0.208984 -0.0129012 0 0.34823 0.0284774 0 0.202238 0.0405913 0 0.348177 0.172877 0 + 0.0108274 0.00296016 0 0.288681 -3.36346e-05 0 0.108004 0.00852415 0 0.376168 0.0106078 0 + -0.00162943 -0.00322009 0 0.246904 -0.18375 0 0.0612957 -0.0204773 0 0.0623489 -1.74421e-05 0 + 0.300514 0.0325074 0 0.333912 -0.0389858 0 -0.00133905 -0.0037317 0 0.000328571 -0.000803985 0 + 0.00821978 4.48882e-06 0 0.0186691 8.89519e-06 0 0.0138365 -0.0262145 0 0.122569 0.0760606 0 + 0.231519 -0.176543 0 0.109167 -0.000153409 0 0.26182 0.0693631 0 0.278279 0.000449621 0 + 0.00534076 0.00590339 0 0.347243 0.0358412 0 0.083434 -0.000174717 0 0.0976044 0.00302358 0 + 0.287865 -0.000774326 0 0.250148 0.00337201 0 0.320299 -0.00709201 0 0.292149 -0.119375 0 + 0.329604 0.182829 0 0.366095 -0.112861 0 0.102133 -0.000481613 0 0.104952 0.000925377 0 + -0.0048549 0.00906153 0 0.182187 -0.188213 0 0.263408 0.136686 0 0.0236718 0.000910526 0 + 0.135813 0.0325612 0 0.166472 0.0391202 0 0.14919 0.0205719 0 0.0504344 -0.0113313 0 + 0.0681422 -0.0264566 0 0.10151 0.000593203 0 0.243132 0.0175316 0 0.278457 0.000269518 0 + 0.288436 -0.0993654 0 0.360809 -0.151202 0 0.0646111 0.00126825 0 0.202164 -0.0158516 0 + 0.152057 -0.0195303 0 0.203884 -0.108313 0 0.257514 0.0194568 0 0.0161283 -0.0280343 0 + 0.384344 -0.0109733 0 0.28872 -0.000976023 0 0.0898629 0.0172282 0 0.19712 0.0239132 0 + 0.0737687 -0.000861319 0 0.137995 0.00630532 0 0.115503 0.0263112 0 0.0410703 -0.0092632 0 + 0.0782698 -0.00724786 0 0.274383 0.13396 0 0.0881132 0.00259565 0 -0.0010416 -0.00215964 0 + 0.114191 0.0597703 0 0.288413 0.00877922 0 0.0644371 0.0117873 0 0.265845 0.177903 0 + 0.172071 0.0169753 0 0.33929 0.178643 0 0.147147 0.0214651 0 0.271973 -0.000846997 0 + 0.0332718 -0.00708691 0 0.252189 -0.129317 0 0.259559 0.00312816 0 0.185486 -0.0286383 0 + 0.034785 -1.6304e-05 0 0.0261887 -0.00470818 0 0.075602 -0.000655861 0 -0.0012734 0.00252972 0 + 0.0215155 0.000286634 0 0.113184 0.0221433 0 0.250768 0.0634169 0 0.002168 -0.00114599 0 + 0.194433 -0.000566881 0 0.265446 -0.0328683 0 0.359279 0.153445 0 0.307011 0.169494 0 + 0.297507 0.00755854 0 0.257382 -0.0521316 0 0.337287 -0.0385 0 0.284383 -0.0194642 0 + 0.0437008 -6.0048e-05 0 0.232251 0.0213499 0 0.10721 0.000656345 0 0.000411146 0.00789455 0 + 0.262956 0.071315 0 0.272689 0.0229996 0 0.230721 -0.0675153 0 0.243571 0.0272504 0 + 0.104655 0.00720548 0 0.0565247 -0.0196284 0 0.301341 -0.0769104 0 -0.00913131 -0.00250638 0 + 0.278114 0.000186209 0 0.294026 -0.000480725 0 0.0995122 0.000380034 0 0.109468 -0.0116316 0 + 0.283357 -0.100029 0 0.254698 0.00559688 0 0.260416 -0.00159577 0 0.265516 -0.0036229 0 + 0.019729 -0.00230004 0 0.367435 -0.141114 0 0.387621 -0.0413244 0 0.289017 0.00597296 0 + 0.00778269 -0.00260397 0 0.224547 0.0105689 0 0.06185 0.000142483 0 0.133213 0.0905728 0 + 0.175247 -0.02961 0 -0.00938164 0.00452991 0 0.293343 -0.00433344 0 0.107897 0.0423658 0 + 0.0495717 0.00852222 0 0.0767086 -0.00536356 0 0.131103 0.0246559 0 0.0582842 -2.98931e-05 0 + 0.267401 0.0157053 0 0.339365 -0.158444 0 0.259845 0.00298362 0 0.0720681 -0.000349506 0 + 0.0813406 0.116604 0 0.279072 0.000389774 0 0.290673 -0.000768591 0 -0.00765347 0.00259106 0 + 0.265898 -0.000869756 0 0.12945 -0.0323565 0 0.0256908 -0.0557697 0 0.0700633 0.00218174 0 + 0.259831 -0.0837658 0 0.205563 0.02775 0 0.00867581 0.00843107 0 -0.00854145 0.00584152 0 + 0.235576 -0.060696 0 0.00798806 -0.0031482 0 0.214504 -0.0545274 0 0.355767 -0.027984 0 + 0.245139 -0.0816692 0 0.0421915 0.00715255 0 0.298769 0.0166072 0 0.130008 0.000776417 0 + 0.0832391 0.000133258 0 0.170547 0.00199072 0 0.239929 -0.00267476 0 0.259918 0.0031313 0 + 0.208024 -0.0349436 0 0.0130046 0.00131037 0 0.169472 0.034928 0 0.117905 -0.0127047 0 + 0.38346 -0.102523 0 0.149734 -0.126756 0 0.315434 -0.0421423 0 0.280216 0.000228838 0 + 0.295188 -0.000420167 0 0.0346973 0.0179144 0 0.203517 -0.18791 0 0.281771 -0.00867092 0 + 0.247883 -0.0821423 0 0.310815 0.0391901 0 0.348502 -0.0624713 0 0.055428 -0.000876906 0 + 0.255051 -0.0140111 0 0.19538 0.0215599 0 0.0157105 -0.00038203 0 0.103572 0.000635492 0 + 0.265132 0.00133141 0 0.261969 0.00140783 0 0.00165685 0.00040508 0 0.255858 -0.0142143 0 + 0.0774464 0.0168061 0 0.300093 0.0740673 0 0.060343 1.39556e-05 0 0.285808 0.00664706 0 + 0.36426 0.14405 0 0.378219 0.10539 0 0.212134 0.113118 0 0.255108 0.0103711 0 + 0.0466405 0.0119636 0 0.255429 0.0545844 0 0.243201 0.0181747 0 0.0909635 0.0185098 0 + 0.125645 -0.00433555 0 0.0494135 -0.0178598 0 0.24948 -0.0303853 0 0.206432 0.0135831 0 + 0.0100254 0.00309388 0 0.100241 0.00316683 0 0.0996188 5.95602e-05 0 0.263062 -0.000837676 0 + 0.244492 -0.000102119 0 0.222744 0.0443175 0 0.385215 -0.0100211 0 0.278819 0.000158385 0 + 0.0443281 -0.0160916 0 0.335067 -0.0395405 0 0.156425 -0.00537866 0 0.305395 -0.00197615 0 + 0.00756264 1.19962e-06 0 0.281816 0.0221397 0 0.281434 0.000118372 0 0.287672 -0.0204701 0 + 0.0311453 1.5695e-05 0 0.0493546 9.55349e-05 0 0.282298 0.00666261 0 0.0246347 -0.0307999 0 + 0.129241 0.146067 0 0.320436 0.181822 0 0.0245123 -0.0284317 0 -0.00936666 0.00530925 0 + 0.0535435 0.00960249 0 0.256844 0.0455249 0 0.242826 0.0292795 0 0.00662598 -0.0026958 0 + 0.114913 0.0238353 0 0.365301 -0.0120741 0 -0.00519534 -0.00083463 0 0.179398 0.0125564 0 + 0.22854 -3.9666e-05 0 0.265428 0.0603759 0 0.278945 0.000160579 0 0.307359 0.0449322 0 + 0.00981491 -0.00281541 0 0.320046 0.0452164 0 0.387263 0.045521 0 0.00245025 -0.00601617 0 + 0.250558 -0.0238355 0 0.0751635 0.0050991 0 0.277964 0.000128648 0 0.276968 0.000357561 0 + 0.0494066 0.000695694 0 0.317083 -0.0370225 0 0.0362418 0.0133898 0 0.227994 0.0519985 0 + 0.0198164 0.00419782 0 0.0515463 0.00236665 0 0.317466 0.129098 0 0.0448987 -0.00635401 0 + 0.373362 0.134372 0 0.147665 0.0205243 0 0.106246 0.0269344 0 -0.00158078 0.00276667 0 + 0.100201 -0.0114343 0 0.252176 0.00389399 0 0.226428 0.0782895 0 0.0986361 -0.000489035 0 + 0.268569 -0.00085444 0 0.310256 0.00176648 0 0.00564631 -0.00256215 0 0.250037 -0.0714413 0 + 0.126879 -0.0179618 0 0.282938 0.000183418 0 0.150581 0.136266 0 0.0410835 -1.26014e-06 0 + 0.0475584 0.00192343 0 0.0659365 0.0170042 0 0.0836727 -0.0178502 0 0.276604 -0.0178007 0 + 0.358705 0.117966 0 0.118102 0.00646082 0 -0.00200431 -0.00505408 0 0.126219 -0.0104205 0 + 0.267228 0.0211773 0 0.0867791 -0.00128809 0 0.269543 -0.0150988 0 0.232721 0.00803745 0 + 0.103044 0.0246165 0 0.379633 -0.0575206 0 0.313477 -0.0373774 0 0.024134 -0.00225738 0 + 0.0799163 0.005761 0 0.101258 0.019099 0 0.0593693 0.0587683 0 -0.00165788 0.000897743 0 + 0.0673498 0.000161855 0 0.191052 -0.0345201 0 0.294762 -0.000276006 0 0.250927 0.00812603 0 + 0.244931 0.0331404 0 0.308168 0.0114006 0 0.00486796 -0.00105908 0 0.267802 -0.187405 0 + -0.00757633 0.00346528 0 0.171819 0.0230508 0 0.000371708 -0.0026354 0 0.312597 0.00391557 0 + 0.178986 -0.0206716 0 0.0306148 -9.37826e-06 0 -0.0111566 0.00241338 0 0.347205 0.108017 0 + 0.214272 -0.0272905 0 0.262484 0.0364151 0 0.279249 0.000232739 0 0.317819 -0.0426553 0 + 0.0555364 1.00892e-05 0 0.366186 0.0236596 0 0.265664 0.0110433 0 0.08938 -0.0143251 0 + 0.188741 0.0358074 0 0.0561096 4.16589e-05 0 0.160354 0.000688067 0 0.262044 0.00153799 0 + 0.264034 0.0489267 0 0.304287 -0.0429662 0 0.00876095 -4.63373e-06 0 0.00185598 -0.00114509 0 + 0.116977 -0.024989 0 0.282113 -0.036808 0 0.113042 0.000846121 0 -0.00175623 -0.00462261 0 + 0.27311 0.000908402 0 0.0320562 -5.33786e-06 0 0.074634 0.100863 0 0.120001 0.0282119 0 + 0.105793 -0.000400464 0 0.227008 0.0451945 0 0.00633016 0.00173655 0 0.100121 0.00668065 0 + 0.315678 0.0377763 0 0.147477 -0.118102 0 0.0540092 -0.000264207 0 0.173646 0.157339 0 + 0.315887 0.0159266 0 0.0384713 0.0104018 0 0.320545 -0.142798 0 0.0191989 -0.00456784 0 + 0.0793742 0.00315574 0 0.0116417 0.00142375 0 0.257602 -0.158287 0 0.257464 0.0462096 0 + 0.27539 0.0761152 0 0.0823304 -0.000223179 0 0.209293 -0.0181045 0 0.0301866 4.04988e-06 0 + 0.185417 0.0423035 0 0.0246786 -0.0014429 0 0.162478 0.023745 0 0.0505753 1.62855e-05 0 + 0.0454916 0.0502525 0 0.327201 0.0811717 0 0.285956 0.0156237 0 0.286809 -0.118809 0 + 0.0660958 0.0313739 0 0.243417 0.0169058 0 0.049865 -0.00695464 0 0.0148774 0.00282416 0 + 0.290557 -0.000808623 0 0.277366 -0.00151168 0 0.0882753 0.0265394 0 0.252057 -0.00372997 0 + 0.32538 -0.0217969 0 0.121095 0.151259 0 0.105644 0.0217185 0 0.291192 -0.000169374 0 + 0.262807 0.0644545 0 0.0720912 3.6244e-05 0 0.285892 -0.000156224 0 0.0423471 3.79131e-05 0 + 0.0127214 0.00267027 0 0.0774053 0.000200522 0 0.279506 0.000143099 0 0.258934 0.0528067 0 + 0.117117 -0.0562397 0 0.39145 -0.0873157 0 0.131312 -0.0044425