From d32ea0fca0af5b851fbd5c0ec651754cc8e428d0 Mon Sep 17 00:00:00 2001 From: Thomas Richter Date: Wed, 21 Aug 2024 14:43:44 +0200 Subject: [PATCH 01/21] Added the dG(0) variable SeasurfaceHeight. This variable has to be set from outside. CGDynamicsKernel::prepareIteration will compute the gradient of SeasurfaceHeight and stores it as CG-Vectors uGradSeasurfaceHeight and vGradSeasurfaceHeight ins CGDynamicsKernel. VPCGDynamicsKernel is using it in main update loop. Before merging we should activate a ice-only testcase. --- dynamics/src/CGDynamicsKernel.cpp | 150 ++++++++++++++++++++ dynamics/src/ParametricMap.cpp | 73 +++++++++- dynamics/src/include/CGDynamicsKernel.hpp | 6 + dynamics/src/include/DynamicsKernel.hpp | 6 + dynamics/src/include/DynamicsParameters.hpp | 4 + dynamics/src/include/ParametricMap.hpp | 14 ++ dynamics/src/include/VPCGDynamicsKernel.hpp | 12 +- 7 files changed, 259 insertions(+), 6 deletions(-) diff --git a/dynamics/src/CGDynamicsKernel.cpp b/dynamics/src/CGDynamicsKernel.cpp index 332f68047..942058631 100644 --- a/dynamics/src/CGDynamicsKernel.cpp +++ b/dynamics/src/CGDynamicsKernel.cpp @@ -36,6 +36,9 @@ void CGDynamicsKernel::initialise( cgH.resize_by_mesh(*smesh); cgA.resize_by_mesh(*smesh); + uGradSeasurfaceHeight.resize_by_mesh(*smesh); + vGradSeasurfaceHeight.resize_by_mesh(*smesh); + dStressX.resize_by_mesh(*smesh); dStressY.resize_by_mesh(*smesh); @@ -104,6 +107,149 @@ template void CGDynamicsKernel::prepareAdvection( dgtransport->prepareAdvection(u, v); } +template void CGDynamicsKernel::ComputeGradientOfSeaSurfaceHeight(const DGVector<1>& SeasurfaceHeight) +{ + // First transform to CG1 Vector and do all computations in CG1 + CGVector<1> cgSeasurfaceHeight(*smesh); + Interpolations::DG2CG(*smesh, cgSeasurfaceHeight, SeasurfaceHeight); + + CGVector<1> uGrad(*smesh); + CGVector<1> vGrad(*smesh); + uGrad.setZero(); + vGrad.setZero(); + + + // parallelization in stripes + for (size_t p = 0; p < 2; ++p) { +#pragma omp parallel for schedule(static) + for (size_t cy = 0; cy < smesh->ny; ++cy) { + //!< loop over all cells of the mesh + if (cy % 2 == p) { + size_t eid = smesh->nx * cy; + size_t cg1id = cy*(smesh->nx+1); + for (size_t cx = 0; cx < smesh->nx; ++cx, ++eid, ++cg1id) + { + // get local CG nodes + Eigen::Vector loc_cgSSH = + {cgSeasurfaceHeight(cg1id), + cgSeasurfaceHeight(cg1id+1), + cgSeasurfaceHeight(cg1id+smesh->nx+1), + cgSeasurfaceHeight(cg1id+smesh->nx+1+1)}; + + // compute grad + Eigen::Vector tx = pmap->dX_SSH[eid] * loc_cgSSH; + Eigen::Vector ty = pmap->dY_SSH[eid] * loc_cgSSH; + + // add global vector + uGrad(cg1id) -= tx(0); + uGrad(cg1id+1) -= tx(1); + uGrad(cg1id+smesh->nx+1) -= tx(2); + uGrad(cg1id+smesh->nx+1+1) -= tx(3); + vGrad(cg1id) -= ty(0); + vGrad(cg1id+1) -= ty(1); + vGrad(cg1id+smesh->nx+1) -= ty(2); + vGrad(cg1id+smesh->nx+1+1) -= ty(3); + } + } + } + } + + // scale with mass +#pragma omp parallel for + for (size_t i=0;ilumpedcg1mass(i); + vGrad(i) /= pmap->lumpedcg1mass(i); + } + + ///// correct boundary (just extend in last elements) + size_t cg1row = smesh->nx+1; + size_t topleft = smesh->ny*cg1row; + for (size_t i=1;inx;++i) // bottom / top + { + uGrad(i) = uGrad(i+cg1row); + vGrad(i) = vGrad(i+cg1row); + uGrad(topleft+i) = uGrad(topleft+i-cg1row); + vGrad(topleft+i) = vGrad(topleft+i-cg1row); + } + for (size_t i=1;iny;++i) // left / right + { + uGrad(i*cg1row) = uGrad(i*cg1row+1); + vGrad(i*cg1row) = vGrad(i*cg1row+1); + + uGrad(i*cg1row+cg1row-1) = uGrad(i*cg1row+cg1row-1-1); + vGrad(i*cg1row+cg1row-1) = vGrad(i*cg1row+cg1row-1-1); + } + // corners + uGrad(0) = uGrad(cg1row+1); + vGrad(0) = vGrad(cg1row+1); + uGrad(smesh->nx) = uGrad(smesh->nx + cg1row - 1); + vGrad(smesh->nx) = vGrad(smesh->nx + cg1row - 1); + uGrad(smesh->ny*cg1row) = uGrad((smesh->ny-1)*cg1row+1); + vGrad(smesh->ny*cg1row) = vGrad((smesh->ny-1)*cg1row+1); + uGrad((smesh->ny+1)*cg1row-1) = uGrad((smesh->ny)*cg1row-1-1); + vGrad((smesh->ny+1)*cg1row-1) = vGrad((smesh->ny)*cg1row-1-1); + + // Interpolate to CG2 (maybe own function in interpolation?) + if (CGDEGREE==1) + { + uGradSeasurfaceHeight = uGrad; + vGradSeasurfaceHeight = vGrad; + } + else + { + // outer nodes + size_t icg1 = 0; +#pragma omp parallel for + for (size_t iy=0;iy<=smesh->ny;++iy) + { + size_t icg2 = (2*smesh->nx+1)*2*iy; + for (size_t ix=0;ix<=smesh->nx;++ix,++icg1,icg2+=2) + { + uGradSeasurfaceHeight(icg2) = uGrad(icg1); + vGradSeasurfaceHeight(icg2) = vGrad(icg1); + } + } + // along lines +#pragma omp parallel for + for (size_t iy=0;iy<=smesh->ny;++iy) // horizontal + { + size_t icg1 = (smesh->nx+1)*iy; + size_t icg2 = (2*smesh->nx+1)*2*iy+1; + for (size_t ix=0;ixnx;++ix,++icg1,icg2+=2) + { + uGradSeasurfaceHeight(icg2) = 0.5 * (uGrad(icg1)+uGrad(icg1+1)); + vGradSeasurfaceHeight(icg2) = 0.5 * (vGrad(icg1)+vGrad(icg1+1)); + } + } +#pragma omp parallel for + for (size_t iy=0;iyny;++iy) // vertical + { + size_t icg1 = (smesh->nx+1)*iy; + size_t icg2 = (2*smesh->nx+1)*(2*iy+1); + for (size_t ix=0;ix<=smesh->nx;++ix,++icg1,icg2+=2) + { + uGradSeasurfaceHeight(icg2) = 0.5 * (uGrad(icg1)+uGrad(icg1+cg1row)); + vGradSeasurfaceHeight(icg2) = 0.5 * (vGrad(icg1)+vGrad(icg1+cg1row)); + } + } + + // midpoints +#pragma omp parallel for + for (size_t iy=0;iyny;++iy) // vertical + { + size_t icg1 = (smesh->nx+1)*iy; + size_t icg2 = (2*smesh->nx+1)*(2*iy+1)+1; + for (size_t ix=0;ixnx;++ix,++icg1,icg2+=2) + { + uGradSeasurfaceHeight(icg2) = 0.25 * (uGrad(icg1)+uGrad(icg1+1)+uGrad(icg1+cg1row)+uGrad(icg1+cg1row+1)); + vGradSeasurfaceHeight(icg2) = 0.25 * (vGrad(icg1)+vGrad(icg1+1)+vGrad(icg1+cg1row)+vGrad(icg1+cg1row+1)); + } + } + } +} + + template void CGDynamicsKernel::prepareIteration(const DataMap& data) { // interpolate ice height and concentration to local cg Variables @@ -112,6 +258,10 @@ template void CGDynamicsKernel::prepareIteration( Interpolations::DG2CG(*smesh, cgA, data.at(ciceName)); VectorManipulations::CGAveragePeriodic(*smesh, cgA); + // Reinit the gradient of the sea surface height. Not done by + // DataMap as SeasurfaceHeight is always dG(0) + ComputeGradientOfSeaSurfaceHeight(DynamicsKernel::SeasurfaceHeight); + // limit A to [0,1] and H to [0, ...) cgA = cgA.cwiseMin(1.0); cgA = cgA.cwiseMax(1.e-4); diff --git a/dynamics/src/ParametricMap.cpp b/dynamics/src/ParametricMap.cpp index abfcd2a34..ad9300e0e 100644 --- a/dynamics/src/ParametricMap.cpp +++ b/dynamics/src/ParametricMap.cpp @@ -86,6 +86,8 @@ template void ParametricTransportMap::InitializeInverseDGMassMatrix //! template void ParametricMomentumMap::InitializeLumpedCGMassMatrix() { + // Compute lumped mass matric for cG(CG) + lumpedcgmass.resize_by_mesh(smesh); lumpedcgmass.zero(); @@ -151,11 +153,59 @@ template void ParametricMomentumMap::InitializeLumpedCGMassMatrix() } } // VectorManipulations::CGAddPeriodic(smesh, lumpedcgmass); + + // Build the cG1 mass matrix. If CG=1 this is redundant. But CG=2 is standard. + lumpedcg1mass.resize_by_mesh(smesh); + lumpedcg1mass.zero(); + + for (size_t p = 0; p < 2; ++p) // for parallelization + { +#pragma omp parallel for + for (size_t iy = p; iy < smesh.ny; iy += 2) + for (size_t ix = 0; ix < smesh.nx; ++ix) { + size_t eid = smesh.nx * iy + ix; + + Eigen::Vector Meid; + + if (smesh.CoordinateSystem == CARTESIAN) { + const Eigen::Matrix J + = ParametricTools::J<2>(smesh, eid).array() + * GAUSSWEIGHTS<2>.array(); + + Meid = PHI<1, 2> * J.transpose(); + } else if (smesh.CoordinateSystem == SPHERICAL) { + const Eigen::Matrix cos_lat + = (ParametricTools::getGaussPointsInElement<2>(smesh, eid) + .row(1) + .array()) + .cos(); + + const Eigen::Matrix J + = ParametricTools::J<2>(smesh, eid).array() + * GAUSSWEIGHTS<2>.array() * cos_lat.array(); + + Meid = PHI<1, 2> * J.transpose(); + } else + abort(); + + // index of first dof in element + const size_t sy = smesh.nx + 1; + const size_t n0 = iy * sy + ix; + + lumpedcg1mass(n0, 0) += Meid(0); + lumpedcg1mass(n0 + 1, 0) += Meid(1); + + lumpedcg1mass(n0 + sy, 0) += Meid(2); + lumpedcg1mass(n0 + 1 + sy, 0) += Meid(3); + } + } } //! template void ParametricMomentumMap::InitializeDivSMatrices() { + dX_SSH.resize(smesh.nelements); + dY_SSH.resize(smesh.nelements); divS1.resize(smesh.nelements); divS2.resize(smesh.nelements); iMgradX.resize(smesh.nelements); @@ -198,9 +248,16 @@ template void ParametricMomentumMap::InitializeDivSMatrices() dy_cg2 = PHIy.array().rowwise() * Fx.row(0).array() - PHIx.array().rowwise() * Fy.row(0).array(); - // PSI83 is the DG-Basis-function in the guass-point - // PSI83_{iq} = PSI_i(q) [ should be called DG_in_GAUSS ] + // same but using CG1 basis functions. Required for SeasurfaceHeight + const Eigen::Matrix + dx_cg1 = PHIx<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.array().rowwise() * Fy.row(1).array() + - PHIy<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.array().rowwise() * Fx.row(1).array(); + const Eigen::Matrix + dy_cg1 = PHIy<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.array().rowwise() * Fx.row(0).array() + - PHIx<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.array().rowwise() * Fy.row(0).array(); + + const Eigen::Matrix J = ParametricTools::J(smesh, eid); @@ -208,6 +265,12 @@ template void ParametricMomentumMap::InitializeDivSMatrices() // divS is used for update of stress (S, nabla Phi) in Momentum divS1[eid] = dx_cg2 * PSI.transpose(); divS2[eid] = dy_cg2 * PSI.transpose(); + + // dX_SSH and dY_SSH are used to compute the gradient of the sea surface height + // they store (d_[x/y] PHI_j, PHI_i) + dX_SSH[eid] = dx_cg1 * PHI<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.transpose(); + dY_SSH[eid] = dy_cg1 * PHI<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.transpose(); + // iMgradX/Y (inverse-Mass-gradient X/Y) is used to project strain rate from CG to DG const Eigen::Matrix imass @@ -250,6 +313,12 @@ template void ParametricMomentumMap::InitializeDivSMatrices() * PSI.transpose() / Nextsim::EarthRadius; + // same for CG1 (Sea-Surface Height) + dX_SSH[eid] = dx_cg1 * PHI<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.transpose() / Nextsim::EarthRadius; + dY_SSH[eid] = (dy_cg1.array().rowwise() * cos_lat.array()).matrix() + * PHI<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.transpose() / Nextsim::EarthRadius; + + const Eigen::Matrix imass = SphericalTools::massMatrix(smesh, eid).inverse(); iMgradX[eid] = imass * divS1[eid].transpose(); diff --git a/dynamics/src/include/CGDynamicsKernel.hpp b/dynamics/src/include/CGDynamicsKernel.hpp index 0705e3e79..97951daf0 100644 --- a/dynamics/src/include/CGDynamicsKernel.hpp +++ b/dynamics/src/include/CGDynamicsKernel.hpp @@ -42,8 +42,10 @@ class CGDynamicsKernel : public DynamicsKernel { } virtual ~CGDynamicsKernel() = default; void initialise(const ModelArray& coords, bool isSpherical, const ModelArray& mask) override; + void setData(const std::string& name, const ModelArray& data) override; ModelArray getDG0Data(const std::string& name) const override; + void ComputeGradientOfSeaSurfaceHeight(const DGVector<1>& SeasurfaceHeight); void prepareIteration(const DataMap& data) override; void projectVelocityToStrain() override; void stressDivergence() override; @@ -61,6 +63,10 @@ class CGDynamicsKernel : public DynamicsKernel { CGVector cgA; CGVector cgH; + // CG gradient of the SeasurfaceHeight + CGVector uGradSeasurfaceHeight; + CGVector vGradSeasurfaceHeight; + // divergence of stress CGVector dStressX; CGVector dStressY; diff --git a/dynamics/src/include/DynamicsKernel.hpp b/dynamics/src/include/DynamicsKernel.hpp index a179ff8ac..35611011b 100644 --- a/dynamics/src/include/DynamicsKernel.hpp +++ b/dynamics/src/include/DynamicsKernel.hpp @@ -64,6 +64,8 @@ template class DynamicsKernel { hice.resize_by_mesh(*smesh); cice.resize_by_mesh(*smesh); + SeasurfaceHeight.resize_by_mesh(*smesh); + e11.resize_by_mesh(*smesh); e12.resize_by_mesh(*smesh); e22.resize_by_mesh(*smesh); @@ -72,6 +74,7 @@ template class DynamicsKernel { s22.resize_by_mesh(*smesh); } + /*! * @brief Sets the data from a provided ModelArray. * @@ -169,6 +172,9 @@ template class DynamicsKernel { DGVector hice; DGVector cice; + //! Vector storing the sea surface height (only dG(0) averages) + DGVector<1> SeasurfaceHeight; + //! Vectors storing strain and stress components DGVector e11, e12, e22; DGVector s11, s12, s22; diff --git a/dynamics/src/include/DynamicsParameters.hpp b/dynamics/src/include/DynamicsParameters.hpp index 72c3a9a70..fbd3484d5 100644 --- a/dynamics/src/include/DynamicsParameters.hpp +++ b/dynamics/src/include/DynamicsParameters.hpp @@ -27,6 +27,8 @@ class DynamicsParameters { double ocean_turning_angle; //!< Ocean turning angle + double gravity; //!< gravity parameter + DynamicsParameters() { rho_ice = 900.0; //!< Sea ice density @@ -43,6 +45,8 @@ class DynamicsParameters { ocean_turning_angle = 25.; //!< Ocean turning angle ocean_turning_angle = 0.0; // FIXME decide between ocean turning angles + + gravity = 9.81; //!< gravity parameter } }; } diff --git a/dynamics/src/include/ParametricMap.hpp b/dynamics/src/include/ParametricMap.hpp index c770911c5..379f1e1ec 100644 --- a/dynamics/src/include/ParametricMap.hpp +++ b/dynamics/src/include/ParametricMap.hpp @@ -66,6 +66,8 @@ template class ParametricMomentumMap { public: //! Vector to store the lumpes mass matrix. Is directly initialized when the mesh is known CGVector lumpedcgmass; + //! Vector to store the lumpes mass matrix in CG1. Neede to compute SeasurfaceGradient + CGVector<1> lumpedcg1mass; /*! * These matrices realize the integration of (-div S, phi) = (S, nabla phi) @@ -77,6 +79,18 @@ template class ParametricMomentumMap { Eigen::aligned_allocator>> divS1, divS2, divM; + /*! + * These matrices are used to compute the gradient of the sea surface height via + * ( gH, Phi) = ( d_[X/Y] SSH, Phi) + * where SSH is CG1-representation of SeasurfaceHeight + * + * Very similar to divS1 and divS2 but working in CG(1) vectors + */ + std::vector, + Eigen::aligned_allocator>> + dX_SSH, dY_SSH; + + /*! * These matrices realize the integration of (E, \grad phi) scaled with the * inverse mass matrix; diff --git a/dynamics/src/include/VPCGDynamicsKernel.hpp b/dynamics/src/include/VPCGDynamicsKernel.hpp index f223ef5f8..f029fbbb4 100644 --- a/dynamics/src/include/VPCGDynamicsKernel.hpp +++ b/dynamics/src/include/VPCGDynamicsKernel.hpp @@ -36,6 +36,8 @@ template class VPCGDynamicsKernel : public CGDynamicsKernel::u; using CGDynamicsKernel::v; + using CGDynamicsKernel::uGradSeasurfaceHeight; + using CGDynamicsKernel::vGradSeasurfaceHeight; using CGDynamicsKernel::uAtmos; using CGDynamicsKernel::vAtmos; using CGDynamicsKernel::uOcean; @@ -122,8 +124,9 @@ template class VPCGDynamicsKernel : public CGDynamicsKernellumpedcgmass(i))); + - params.rho_ice * cgH(i) * params.fc * u(i) // Coriolis + - params.rho_ice * cgH(i) * params.gravity * uGradSeasurfaceHeight(i) // sea surface + + dStressX(i) / pmap->lumpedcgmass(i))); v(i) = (1.0 / (params.rho_ice * cgH(i) / deltaT * (1.0 + beta) // implicit parts + cgA(i) * params.F_ocean * absocn) // implicit parts @@ -131,8 +134,9 @@ template class VPCGDynamicsKernel : public CGDynamicsKernellumpedcgmass(i))); } } From aea435361163bb6d5afc940c3ccd1add00382eaa Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Einar=20=C3=96rn=20=C3=93lason?= Date: Fri, 23 Aug 2024 10:11:25 +0200 Subject: [PATCH 02/21] Plumbing to move ssh around Adds ssh to IDynamics and IOceanBoundary classes and all the derived classes. Also modifies TOPAZOcn_test.cpp and topaz_test_data.py to test ssh, as well as changing era5_topaz4_maker.py to include and interpolate ssh. --- core/src/include/ModelComponent.hpp | 1 + core/src/include/gridNames.hpp | 1 + core/src/modules/DynamicsModule/BBMDynamics.cpp | 1 + core/src/modules/DynamicsModule/MEVPDynamics.cpp | 1 + core/src/modules/include/IDynamics.hpp | 2 ++ dynamics/src/CGDynamicsKernel.cpp | 4 ++-- dynamics/src/ParametricMap.cpp | 2 +- dynamics/src/include/CGDynamicsKernel.hpp | 2 +- dynamics/src/include/DynamicsKernel.hpp | 6 ++++-- dynamics/src/include/ParametricMap.hpp | 2 +- physics/src/modules/OceanBoundaryModule/BenchmarkOcean.cpp | 1 + physics/src/modules/OceanBoundaryModule/ConfiguredOcean.cpp | 4 ++++ .../modules/OceanBoundaryModule/ConstantOceanBoundary.cpp | 1 + .../src/modules/OceanBoundaryModule/FluxConfiguredOcean.cpp | 4 ++++ physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp | 3 ++- physics/src/modules/OceanBoundaryModule/UniformOcean.cpp | 4 ++++ physics/src/modules/include/IOceanBoundary.hpp | 4 ++++ physics/test/TOPAZOcn_test.cpp | 5 +++++ physics/test/topaz_test_data.py | 6 +++++- run/era5_topaz4_maker.py | 6 +++--- 20 files changed, 48 insertions(+), 12 deletions(-) diff --git a/core/src/include/ModelComponent.hpp b/core/src/include/ModelComponent.hpp index 73e944c94..c36f1f1e7 100644 --- a/core/src/include/ModelComponent.hpp +++ b/core/src/include/ModelComponent.hpp @@ -50,6 +50,7 @@ namespace Protected { = "EXT_SSS"; // sea surface salinity from coupling or forcing, PSU inline constexpr TextTag EXT_SST = "EXT_SST"; // sea surface temperature from coupling or forcing, ˚C +inline constexpr TextTag SSH = "SSH"; // sea surface height, m inline constexpr TextTag EVAP_MINUS_PRECIP = "E-P"; // E-P atmospheric freshwater flux, kg s⁻¹ m⁻² // Derived fields, calculated once per timestep diff --git a/core/src/include/gridNames.hpp b/core/src/include/gridNames.hpp index 82ddcde61..77d4b67bf 100644 --- a/core/src/include/gridNames.hpp +++ b/core/src/include/gridNames.hpp @@ -28,6 +28,7 @@ static const std::string uWindName = "uwind"; static const std::string vWindName = "vwind"; static const std::string uOceanName = "uocean"; static const std::string vOceanName = "vocean"; +static const std::string sshName = "ssh"; static const std::string coordsName = "coords"; static const std::string latitudeName = "latitude"; diff --git a/core/src/modules/DynamicsModule/BBMDynamics.cpp b/core/src/modules/DynamicsModule/BBMDynamics.cpp index d305b81eb..13dd91644 100644 --- a/core/src/modules/DynamicsModule/BBMDynamics.cpp +++ b/core/src/modules/DynamicsModule/BBMDynamics.cpp @@ -80,6 +80,7 @@ void BBMDynamics::update(const TimestepTime& tst) kernel.setData(vWindName, vwind.data()); kernel.setData(uOceanName, uocean.data()); kernel.setData(vOceanName, vocean.data()); + kernel.setData(sshName, ssh.data()); /* * Ice velocity components are stored in the dynamics, and not changed by the model outside the diff --git a/core/src/modules/DynamicsModule/MEVPDynamics.cpp b/core/src/modules/DynamicsModule/MEVPDynamics.cpp index a7724dd00..f401ee34f 100644 --- a/core/src/modules/DynamicsModule/MEVPDynamics.cpp +++ b/core/src/modules/DynamicsModule/MEVPDynamics.cpp @@ -69,6 +69,7 @@ void MEVPDynamics::update(const TimestepTime& tst) kernel.setData(vWindName, vwind.data()); kernel.setData(uOceanName, uocean.data()); kernel.setData(vOceanName, vocean.data()); + kernel.setData(sshName, ssh.data()); // kernel.setData(uName, uice); // kernel.setData(vName, vice); diff --git a/core/src/modules/include/IDynamics.hpp b/core/src/modules/include/IDynamics.hpp index 29d9423d2..fd393ad58 100644 --- a/core/src/modules/include/IDynamics.hpp +++ b/core/src/modules/include/IDynamics.hpp @@ -31,6 +31,7 @@ class IDynamics : public ModelComponent { , vwind(getStore()) , uocean(getStore()) , vocean(getStore()) + , ssh(getStore()) , m_usesDamage(usesDamageIn) { getStore().registerArray(Shared::DAMAGE, &damage, RW); @@ -88,6 +89,7 @@ class IDynamics : public ModelComponent { ModelArrayRef vwind; ModelArrayRef uocean; ModelArrayRef vocean; + ModelArrayRef ssh; // Does this implementation of the dynamics use damage? bool m_usesDamage; diff --git a/dynamics/src/CGDynamicsKernel.cpp b/dynamics/src/CGDynamicsKernel.cpp index 942058631..5510e7dd8 100644 --- a/dynamics/src/CGDynamicsKernel.cpp +++ b/dynamics/src/CGDynamicsKernel.cpp @@ -259,8 +259,8 @@ template void CGDynamicsKernel::prepareIteration( VectorManipulations::CGAveragePeriodic(*smesh, cgA); // Reinit the gradient of the sea surface height. Not done by - // DataMap as SeasurfaceHeight is always dG(0) - ComputeGradientOfSeaSurfaceHeight(DynamicsKernel::SeasurfaceHeight); + // DataMap as seaSurfaceHeight is always dG(0) + ComputeGradientOfSeaSurfaceHeight(DynamicsKernel::seaSurfaceHeight); // limit A to [0,1] and H to [0, ...) cgA = cgA.cwiseMin(1.0); diff --git a/dynamics/src/ParametricMap.cpp b/dynamics/src/ParametricMap.cpp index ad9300e0e..406af6102 100644 --- a/dynamics/src/ParametricMap.cpp +++ b/dynamics/src/ParametricMap.cpp @@ -248,7 +248,7 @@ template void ParametricMomentumMap::InitializeDivSMatrices() dy_cg2 = PHIy.array().rowwise() * Fx.row(0).array() - PHIx.array().rowwise() * Fy.row(0).array(); - // same but using CG1 basis functions. Required for SeasurfaceHeight + // same but using CG1 basis functions. Required for seaSurfaceHeight const Eigen::Matrix dx_cg1 = PHIx<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.array().rowwise() * Fy.row(1).array() - PHIy<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.array().rowwise() * Fx.row(1).array(); diff --git a/dynamics/src/include/CGDynamicsKernel.hpp b/dynamics/src/include/CGDynamicsKernel.hpp index 97951daf0..648606ba4 100644 --- a/dynamics/src/include/CGDynamicsKernel.hpp +++ b/dynamics/src/include/CGDynamicsKernel.hpp @@ -63,7 +63,7 @@ class CGDynamicsKernel : public DynamicsKernel { CGVector cgA; CGVector cgH; - // CG gradient of the SeasurfaceHeight + // CG gradient of the seaSurfaceHeight CGVector uGradSeasurfaceHeight; CGVector vGradSeasurfaceHeight; diff --git a/dynamics/src/include/DynamicsKernel.hpp b/dynamics/src/include/DynamicsKernel.hpp index 35611011b..2ec8e1e03 100644 --- a/dynamics/src/include/DynamicsKernel.hpp +++ b/dynamics/src/include/DynamicsKernel.hpp @@ -64,7 +64,7 @@ template class DynamicsKernel { hice.resize_by_mesh(*smesh); cice.resize_by_mesh(*smesh); - SeasurfaceHeight.resize_by_mesh(*smesh); + seaSurfaceHeight.resize_by_mesh(*smesh); e11.resize_by_mesh(*smesh); e12.resize_by_mesh(*smesh); @@ -99,6 +99,8 @@ template class DynamicsKernel { DGModelArray::ma2dg(data, hice); } else if (name == ciceName) { DGModelArray::ma2dg(data, cice); + } else if (name == sshName) { + DGModelArray::ma2dg(data, seaSurfaceHeight); } else { // All other fields get shoved in a (labelled) bucket DGModelArray::ma2dg(data, advectedFields[name]); @@ -173,7 +175,7 @@ template class DynamicsKernel { DGVector cice; //! Vector storing the sea surface height (only dG(0) averages) - DGVector<1> SeasurfaceHeight; + DGVector<1> seaSurfaceHeight; //! Vectors storing strain and stress components DGVector e11, e12, e22; diff --git a/dynamics/src/include/ParametricMap.hpp b/dynamics/src/include/ParametricMap.hpp index 379f1e1ec..f98188156 100644 --- a/dynamics/src/include/ParametricMap.hpp +++ b/dynamics/src/include/ParametricMap.hpp @@ -82,7 +82,7 @@ template class ParametricMomentumMap { /*! * These matrices are used to compute the gradient of the sea surface height via * ( gH, Phi) = ( d_[X/Y] SSH, Phi) - * where SSH is CG1-representation of SeasurfaceHeight + * where SSH is CG1-representation of seaSurfaceHeight * * Very similar to divS1 and divS2 but working in CG(1) vectors */ diff --git a/physics/src/modules/OceanBoundaryModule/BenchmarkOcean.cpp b/physics/src/modules/OceanBoundaryModule/BenchmarkOcean.cpp index 65b1fdaff..642693ca9 100644 --- a/physics/src/modules/OceanBoundaryModule/BenchmarkOcean.cpp +++ b/physics/src/modules/OceanBoundaryModule/BenchmarkOcean.cpp @@ -24,6 +24,7 @@ void BenchmarkOcean::setData(const ModelState::DataMap& ms) mld = 10.; cpml = Water::rho * Water::cp * mld[0]; qio = 0; + ssh = 0.; // The time and length scales of the current generation function constexpr double L = 512000.; // Size of the domain in km diff --git a/physics/src/modules/OceanBoundaryModule/ConfiguredOcean.cpp b/physics/src/modules/OceanBoundaryModule/ConfiguredOcean.cpp index 03aed3154..546eceee5 100644 --- a/physics/src/modules/OceanBoundaryModule/ConfiguredOcean.cpp +++ b/physics/src/modules/OceanBoundaryModule/ConfiguredOcean.cpp @@ -98,6 +98,10 @@ void ConfiguredOcean::setData(const ModelState::DataMap& ms) tf = Module::getImplementation()(sssExt[0]); cpml = Water::rho * Water::cp * mld[0]; + /* It's only the SSH gradient which has an effect, so being able to sett a constant SSH is + * useless. */ + ssh = 0.; + slabOcean.setData(ms); Module::getImplementation().setData(ms); diff --git a/physics/src/modules/OceanBoundaryModule/ConstantOceanBoundary.cpp b/physics/src/modules/OceanBoundaryModule/ConstantOceanBoundary.cpp index 2ba88d15d..2421c483f 100644 --- a/physics/src/modules/OceanBoundaryModule/ConstantOceanBoundary.cpp +++ b/physics/src/modules/OceanBoundaryModule/ConstantOceanBoundary.cpp @@ -29,6 +29,7 @@ void ConstantOceanBoundary::setData(const ModelState::DataMap& ms) sst = tf32; // Tf == SST ensures that there is no ice-ocean heat flux cpml = Water::cp * Water::rho * mld; qio = 0.; + ssh = 0.; } void ConstantOceanBoundary::updateBefore(const TimestepTime& tst) diff --git a/physics/src/modules/OceanBoundaryModule/FluxConfiguredOcean.cpp b/physics/src/modules/OceanBoundaryModule/FluxConfiguredOcean.cpp index 7fab47f44..91b02cfdd 100644 --- a/physics/src/modules/OceanBoundaryModule/FluxConfiguredOcean.cpp +++ b/physics/src/modules/OceanBoundaryModule/FluxConfiguredOcean.cpp @@ -79,6 +79,10 @@ void FluxConfiguredOcean::setData(const ModelState::DataMap& ms) v = v0; tf = Module::getImplementation()(sss[0]); cpml = Water::rho * Water::cp * mld[0]; + + /* It's only the SSH gradient which has an effect, so being able to sett a constant SSH is + * useless. */ + ssh = 0.; } } /* namespace Nextsim */ diff --git a/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp b/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp index a38a11d0b..0cc4aa82c 100644 --- a/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp +++ b/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp @@ -55,7 +55,7 @@ void TOPAZOcean::configure() void TOPAZOcean::updateBefore(const TimestepTime& tst) { // TODO: Get more authoritative names for the forcings - std::set forcings = { "sst", "sss", "mld", "u", "v" }; + std::set forcings = { "sst", "sss", "mld", "u", "v", "ssh" }; ModelState state = ParaGridIO::readForcingTimeStatic(forcings, tst.start, filePath); sstExt = state.data.at("sst"); @@ -63,6 +63,7 @@ void TOPAZOcean::updateBefore(const TimestepTime& tst) mld = state.data.at("mld"); u = state.data.at("u"); v = state.data.at("v"); + ssh = state.data.at("ssh"); cpml = Water::rho * Water::cp * mld; overElements(std::bind(&TOPAZOcean::updateTf, this, std::placeholders::_1, diff --git a/physics/src/modules/OceanBoundaryModule/UniformOcean.cpp b/physics/src/modules/OceanBoundaryModule/UniformOcean.cpp index 1da427d91..fffc8fc00 100644 --- a/physics/src/modules/OceanBoundaryModule/UniformOcean.cpp +++ b/physics/src/modules/OceanBoundaryModule/UniformOcean.cpp @@ -24,6 +24,10 @@ void UniformOcean::setData(const ModelState::DataMap& ms) tf = Module::getImplementation()(sss[0]); cpml = Water::rho * Water::cp * mld[0]; qio = qio0; + + /* It's only the SSH gradient which has an effect, so being able to sett a constant SSH is + * useless. */ + ssh = 0.; } UniformOcean& UniformOcean::setSST(double sstIn) diff --git a/physics/src/modules/include/IOceanBoundary.hpp b/physics/src/modules/include/IOceanBoundary.hpp index b85c4cb06..49ac9f1c5 100644 --- a/physics/src/modules/include/IOceanBoundary.hpp +++ b/physics/src/modules/include/IOceanBoundary.hpp @@ -18,6 +18,7 @@ constexpr TextTag SSS = "SSS"; // sea surface salinity PSU constexpr TextTag MLD = "MLD"; // Mixed layer or slab ocean depth m constexpr TextTag OCEAN_U = "U"; // x(east)-ward ocean current m s⁻¹ constexpr TextTag OCEAN_V = "V"; // y(north)-ward ocean current m s⁻¹ +constexpr TextTag SSH = "SSH"; // sea surface height, m } //! An interface class for the oceanic inputs into the ice physics. class IOceanBoundary : public ModelComponent { @@ -37,6 +38,7 @@ class IOceanBoundary : public ModelComponent { getStore().registerArray(Protected::TF, &tf, RO); getStore().registerArray(Protected::OCEAN_U, &u, RO); getStore().registerArray(Protected::OCEAN_V, &v, RO); + getStore().registerArray(Protected::SSH, &ssh, RO); } virtual ~IOceanBoundary() = default; @@ -54,6 +56,7 @@ class IOceanBoundary : public ModelComponent { tf.resize(); u.resize(); v.resize(); + ssh.resize(); if (ms.count("sst")) { sst = ms.at("sst"); @@ -86,6 +89,7 @@ class IOceanBoundary : public ModelComponent { HField cpml; // Heat capacity of the mixed layer, J K⁻¹ m² UField u; // x(east)-ward ocean current, m s⁻¹ VField v; // y(north)-ward ocean current, m s⁻¹ + VField ssh; // sea surface height, m ModelArrayReferenceStore m_couplingArrays; }; diff --git a/physics/test/TOPAZOcn_test.cpp b/physics/test/TOPAZOcn_test.cpp index 749c8a7b3..93f4dd442 100644 --- a/physics/test/TOPAZOcn_test.cpp +++ b/physics/test/TOPAZOcn_test.cpp @@ -54,6 +54,7 @@ TEST_CASE("TOPAZOcean test") ModelArrayRef mld(ModelComponent::getStore()); ModelArrayRef u(ModelComponent::getStore()); ModelArrayRef v(ModelComponent::getStore()); + ModelArrayRef ssh(ModelComponent::getStore()); TimePoint t1("2000-01-01T00:00:00Z"); TimestepTime tst = { t1, Duration(600) }; @@ -75,6 +76,7 @@ TEST_CASE("TOPAZOcean test") REQUIRE(sst(32, 32) == -0.032032); REQUIRE(sst(45, 35) == -(0 + targetFrac)); REQUIRE(mld(45, 35) == (10 + targetFrac)); + REQUIRE(ssh(45, 35) == (20 + targetFrac)); TimePoint t2("2000-02-01T00:00:00Z"); topaz.updateBefore({ t2, Duration(600) }); @@ -83,6 +85,7 @@ TEST_CASE("TOPAZOcean test") REQUIRE(sst(32, 32) == -0.032032 - 1); REQUIRE(sst(45, 35) == -(0 + targetFrac) - 1); REQUIRE(mld(45, 35) == (10 + targetFrac) + 1); + REQUIRE(ssh(45, 35) == (20 + targetFrac) + 1); TimePoint t12("2000-12-01T00:00:00Z"); topaz.updateBefore({ t12, Duration(600) }); @@ -91,6 +94,7 @@ TEST_CASE("TOPAZOcean test") REQUIRE(sst(32, 32) == -0.032032 - 11); REQUIRE(sst(45, 35) == -(0 + targetFrac) - 11); REQUIRE(mld(45, 35) == (10 + targetFrac) + 11); + REQUIRE(ssh(45, 35) == (20 + targetFrac) + 11); // All times after the last time sample should use the last sample's data TimePoint t120("2010-01-01T00:00:00Z"); @@ -100,6 +104,7 @@ TEST_CASE("TOPAZOcean test") REQUIRE(sst(32, 32) == -0.032032 - 11); REQUIRE(sst(45, 35) == -(0 + targetFrac) - 11); REQUIRE(mld(45, 35) == (10 + targetFrac) + 11); + REQUIRE(ssh(45, 35) == (20 + targetFrac) + 11); std::filesystem::remove(filePath); } diff --git a/physics/test/topaz_test_data.py b/physics/test/topaz_test_data.py index 0961db0ed..cfc87f9f9 100644 --- a/physics/test/topaz_test_data.py +++ b/physics/test/topaz_test_data.py @@ -122,6 +122,7 @@ mld = datagrp.createVariable("mld", "f8", timefield_dims) u = datagrp.createVariable("u", "f8", timefield_dims) v = datagrp.createVariable("v", "f8", timefield_dims) +ssh = datagrp.createVariable("ssh", "f8", timefield_dims) # 12 monthly values for t in range(12): @@ -141,5 +142,8 @@ v[t, :, :] = (200 + test_data + 100*t) * mask + mdi * antimask v.missing_value = mdi - + + ssh[t, :, :] = (test_data + 20 + t) * mask + mdi * antimask + ssh.missing_value = mdi + root.close() diff --git a/run/era5_topaz4_maker.py b/run/era5_topaz4_maker.py index bb996039a..32b1b9932 100644 --- a/run/era5_topaz4_maker.py +++ b/run/era5_topaz4_maker.py @@ -58,7 +58,7 @@ def era5_source_file_name(field, unix_time): # Returns the file name that holds the TOPAZ data for a given field at a given time def topaz4_source_file_name(field, unix_time): unix_tm = time.gmtime(unix_time) - if field in ("u", "v"): + if field in ("u", "v", "ssh"): # Ocean currents come from the 30 m files return f"TP4DAILY_{unix_tm.tm_year}{unix_tm.tm_mon:02}_30m.nc" else: @@ -326,10 +326,10 @@ def rotate_velocities(u, v, angle): nc_times[time_index] = unix_times_e[target_t_index] era_root.close() - ocean_fields = ("mld", "sss", "sst") + ocean_fields = ("mld", "sss", "sst", "ssh") skip_ocean_fields = () topaz_fields = ("mlp", "salinity", "temperature", "u", "v") - topaz_translation = {"mld" : "mlp", "sss" : "salinity", "sst" : "temperature"} # wind is special + topaz_translation = {"mld" : "mlp", "sss" : "salinity", "sst" : "temperature", "ssh" : "ssh"} # wind is special ################################################################### From f37653a276bdb7d81d53e1eea094b1a95b34456c Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Einar=20=C3=96rn=20=C3=93lason?= Date: Fri, 23 Aug 2024 12:04:31 +0200 Subject: [PATCH 03/21] Include SSH in BBM --- dynamics/src/include/BrittleCGDynamicsKernel.hpp | 8 ++++++-- 1 file changed, 6 insertions(+), 2 deletions(-) diff --git a/dynamics/src/include/BrittleCGDynamicsKernel.hpp b/dynamics/src/include/BrittleCGDynamicsKernel.hpp index 69ba471cf..bafdf4869 100644 --- a/dynamics/src/include/BrittleCGDynamicsKernel.hpp +++ b/dynamics/src/include/BrittleCGDynamicsKernel.hpp @@ -40,6 +40,8 @@ template class BrittleCGDynamicsKernel : public CGDynamicsKern using CGDynamicsKernel::u; using CGDynamicsKernel::v; + using CGDynamicsKernel::uGradSeasurfaceHeight; + using CGDynamicsKernel::vGradSeasurfaceHeight; using CGDynamicsKernel::uAtmos; using CGDynamicsKernel::vAtmos; using CGDynamicsKernel::uOcean; @@ -205,8 +207,10 @@ template class BrittleCGDynamicsKernel : public CGDynamicsKern + cPrime * (vOcean(i) * cosOceanAngle + uOcean(i) * sinOceanAngle); // Stress gradient - const double gradX = dStressX(i) / pmap->lumpedcgmass(i); - const double gradY = dStressY(i) / pmap->lumpedcgmass(i); + const double gradX = dStressX(i) / pmap->lumpedcgmass(i) + - params.rho_ice * cgH(i) * params.gravity * uGradSeasurfaceHeight(i); + const double gradY = dStressY(i) / pmap->lumpedcgmass(i) + - params.rho_ice * cgH(i) * params.gravity * vGradSeasurfaceHeight(i); u(i) = alpha * uIce + beta * vIce + dteOverMass * (alpha * (gradX + tauX) + beta * (gradY + tauY)); From a51eeabf597041510a01f51dd80465179fae6c3f Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Einar=20=C3=96rn=20=C3=93lason?= Date: Fri, 23 Aug 2024 13:33:21 +0200 Subject: [PATCH 04/21] Add a sensible name for SSH in output And that is "ssh" (instead of "SSH"). --- core/src/modules/include/ProtectedArrayNames.ipp | 1 + 1 file changed, 1 insertion(+) diff --git a/core/src/modules/include/ProtectedArrayNames.ipp b/core/src/modules/include/ProtectedArrayNames.ipp index 83e46fc77..88b751a28 100644 --- a/core/src/modules/include/ProtectedArrayNames.ipp +++ b/core/src/modules/include/ProtectedArrayNames.ipp @@ -40,4 +40,5 @@ { "sss_slab", "SLAB_SSS" }, // Slab ocean surface salinity PSU { "qdw", "SLAB_QDW" }, // Slab ocean temperature nudging heat flux, W m⁻² { "fdw", "SLAB_FDW" }, // Slab ocean salinity nudging water flux, kg s⁻¹ m⁻² +{ "ssh", "SSH" }, // Slab ocean salinity nudging water flux, kg s⁻¹ m⁻² From a4e869d5fd3233c8b03c9e042907175cfa78e015 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Einar=20=C3=96rn=20=C3=93lason?= Date: Fri, 23 Aug 2024 13:46:32 +0200 Subject: [PATCH 05/21] Headers and formatting ... to appease clang-format and the PR template --- core/src/include/ModelComponent.hpp | 4 ++-- core/src/include/gridNames.hpp | 2 +- core/src/modules/DynamicsModule/BBMDynamics.cpp | 2 +- core/src/modules/DynamicsModule/MEVPDynamics.cpp | 2 +- core/src/modules/include/IDynamics.hpp | 2 +- core/src/modules/include/ProtectedArrayNames.ipp | 2 +- dynamics/src/CGDynamicsKernel.cpp | 2 +- dynamics/src/ParametricMap.cpp | 7 +++++++ dynamics/src/include/VPCGDynamicsKernel.hpp | 2 +- physics/src/modules/OceanBoundaryModule/BenchmarkOcean.cpp | 2 +- .../src/modules/OceanBoundaryModule/ConfiguredOcean.cpp | 3 +-- .../modules/OceanBoundaryModule/ConstantOceanBoundary.cpp | 2 +- .../modules/OceanBoundaryModule/FluxConfiguredOcean.cpp | 2 +- physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp | 2 +- physics/src/modules/OceanBoundaryModule/UniformOcean.cpp | 2 +- physics/src/modules/include/IOceanBoundary.hpp | 2 +- physics/test/TOPAZOcn_test.cpp | 2 +- 17 files changed, 24 insertions(+), 18 deletions(-) diff --git a/core/src/include/ModelComponent.hpp b/core/src/include/ModelComponent.hpp index c36f1f1e7..925cf46a3 100644 --- a/core/src/include/ModelComponent.hpp +++ b/core/src/include/ModelComponent.hpp @@ -1,7 +1,7 @@ /*! * @file ModelComponent.hpp * - * @date 1 Jul 2024 + * @date 23 Aug 2024 * @author Tim Spain * @author Einar Ólason */ @@ -50,7 +50,7 @@ namespace Protected { = "EXT_SSS"; // sea surface salinity from coupling or forcing, PSU inline constexpr TextTag EXT_SST = "EXT_SST"; // sea surface temperature from coupling or forcing, ˚C -inline constexpr TextTag SSH = "SSH"; // sea surface height, m + inline constexpr TextTag SSH = "SSH"; // sea surface height, m inline constexpr TextTag EVAP_MINUS_PRECIP = "E-P"; // E-P atmospheric freshwater flux, kg s⁻¹ m⁻² // Derived fields, calculated once per timestep diff --git a/core/src/include/gridNames.hpp b/core/src/include/gridNames.hpp index 77d4b67bf..ec9f04ab6 100644 --- a/core/src/include/gridNames.hpp +++ b/core/src/include/gridNames.hpp @@ -1,7 +1,7 @@ /*! * @file gridNames.hpp * - * @date Oct 24, 2022 + * @date Aug 23, 2024 * @author Tim Spain */ diff --git a/core/src/modules/DynamicsModule/BBMDynamics.cpp b/core/src/modules/DynamicsModule/BBMDynamics.cpp index 13dd91644..9bf09a35a 100644 --- a/core/src/modules/DynamicsModule/BBMDynamics.cpp +++ b/core/src/modules/DynamicsModule/BBMDynamics.cpp @@ -1,7 +1,7 @@ /*! * @file BBMDynamics.cpp * - * @date Jul 1, 2024 + * @date Aug 23, 2024 * @author Tim Spain * @author Einar Ólason */ diff --git a/core/src/modules/DynamicsModule/MEVPDynamics.cpp b/core/src/modules/DynamicsModule/MEVPDynamics.cpp index f401ee34f..efe109faf 100644 --- a/core/src/modules/DynamicsModule/MEVPDynamics.cpp +++ b/core/src/modules/DynamicsModule/MEVPDynamics.cpp @@ -1,7 +1,7 @@ /*! * @file MEVPDynamics.cpp * - * @date 18 Jul 2024 + * @date 23 Aug 2024 * @author Tim Spain * @author Piotr Minakowski * @author Einar Ólason diff --git a/core/src/modules/include/IDynamics.hpp b/core/src/modules/include/IDynamics.hpp index fd393ad58..58b3a5322 100644 --- a/core/src/modules/include/IDynamics.hpp +++ b/core/src/modules/include/IDynamics.hpp @@ -1,7 +1,7 @@ /*! * @file IDynamics.hpp * - * @date 7 Sep 2023 + * @date 23 Aug 2024 * @author Tim Spain */ diff --git a/core/src/modules/include/ProtectedArrayNames.ipp b/core/src/modules/include/ProtectedArrayNames.ipp index 88b751a28..fcb6f2e1a 100644 --- a/core/src/modules/include/ProtectedArrayNames.ipp +++ b/core/src/modules/include/ProtectedArrayNames.ipp @@ -1,7 +1,7 @@ /*! * @file ProtectedArrayNames.ipp * - * @date 1 Jul 2024 + * @date 23 Aug 2024 * @author Tim Spain * @author Einar Ólason */ diff --git a/dynamics/src/CGDynamicsKernel.cpp b/dynamics/src/CGDynamicsKernel.cpp index 5510e7dd8..4ece6c0b9 100644 --- a/dynamics/src/CGDynamicsKernel.cpp +++ b/dynamics/src/CGDynamicsKernel.cpp @@ -1,7 +1,7 @@ /*! * @file CGDynamicsKernel.cpp * - * @date Jan 26, 2024 + * @date Aug 23, 2024 * @author Tim Spain */ diff --git a/dynamics/src/ParametricMap.cpp b/dynamics/src/ParametricMap.cpp index 406af6102..578d5461a 100644 --- a/dynamics/src/ParametricMap.cpp +++ b/dynamics/src/ParametricMap.cpp @@ -1,3 +1,10 @@ +/*! + * @file ParametricMap.cpp + * + * @date Aug 23, 2024 + * @author Thomas Richter + */ + #include "ParametricMap.hpp" #include "ParametricTools.hpp" #include "VectorManipulations.hpp" diff --git a/dynamics/src/include/VPCGDynamicsKernel.hpp b/dynamics/src/include/VPCGDynamicsKernel.hpp index f029fbbb4..c13b19de6 100644 --- a/dynamics/src/include/VPCGDynamicsKernel.hpp +++ b/dynamics/src/include/VPCGDynamicsKernel.hpp @@ -1,7 +1,7 @@ /*! * @file VPCGDynamicsKernel.hpp * - * @date Feb 2, 2024 + * @date Aug 23, 2024 * @author Tim Spain */ diff --git a/physics/src/modules/OceanBoundaryModule/BenchmarkOcean.cpp b/physics/src/modules/OceanBoundaryModule/BenchmarkOcean.cpp index 642693ca9..5567b5ca3 100644 --- a/physics/src/modules/OceanBoundaryModule/BenchmarkOcean.cpp +++ b/physics/src/modules/OceanBoundaryModule/BenchmarkOcean.cpp @@ -1,7 +1,7 @@ /*! * @file BenchmarkOcean.cpp * - * @date 19 Apr 2023 + * @date 23 Aug 2024 * @author Tim Spain */ diff --git a/physics/src/modules/OceanBoundaryModule/ConfiguredOcean.cpp b/physics/src/modules/OceanBoundaryModule/ConfiguredOcean.cpp index 546eceee5..862958f28 100644 --- a/physics/src/modules/OceanBoundaryModule/ConfiguredOcean.cpp +++ b/physics/src/modules/OceanBoundaryModule/ConfiguredOcean.cpp @@ -1,7 +1,7 @@ /*! * @file ConfiguredOcean.cpp * - * @date 7 Sep 2023 + * @date 23 Aug 2024 * @author Tim Spain */ @@ -117,6 +117,5 @@ void ConfiguredOcean::updateAfter(const TimestepTime& tst) slabOcean.update(tst); sst = ModelArrayRef(getStore()).data(); sss = ModelArrayRef(getStore()).data(); - } } /* namespace Nextsim */ diff --git a/physics/src/modules/OceanBoundaryModule/ConstantOceanBoundary.cpp b/physics/src/modules/OceanBoundaryModule/ConstantOceanBoundary.cpp index 2421c483f..267924c44 100644 --- a/physics/src/modules/OceanBoundaryModule/ConstantOceanBoundary.cpp +++ b/physics/src/modules/OceanBoundaryModule/ConstantOceanBoundary.cpp @@ -1,7 +1,7 @@ /*! * @file ConstantOceanBoundary.cpp * - * @date Sep 26, 2022 + * @date Aug 23, 2024 * @author Tim Spain */ diff --git a/physics/src/modules/OceanBoundaryModule/FluxConfiguredOcean.cpp b/physics/src/modules/OceanBoundaryModule/FluxConfiguredOcean.cpp index 91b02cfdd..875bc7604 100644 --- a/physics/src/modules/OceanBoundaryModule/FluxConfiguredOcean.cpp +++ b/physics/src/modules/OceanBoundaryModule/FluxConfiguredOcean.cpp @@ -1,7 +1,7 @@ /*! * @file FluxConfiguredOcean.cpp * - * @date Sep 29, 2022 + * @date Aug 23, 2024 * @author Tim Spain */ diff --git a/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp b/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp index 0cc4aa82c..9634def1c 100644 --- a/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp +++ b/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp @@ -1,7 +1,7 @@ /*! * @file TOPAZOcean.cpp * - * @date 7 Sep 2023 + * @date 23 Aug 2024 * @author Tim Spain */ diff --git a/physics/src/modules/OceanBoundaryModule/UniformOcean.cpp b/physics/src/modules/OceanBoundaryModule/UniformOcean.cpp index fffc8fc00..3ed6067d9 100644 --- a/physics/src/modules/OceanBoundaryModule/UniformOcean.cpp +++ b/physics/src/modules/OceanBoundaryModule/UniformOcean.cpp @@ -1,7 +1,7 @@ /*! * @file UniformOcean.cpp * - * @date 30 Mar 2023 + * @date 23 Aug 2024 * @author Tim Spain */ diff --git a/physics/src/modules/include/IOceanBoundary.hpp b/physics/src/modules/include/IOceanBoundary.hpp index 49ac9f1c5..a81a52318 100644 --- a/physics/src/modules/include/IOceanBoundary.hpp +++ b/physics/src/modules/include/IOceanBoundary.hpp @@ -1,7 +1,7 @@ /*! * @file IOceanBoundary.hpp * - * @date Sep 12, 2022 + * @date Aug 23 2024 * @author Tim Spain */ diff --git a/physics/test/TOPAZOcn_test.cpp b/physics/test/TOPAZOcn_test.cpp index 93f4dd442..529adbf56 100644 --- a/physics/test/TOPAZOcn_test.cpp +++ b/physics/test/TOPAZOcn_test.cpp @@ -1,7 +1,7 @@ /*! * @file ERA5Atm_test.cpp * - * @date 7 Sep 2023 + * @date 23 Aug 2024 * @author Tim Spain */ From 746df5f13f63abf525c8712200a668e6b7898d1a Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Einar=20=C3=96rn=20=C3=93lason?= Date: Fri, 23 Aug 2024 13:51:40 +0200 Subject: [PATCH 06/21] Clang format fixes ... which I missed on the last commit. --- dynamics/src/CGDynamicsKernel.cpp | 246 ++++++++++---------- dynamics/src/ParametricMap.cpp | 61 +++-- dynamics/src/include/CGDynamicsKernel.hpp | 4 +- dynamics/src/include/DynamicsParameters.hpp | 4 +- dynamics/src/include/VPCGDynamicsKernel.hpp | 15 +- 5 files changed, 160 insertions(+), 170 deletions(-) diff --git a/dynamics/src/CGDynamicsKernel.cpp b/dynamics/src/CGDynamicsKernel.cpp index 4ece6c0b9..bacf918e6 100644 --- a/dynamics/src/CGDynamicsKernel.cpp +++ b/dynamics/src/CGDynamicsKernel.cpp @@ -38,7 +38,7 @@ void CGDynamicsKernel::initialise( uGradSeasurfaceHeight.resize_by_mesh(*smesh); vGradSeasurfaceHeight.resize_by_mesh(*smesh); - + dStressX.resize_by_mesh(*smesh); dStressY.resize_by_mesh(*smesh); @@ -107,149 +107,141 @@ template void CGDynamicsKernel::prepareAdvection( dgtransport->prepareAdvection(u, v); } -template void CGDynamicsKernel::ComputeGradientOfSeaSurfaceHeight(const DGVector<1>& SeasurfaceHeight) +template +void CGDynamicsKernel::ComputeGradientOfSeaSurfaceHeight( + const DGVector<1>& seaSurfaceHeight) { - // First transform to CG1 Vector and do all computations in CG1 - CGVector<1> cgSeasurfaceHeight(*smesh); - Interpolations::DG2CG(*smesh, cgSeasurfaceHeight, SeasurfaceHeight); - - CGVector<1> uGrad(*smesh); - CGVector<1> vGrad(*smesh); - uGrad.setZero(); - vGrad.setZero(); - - - // parallelization in stripes - for (size_t p = 0; p < 2; ++p) { + // First transform to CG1 Vector and do all computations in CG1 + CGVector<1> cgSeasurfaceHeight(*smesh); + Interpolations::DG2CG(*smesh, cgSeasurfaceHeight, SeasurfaceHeight); + + CGVector<1> uGrad(*smesh); + CGVector<1> vGrad(*smesh); + uGrad.setZero(); + vGrad.setZero(); + + // parallelization in stripes + for (size_t p = 0; p < 2; ++p) { #pragma omp parallel for schedule(static) - for (size_t cy = 0; cy < smesh->ny; ++cy) { - //!< loop over all cells of the mesh - if (cy % 2 == p) { - size_t eid = smesh->nx * cy; - size_t cg1id = cy*(smesh->nx+1); - for (size_t cx = 0; cx < smesh->nx; ++cx, ++eid, ++cg1id) - { - // get local CG nodes - Eigen::Vector loc_cgSSH = - {cgSeasurfaceHeight(cg1id), - cgSeasurfaceHeight(cg1id+1), - cgSeasurfaceHeight(cg1id+smesh->nx+1), - cgSeasurfaceHeight(cg1id+smesh->nx+1+1)}; - - // compute grad - Eigen::Vector tx = pmap->dX_SSH[eid] * loc_cgSSH; - Eigen::Vector ty = pmap->dY_SSH[eid] * loc_cgSSH; - - // add global vector - uGrad(cg1id) -= tx(0); - uGrad(cg1id+1) -= tx(1); - uGrad(cg1id+smesh->nx+1) -= tx(2); - uGrad(cg1id+smesh->nx+1+1) -= tx(3); - vGrad(cg1id) -= ty(0); - vGrad(cg1id+1) -= ty(1); - vGrad(cg1id+smesh->nx+1) -= ty(2); - vGrad(cg1id+smesh->nx+1+1) -= ty(3); - } - } + for (size_t cy = 0; cy < smesh->ny; ++cy) { + //!< loop over all cells of the mesh + if (cy % 2 == p) { + size_t eid = smesh->nx * cy; + size_t cg1id = cy * (smesh->nx + 1); + for (size_t cx = 0; cx < smesh->nx; ++cx, ++eid, ++cg1id) { + // get local CG nodes + Eigen::Vector loc_cgSSH = { cgSeasurfaceHeight(cg1id), + cgSeasurfaceHeight(cg1id + 1), cgSeasurfaceHeight(cg1id + smesh->nx + 1), + cgSeasurfaceHeight(cg1id + smesh->nx + 1 + 1) }; + + // compute grad + Eigen::Vector tx = pmap->dX_SSH[eid] * loc_cgSSH; + Eigen::Vector ty = pmap->dY_SSH[eid] * loc_cgSSH; + + // add global vector + uGrad(cg1id) -= tx(0); + uGrad(cg1id + 1) -= tx(1); + uGrad(cg1id + smesh->nx + 1) -= tx(2); + uGrad(cg1id + smesh->nx + 1 + 1) -= tx(3); + vGrad(cg1id) -= ty(0); + vGrad(cg1id + 1) -= ty(1); + vGrad(cg1id + smesh->nx + 1) -= ty(2); + vGrad(cg1id + smesh->nx + 1 + 1) -= ty(3); + } + } + } } - } // scale with mass #pragma omp parallel for - for (size_t i=0;ilumpedcg1mass(i); - vGrad(i) /= pmap->lumpedcg1mass(i); - } - - ///// correct boundary (just extend in last elements) - size_t cg1row = smesh->nx+1; - size_t topleft = smesh->ny*cg1row; - for (size_t i=1;inx;++i) // bottom / top - { - uGrad(i) = uGrad(i+cg1row); - vGrad(i) = vGrad(i+cg1row); - uGrad(topleft+i) = uGrad(topleft+i-cg1row); - vGrad(topleft+i) = vGrad(topleft+i-cg1row); + for (size_t i = 0; i < uGrad.rows(); ++i) { + uGrad(i) /= pmap->lumpedcg1mass(i); + vGrad(i) /= pmap->lumpedcg1mass(i); } - for (size_t i=1;iny;++i) // left / right + + ///// correct boundary (just extend in last elements) + size_t cg1row = smesh->nx + 1; + size_t topleft = smesh->ny * cg1row; + for (size_t i = 1; i < smesh->nx; ++i) // bottom / top { - uGrad(i*cg1row) = uGrad(i*cg1row+1); - vGrad(i*cg1row) = vGrad(i*cg1row+1); - - uGrad(i*cg1row+cg1row-1) = uGrad(i*cg1row+cg1row-1-1); - vGrad(i*cg1row+cg1row-1) = vGrad(i*cg1row+cg1row-1-1); + uGrad(i) = uGrad(i + cg1row); + vGrad(i) = vGrad(i + cg1row); + uGrad(topleft + i) = uGrad(topleft + i - cg1row); + vGrad(topleft + i) = vGrad(topleft + i - cg1row); } - // corners - uGrad(0) = uGrad(cg1row+1); - vGrad(0) = vGrad(cg1row+1); - uGrad(smesh->nx) = uGrad(smesh->nx + cg1row - 1); - vGrad(smesh->nx) = vGrad(smesh->nx + cg1row - 1); - uGrad(smesh->ny*cg1row) = uGrad((smesh->ny-1)*cg1row+1); - vGrad(smesh->ny*cg1row) = vGrad((smesh->ny-1)*cg1row+1); - uGrad((smesh->ny+1)*cg1row-1) = uGrad((smesh->ny)*cg1row-1-1); - vGrad((smesh->ny+1)*cg1row-1) = vGrad((smesh->ny)*cg1row-1-1); - - // Interpolate to CG2 (maybe own function in interpolation?) - if (CGDEGREE==1) + for (size_t i = 1; i < smesh->ny; ++i) // left / right { - uGradSeasurfaceHeight = uGrad; - vGradSeasurfaceHeight = vGrad; + uGrad(i * cg1row) = uGrad(i * cg1row + 1); + vGrad(i * cg1row) = vGrad(i * cg1row + 1); + + uGrad(i * cg1row + cg1row - 1) = uGrad(i * cg1row + cg1row - 1 - 1); + vGrad(i * cg1row + cg1row - 1) = vGrad(i * cg1row + cg1row - 1 - 1); } - else - { - // outer nodes - size_t icg1 = 0; + // corners + uGrad(0) = uGrad(cg1row + 1); + vGrad(0) = vGrad(cg1row + 1); + uGrad(smesh->nx) = uGrad(smesh->nx + cg1row - 1); + vGrad(smesh->nx) = vGrad(smesh->nx + cg1row - 1); + uGrad(smesh->ny * cg1row) = uGrad((smesh->ny - 1) * cg1row + 1); + vGrad(smesh->ny * cg1row) = vGrad((smesh->ny - 1) * cg1row + 1); + uGrad((smesh->ny + 1) * cg1row - 1) = uGrad((smesh->ny) * cg1row - 1 - 1); + vGrad((smesh->ny + 1) * cg1row - 1) = vGrad((smesh->ny) * cg1row - 1 - 1); + + // Interpolate to CG2 (maybe own function in interpolation?) + if (CGDEGREE == 1) { + uGradSeasurfaceHeight = uGrad; + vGradSeasurfaceHeight = vGrad; + } else { + // outer nodes + size_t icg1 = 0; #pragma omp parallel for - for (size_t iy=0;iy<=smesh->ny;++iy) - { - size_t icg2 = (2*smesh->nx+1)*2*iy; - for (size_t ix=0;ix<=smesh->nx;++ix,++icg1,icg2+=2) - { - uGradSeasurfaceHeight(icg2) = uGrad(icg1); - vGradSeasurfaceHeight(icg2) = vGrad(icg1); - } - } - // along lines + for (size_t iy = 0; iy <= smesh->ny; ++iy) { + size_t icg2 = (2 * smesh->nx + 1) * 2 * iy; + for (size_t ix = 0; ix <= smesh->nx; ++ix, ++icg1, icg2 += 2) { + uGradSeasurfaceHeight(icg2) = uGrad(icg1); + vGradSeasurfaceHeight(icg2) = vGrad(icg1); + } + } + // along lines #pragma omp parallel for - for (size_t iy=0;iy<=smesh->ny;++iy) // horizontal - { - size_t icg1 = (smesh->nx+1)*iy; - size_t icg2 = (2*smesh->nx+1)*2*iy+1; - for (size_t ix=0;ixnx;++ix,++icg1,icg2+=2) - { - uGradSeasurfaceHeight(icg2) = 0.5 * (uGrad(icg1)+uGrad(icg1+1)); - vGradSeasurfaceHeight(icg2) = 0.5 * (vGrad(icg1)+vGrad(icg1+1)); - } - } + for (size_t iy = 0; iy <= smesh->ny; ++iy) // horizontal + { + size_t icg1 = (smesh->nx + 1) * iy; + size_t icg2 = (2 * smesh->nx + 1) * 2 * iy + 1; + for (size_t ix = 0; ix < smesh->nx; ++ix, ++icg1, icg2 += 2) { + uGradSeasurfaceHeight(icg2) = 0.5 * (uGrad(icg1) + uGrad(icg1 + 1)); + vGradSeasurfaceHeight(icg2) = 0.5 * (vGrad(icg1) + vGrad(icg1 + 1)); + } + } #pragma omp parallel for - for (size_t iy=0;iyny;++iy) // vertical - { - size_t icg1 = (smesh->nx+1)*iy; - size_t icg2 = (2*smesh->nx+1)*(2*iy+1); - for (size_t ix=0;ix<=smesh->nx;++ix,++icg1,icg2+=2) - { - uGradSeasurfaceHeight(icg2) = 0.5 * (uGrad(icg1)+uGrad(icg1+cg1row)); - vGradSeasurfaceHeight(icg2) = 0.5 * (vGrad(icg1)+vGrad(icg1+cg1row)); - } - } - - // midpoints + for (size_t iy = 0; iy < smesh->ny; ++iy) // vertical + { + size_t icg1 = (smesh->nx + 1) * iy; + size_t icg2 = (2 * smesh->nx + 1) * (2 * iy + 1); + for (size_t ix = 0; ix <= smesh->nx; ++ix, ++icg1, icg2 += 2) { + uGradSeasurfaceHeight(icg2) = 0.5 * (uGrad(icg1) + uGrad(icg1 + cg1row)); + vGradSeasurfaceHeight(icg2) = 0.5 * (vGrad(icg1) + vGrad(icg1 + cg1row)); + } + } + + // midpoints #pragma omp parallel for - for (size_t iy=0;iyny;++iy) // vertical - { - size_t icg1 = (smesh->nx+1)*iy; - size_t icg2 = (2*smesh->nx+1)*(2*iy+1)+1; - for (size_t ix=0;ixnx;++ix,++icg1,icg2+=2) - { - uGradSeasurfaceHeight(icg2) = 0.25 * (uGrad(icg1)+uGrad(icg1+1)+uGrad(icg1+cg1row)+uGrad(icg1+cg1row+1)); - vGradSeasurfaceHeight(icg2) = 0.25 * (vGrad(icg1)+vGrad(icg1+1)+vGrad(icg1+cg1row)+vGrad(icg1+cg1row+1)); - } - } + for (size_t iy = 0; iy < smesh->ny; ++iy) // vertical + { + size_t icg1 = (smesh->nx + 1) * iy; + size_t icg2 = (2 * smesh->nx + 1) * (2 * iy + 1) + 1; + for (size_t ix = 0; ix < smesh->nx; ++ix, ++icg1, icg2 += 2) { + uGradSeasurfaceHeight(icg2) = 0.25 + * (uGrad(icg1) + uGrad(icg1 + 1) + uGrad(icg1 + cg1row) + + uGrad(icg1 + cg1row + 1)); + vGradSeasurfaceHeight(icg2) = 0.25 + * (vGrad(icg1) + vGrad(icg1 + 1) + vGrad(icg1 + cg1row) + + vGrad(icg1 + cg1row + 1)); + } + } } } - - + template void CGDynamicsKernel::prepareIteration(const DataMap& data) { // interpolate ice height and concentration to local cg Variables diff --git a/dynamics/src/ParametricMap.cpp b/dynamics/src/ParametricMap.cpp index 578d5461a..ec5371dce 100644 --- a/dynamics/src/ParametricMap.cpp +++ b/dynamics/src/ParametricMap.cpp @@ -93,8 +93,8 @@ template void ParametricTransportMap::InitializeInverseDGMassMatrix //! template void ParametricMomentumMap::InitializeLumpedCGMassMatrix() { - // Compute lumped mass matric for cG(CG) - + // Compute lumped mass matric for cG(CG) + lumpedcgmass.resize_by_mesh(smesh); lumpedcgmass.zero(); @@ -175,21 +175,18 @@ template void ParametricMomentumMap::InitializeLumpedCGMassMatrix() Eigen::Vector Meid; if (smesh.CoordinateSystem == CARTESIAN) { - const Eigen::Matrix J - = ParametricTools::J<2>(smesh, eid).array() - * GAUSSWEIGHTS<2>.array(); + const Eigen::Matrix J + = ParametricTools::J<2>(smesh, eid).array() * GAUSSWEIGHTS<2>.array(); Meid = PHI<1, 2> * J.transpose(); } else if (smesh.CoordinateSystem == SPHERICAL) { - const Eigen::Matrix cos_lat - = (ParametricTools::getGaussPointsInElement<2>(smesh, eid) - .row(1) - .array()) + const Eigen::Matrix cos_lat + = (ParametricTools::getGaussPointsInElement<2>(smesh, eid).row(1).array()) .cos(); - const Eigen::Matrix J - = ParametricTools::J<2>(smesh, eid).array() - * GAUSSWEIGHTS<2>.array() * cos_lat.array(); + const Eigen::Matrix J + = ParametricTools::J<2>(smesh, eid).array() * GAUSSWEIGHTS<2>.array() + * cos_lat.array(); Meid = PHI<1, 2> * J.transpose(); } else @@ -199,11 +196,11 @@ template void ParametricMomentumMap::InitializeLumpedCGMassMatrix() const size_t sy = smesh.nx + 1; const size_t n0 = iy * sy + ix; - lumpedcg1mass(n0, 0) += Meid(0); - lumpedcg1mass(n0 + 1, 0) += Meid(1); - - lumpedcg1mass(n0 + sy, 0) += Meid(2); - lumpedcg1mass(n0 + 1 + sy, 0) += Meid(3); + lumpedcg1mass(n0, 0) += Meid(0); + lumpedcg1mass(n0 + 1, 0) += Meid(1); + + lumpedcg1mass(n0 + sy, 0) += Meid(2); + lumpedcg1mass(n0 + 1 + sy, 0) += Meid(3); } } } @@ -255,16 +252,15 @@ template void ParametricMomentumMap::InitializeDivSMatrices() dy_cg2 = PHIy.array().rowwise() * Fx.row(0).array() - PHIx.array().rowwise() * Fy.row(0).array(); - // same but using CG1 basis functions. Required for seaSurfaceHeight - const Eigen::Matrix - dx_cg1 = PHIx<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.array().rowwise() * Fy.row(1).array() + // same but using CG1 basis functions. Required for seaSurfaceHeight + const Eigen::Matrix dx_cg1 + = PHIx<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.array().rowwise() * Fy.row(1).array() - PHIy<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.array().rowwise() * Fx.row(1).array(); - const Eigen::Matrix - dy_cg1 = PHIy<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.array().rowwise() * Fx.row(0).array() + const Eigen::Matrix dy_cg1 + = PHIy<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.array().rowwise() * Fx.row(0).array() - PHIx<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.array().rowwise() * Fy.row(0).array(); - const Eigen::Matrix J = ParametricTools::J(smesh, eid); @@ -272,12 +268,11 @@ template void ParametricMomentumMap::InitializeDivSMatrices() // divS is used for update of stress (S, nabla Phi) in Momentum divS1[eid] = dx_cg2 * PSI.transpose(); divS2[eid] = dy_cg2 * PSI.transpose(); - - // dX_SSH and dY_SSH are used to compute the gradient of the sea surface height - // they store (d_[x/y] PHI_j, PHI_i) - dX_SSH[eid] = dx_cg1 * PHI<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.transpose(); - dY_SSH[eid] = dy_cg1 * PHI<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.transpose(); + // dX_SSH and dY_SSH are used to compute the gradient of the sea surface height + // they store (d_[x/y] PHI_j, PHI_i) + dX_SSH[eid] = dx_cg1 * PHI<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.transpose(); + dY_SSH[eid] = dy_cg1 * PHI<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.transpose(); // iMgradX/Y (inverse-Mass-gradient X/Y) is used to project strain rate from CG to DG const Eigen::Matrix imass @@ -320,12 +315,12 @@ template void ParametricMomentumMap::InitializeDivSMatrices() * PSI.transpose() / Nextsim::EarthRadius; - // same for CG1 (Sea-Surface Height) - dX_SSH[eid] = dx_cg1 * PHI<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.transpose() / Nextsim::EarthRadius; - dY_SSH[eid] = (dy_cg1.array().rowwise() * cos_lat.array()).matrix() - * PHI<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.transpose() / Nextsim::EarthRadius; + // same for CG1 (Sea-Surface Height) + dX_SSH[eid] = dx_cg1 * PHI<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.transpose() + / Nextsim::EarthRadius; + dY_SSH[eid] = (dy_cg1.array().rowwise() * cos_lat.array()).matrix() + * PHI<1, GAUSSPOINTS1D(CG2DGSTRESS(CG))>.transpose() / Nextsim::EarthRadius; - const Eigen::Matrix imass = SphericalTools::massMatrix(smesh, eid).inverse(); iMgradX[eid] = imass * divS1[eid].transpose(); diff --git a/dynamics/src/include/CGDynamicsKernel.hpp b/dynamics/src/include/CGDynamicsKernel.hpp index 648606ba4..983f36972 100644 --- a/dynamics/src/include/CGDynamicsKernel.hpp +++ b/dynamics/src/include/CGDynamicsKernel.hpp @@ -42,10 +42,10 @@ class CGDynamicsKernel : public DynamicsKernel { } virtual ~CGDynamicsKernel() = default; void initialise(const ModelArray& coords, bool isSpherical, const ModelArray& mask) override; - + void setData(const std::string& name, const ModelArray& data) override; ModelArray getDG0Data(const std::string& name) const override; - void ComputeGradientOfSeaSurfaceHeight(const DGVector<1>& SeasurfaceHeight); + void ComputeGradientOfSeaSurfaceHeight(const DGVector<1>& seaSurfaceHeight); void prepareIteration(const DataMap& data) override; void projectVelocityToStrain() override; void stressDivergence() override; diff --git a/dynamics/src/include/DynamicsParameters.hpp b/dynamics/src/include/DynamicsParameters.hpp index fbd3484d5..ec7d7bf50 100644 --- a/dynamics/src/include/DynamicsParameters.hpp +++ b/dynamics/src/include/DynamicsParameters.hpp @@ -27,7 +27,7 @@ class DynamicsParameters { double ocean_turning_angle; //!< Ocean turning angle - double gravity; //!< gravity parameter + double gravity; //!< gravity parameter DynamicsParameters() { @@ -46,7 +46,7 @@ class DynamicsParameters { ocean_turning_angle = 25.; //!< Ocean turning angle ocean_turning_angle = 0.0; // FIXME decide between ocean turning angles - gravity = 9.81; //!< gravity parameter + gravity = 9.81; //!< gravity parameter } }; } diff --git a/dynamics/src/include/VPCGDynamicsKernel.hpp b/dynamics/src/include/VPCGDynamicsKernel.hpp index c13b19de6..9bf7ff7d2 100644 --- a/dynamics/src/include/VPCGDynamicsKernel.hpp +++ b/dynamics/src/include/VPCGDynamicsKernel.hpp @@ -124,9 +124,10 @@ template class VPCGDynamicsKernel : public CGDynamicsKernellumpedcgmass(i))); + - params.rho_ice * cgH(i) * params.fc * u(i) // Coriolis + - params.rho_ice * cgH(i) * params.gravity + * uGradSeasurfaceHeight(i) // sea surface + + dStressX(i) / pmap->lumpedcgmass(i))); v(i) = (1.0 / (params.rho_ice * cgH(i) / deltaT * (1.0 + beta) // implicit parts + cgA(i) * params.F_ocean * absocn) // implicit parts @@ -134,9 +135,11 @@ template class VPCGDynamicsKernel : public CGDynamicsKernellumpedcgmass(i))); } } From e5387c0172845c9c6a008d5354694d4bec5010cd Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Einar=20=C3=96rn=20=C3=93lason?= Date: Fri, 23 Aug 2024 13:53:02 +0200 Subject: [PATCH 07/21] More clang-format fixes --- dynamics/src/include/DynamicsKernel.hpp | 1 - 1 file changed, 1 deletion(-) diff --git a/dynamics/src/include/DynamicsKernel.hpp b/dynamics/src/include/DynamicsKernel.hpp index 2ec8e1e03..745fdc57e 100644 --- a/dynamics/src/include/DynamicsKernel.hpp +++ b/dynamics/src/include/DynamicsKernel.hpp @@ -74,7 +74,6 @@ template class DynamicsKernel { s22.resize_by_mesh(*smesh); } - /*! * @brief Sets the data from a provided ModelArray. * From 3865de0f0a6c0379d0b355161cf9bbfc4942577e Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Einar=20=C3=96rn=20=C3=93lason?= Date: Fri, 23 Aug 2024 13:54:23 +0200 Subject: [PATCH 08/21] You guessed it! --- dynamics/src/include/ParametricMap.hpp | 9 ++++----- 1 file changed, 4 insertions(+), 5 deletions(-) diff --git a/dynamics/src/include/ParametricMap.hpp b/dynamics/src/include/ParametricMap.hpp index f98188156..8b77b3556 100644 --- a/dynamics/src/include/ParametricMap.hpp +++ b/dynamics/src/include/ParametricMap.hpp @@ -81,15 +81,14 @@ template class ParametricMomentumMap { /*! * These matrices are used to compute the gradient of the sea surface height via - * ( gH, Phi) = ( d_[X/Y] SSH, Phi) + * ( gH, Phi) = ( d_[X/Y] SSH, Phi) * where SSH is CG1-representation of seaSurfaceHeight - * + * * Very similar to divS1 and divS2 but working in CG(1) vectors */ - std::vector, - Eigen::aligned_allocator>> + std::vector, + Eigen::aligned_allocator>> dX_SSH, dY_SSH; - /*! * These matrices realize the integration of (E, \grad phi) scaled with the From fe6badbd86dab9983d5beadf9e709691a7679040 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Einar=20=C3=96rn=20=C3=93lason?= Date: Fri, 23 Aug 2024 14:01:53 +0200 Subject: [PATCH 09/21] Fix renaming/refactoring mistake --- dynamics/src/CGDynamicsKernel.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/dynamics/src/CGDynamicsKernel.cpp b/dynamics/src/CGDynamicsKernel.cpp index bacf918e6..a6220c255 100644 --- a/dynamics/src/CGDynamicsKernel.cpp +++ b/dynamics/src/CGDynamicsKernel.cpp @@ -113,7 +113,7 @@ void CGDynamicsKernel::ComputeGradientOfSeaSurfaceHeight( { // First transform to CG1 Vector and do all computations in CG1 CGVector<1> cgSeasurfaceHeight(*smesh); - Interpolations::DG2CG(*smesh, cgSeasurfaceHeight, SeasurfaceHeight); + Interpolations::DG2CG(*smesh, cgSeasurfaceHeight, seaSurfaceHeight); CGVector<1> uGrad(*smesh); CGVector<1> vGrad(*smesh); From 727689999749c773f361c835612b88d1b83d1bdb Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Einar=20=C3=96rn=20=C3=93lason?= Date: Mon, 7 Oct 2024 08:57:50 +0200 Subject: [PATCH 10/21] Fix a mistake where ssh was a VField not HField As pointed out by Tim when reviewing the PR. --- physics/src/modules/include/IOceanBoundary.hpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/physics/src/modules/include/IOceanBoundary.hpp b/physics/src/modules/include/IOceanBoundary.hpp index a81a52318..0595454d6 100644 --- a/physics/src/modules/include/IOceanBoundary.hpp +++ b/physics/src/modules/include/IOceanBoundary.hpp @@ -1,7 +1,7 @@ /*! * @file IOceanBoundary.hpp * - * @date Aug 23 2024 + * @date 07 Oct 2024 * @author Tim Spain */ @@ -89,7 +89,7 @@ class IOceanBoundary : public ModelComponent { HField cpml; // Heat capacity of the mixed layer, J K⁻¹ m² UField u; // x(east)-ward ocean current, m s⁻¹ VField v; // y(north)-ward ocean current, m s⁻¹ - VField ssh; // sea surface height, m + HField ssh; // sea surface height, m ModelArrayReferenceStore m_couplingArrays; }; From 7bc999aaf1201893df8d7dd6065ba14a9aa3477f Mon Sep 17 00:00:00 2001 From: Tim Spain Date: Thu, 17 Oct 2024 15:42:01 +0200 Subject: [PATCH 11/21] Allow forcing fields to be absent from files. --- core/src/ParaGridIO.cpp | 3 +++ 1 file changed, 3 insertions(+) diff --git a/core/src/ParaGridIO.cpp b/core/src/ParaGridIO.cpp index fa85822c8..34004798d 100644 --- a/core/src/ParaGridIO.cpp +++ b/core/src/ParaGridIO.cpp @@ -197,7 +197,10 @@ ModelState ParaGridIO::readForcingTimeStatic( extentArray.push_back(ModelArray::definedDimensions.at(*riter).length); } + auto availableForcings = dataGroup.getVars(); for (const std::string& varName : forcings) { + // Don't try to read non-existent data + if (!availableForcings.count(varName)) continue; netCDF::NcVar var = dataGroup.getVar(varName); state.data[varName] = ModelArray(ModelArray::Type::H); ModelArray& data = state.data.at(varName); From 8d554d7f8e19bea569b61a01ac3d0b9d2adc8cb1 Mon Sep 17 00:00:00 2001 From: Tim Spain Date: Thu, 17 Oct 2024 15:42:35 +0200 Subject: [PATCH 12/21] Handle absent sea surface height forcing data. --- physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp | 6 +++++- 1 file changed, 5 insertions(+), 1 deletion(-) diff --git a/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp b/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp index 9634def1c..16d50bdfb 100644 --- a/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp +++ b/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp @@ -63,7 +63,11 @@ void TOPAZOcean::updateBefore(const TimestepTime& tst) mld = state.data.at("mld"); u = state.data.at("u"); v = state.data.at("v"); - ssh = state.data.at("ssh"); + if (state.data.count("ssh")) { + ssh = state.data.at("ssh"); + } else { + ssh = 0.; + } cpml = Water::rho * Water::cp * mld; overElements(std::bind(&TOPAZOcean::updateTf, this, std::placeholders::_1, From d280df7a5b67fe7fa307dd6c54002c6d284984b1 Mon Sep 17 00:00:00 2001 From: Tim Spain Date: Thu, 17 Oct 2024 15:45:45 +0200 Subject: [PATCH 13/21] Use gridnames in TOPAZOcean. --- core/src/include/gridNames.hpp | 2 ++ .../OceanBoundaryModule/TOPAZOcean.cpp | 19 ++++++++++--------- 2 files changed, 12 insertions(+), 9 deletions(-) diff --git a/core/src/include/gridNames.hpp b/core/src/include/gridNames.hpp index ec9f04ab6..927b4dd59 100644 --- a/core/src/include/gridNames.hpp +++ b/core/src/include/gridNames.hpp @@ -29,6 +29,8 @@ static const std::string vWindName = "vwind"; static const std::string uOceanName = "uocean"; static const std::string vOceanName = "vocean"; static const std::string sshName = "ssh"; +// Mixed layer depth +static const std::string mldName = "mld"; static const std::string coordsName = "coords"; static const std::string latitudeName = "latitude"; diff --git a/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp b/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp index 16d50bdfb..dbf0ae0cd 100644 --- a/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp +++ b/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp @@ -1,7 +1,7 @@ /*! * @file TOPAZOcean.cpp * - * @date 23 Aug 2024 + * @date 17 Oct 2024 * @author Tim Spain */ @@ -12,6 +12,7 @@ #include "include/Module.hpp" #include "include/ParaGridIO.hpp" #include "include/constants.hpp" +#include "include/gridnames.hpp" namespace Nextsim { @@ -55,16 +56,16 @@ void TOPAZOcean::configure() void TOPAZOcean::updateBefore(const TimestepTime& tst) { // TODO: Get more authoritative names for the forcings - std::set forcings = { "sst", "sss", "mld", "u", "v", "ssh" }; + std::set forcings = { sstName, sssName, "mld", uName, vName, sshName }; ModelState state = ParaGridIO::readForcingTimeStatic(forcings, tst.start, filePath); - sstExt = state.data.at("sst"); - sssExt = state.data.at("sss"); - mld = state.data.at("mld"); - u = state.data.at("u"); - v = state.data.at("v"); - if (state.data.count("ssh")) { - ssh = state.data.at("ssh"); + sstExt = state.data.at(sstName); + sssExt = state.data.at(sssName); + mld = state.data.at(mldName); + u = state.data.at(uName); + v = state.data.at(vName); + if (state.data.count(sshName)) { + ssh = state.data.at(sshName); } else { ssh = 0.; } From 04fc93ceaefe8d37be4665b26f336f95a1e21ca0 Mon Sep 17 00:00:00 2001 From: Tim Spain Date: Thu, 17 Oct 2024 15:53:03 +0200 Subject: [PATCH 14/21] formatting --- core/src/ParaGridIO.cpp | 4 +++- physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp | 2 +- 2 files changed, 4 insertions(+), 2 deletions(-) diff --git a/core/src/ParaGridIO.cpp b/core/src/ParaGridIO.cpp index 34004798d..91d4a8929 100644 --- a/core/src/ParaGridIO.cpp +++ b/core/src/ParaGridIO.cpp @@ -200,7 +200,9 @@ ModelState ParaGridIO::readForcingTimeStatic( auto availableForcings = dataGroup.getVars(); for (const std::string& varName : forcings) { // Don't try to read non-existent data - if (!availableForcings.count(varName)) continue; + if (!availableForcings.count(varName)) { + continue; + } netCDF::NcVar var = dataGroup.getVar(varName); state.data[varName] = ModelArray(ModelArray::Type::H); ModelArray& data = state.data.at(varName); diff --git a/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp b/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp index dbf0ae0cd..dd41821f6 100644 --- a/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp +++ b/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp @@ -12,7 +12,7 @@ #include "include/Module.hpp" #include "include/ParaGridIO.hpp" #include "include/constants.hpp" -#include "include/gridnames.hpp" +#include "include/gridNames.hpp" namespace Nextsim { From 33028b21f56ad5d3250487ba2a3154a01c981608 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Einar=20=C3=96rn=20=C3=93lason?= Date: Thu, 5 Dec 2024 12:48:34 +0100 Subject: [PATCH 15/21] Minor clean up of degrees and radians conversion Move deg2rad to constants.hpp and use this for the radians function. Define also rad2deg and use in the degrees function ... but I still need to rewrite rad2deg as a proper hex float. --- core/src/include/constants.hpp | 13 ++++++++++--- core/src/modules/DynamicsModule/BBMDynamics.cpp | 4 ++-- core/src/modules/DynamicsModule/MEVPDynamics.cpp | 7 ++----- dynamics/src/include/BrittleCGDynamicsKernel.hpp | 7 ++----- dynamics/src/include/FreeDriftDynamicsKernel.hpp | 4 ++-- 5 files changed, 18 insertions(+), 17 deletions(-) diff --git a/core/src/include/constants.hpp b/core/src/include/constants.hpp index 1609ca191..38e0400a5 100644 --- a/core/src/include/constants.hpp +++ b/core/src/include/constants.hpp @@ -1,6 +1,6 @@ /*! * @file constants.hpp - * @date Sep 14, 2021 + * @date 05 Dec 2024 * @author Tim Spain */ @@ -31,6 +31,13 @@ const double Tt = 273.16; //! Ratio of circumference to radius const double tau = 6.28318530717958647652; + +// degrees to radians as a hex float +const double deg2rad = 0x1.1df46a2529d39p-6; + +// radians to degrees +// TODO: Rewrite as a hex float +const double rad2deg = 1. / deg2rad; } //! Properties of water ice around 0˚C and 101.3 kPa @@ -131,10 +138,10 @@ inline double kelvin(double celsius) { return celsius + Water::Tf; } inline double celsius(double kelvin) { return kelvin - Water::Tf; } //! Convert an angle from radians to degrees -inline double degrees(double radians) { return radians * 360 / PhysicalConstants::tau; } +inline double degrees(double radians) { return radians * PhysicalConstants::rad2deg; } //! Convert an angle from degrees to radians -inline double radians(double degrees) { return degrees * PhysicalConstants::tau / 360; } +inline double radians(double degrees) { return degrees * PhysicalConstants::deg2rad; } //! Convert a pressure from Pa to mbar inline double mbar(double pascals) { return pascals / 100; } diff --git a/core/src/modules/DynamicsModule/BBMDynamics.cpp b/core/src/modules/DynamicsModule/BBMDynamics.cpp index d70df8a04..e3530ed4b 100644 --- a/core/src/modules/DynamicsModule/BBMDynamics.cpp +++ b/core/src/modules/DynamicsModule/BBMDynamics.cpp @@ -7,7 +7,7 @@ */ #include "include/BBMDynamics.hpp" - +#include "include/constants.hpp" #include "include/gridNames.hpp" namespace Nextsim { @@ -79,7 +79,7 @@ void BBMDynamics::setData(const ModelState::DataMap& ms) ModelArray coords = ms.at(coordsName); if (isSpherical) { - coords *= deg2rad; + coords *= PhysicalConstants::deg2rad; } // TODO: Some encoding of the periodic edge boundary conditions kernel.initialise(coords, isSpherical, ms.at(maskName)); diff --git a/core/src/modules/DynamicsModule/MEVPDynamics.cpp b/core/src/modules/DynamicsModule/MEVPDynamics.cpp index 8ae67776a..8c19e1816 100644 --- a/core/src/modules/DynamicsModule/MEVPDynamics.cpp +++ b/core/src/modules/DynamicsModule/MEVPDynamics.cpp @@ -8,7 +8,7 @@ */ #include "include/MEVPDynamics.hpp" - +#include "include/constants.hpp" #include "include/gridNames.hpp" #include @@ -16,9 +16,6 @@ namespace Nextsim { -// Degrees to radians as a hex float -static const double deg2rad = 0x1.1df46a2529d39p-6; - // TODO: We should use getName() here, but it isn't static. static const std::string prefix = "MEVPDynamics"; // MEVPDynamics::getName(); static const std::map keyMap = { @@ -70,7 +67,7 @@ void MEVPDynamics::setData(const ModelState::DataMap& ms) ModelArray coords = ms.at(coordsName); if (isSpherical) { - coords *= deg2rad; + coords *= PhysicalConstants::deg2rad; } // TODO: Some encoding of the periodic edge boundary conditions kernel.initialise(coords, isSpherical, ms.at(maskName)); diff --git a/dynamics/src/include/BrittleCGDynamicsKernel.hpp b/dynamics/src/include/BrittleCGDynamicsKernel.hpp index 2b20c62f7..a2599faf6 100644 --- a/dynamics/src/include/BrittleCGDynamicsKernel.hpp +++ b/dynamics/src/include/BrittleCGDynamicsKernel.hpp @@ -19,9 +19,6 @@ namespace Nextsim { -// Degrees to radians as a hex float -static const double deg2rad = 0x1.1df46a2529d39p-6; - // The brittle momentum solver for CG velocity fields template class BrittleCGDynamicsKernel : public CGDynamicsKernel { protected: @@ -83,8 +80,8 @@ template class BrittleCGDynamicsKernel : public CGDynamicsKern avgU.resize_by_mesh(*smesh); avgV.resize_by_mesh(*smesh); - cosOceanAngle = std::cos(deg2rad * params.oceanTurningAngle); - sinOceanAngle = std::sin(deg2rad * params.oceanTurningAngle); + cosOceanAngle = std::cos(radians(params.oceanTurningAngle)); + sinOceanAngle = std::sin(radians(params.oceanTurningAngle)); } // The brittle rheologies use avgU and avgV to do the advection, not u and v, like mEVP diff --git a/dynamics/src/include/FreeDriftDynamicsKernel.hpp b/dynamics/src/include/FreeDriftDynamicsKernel.hpp index f3ad74387..1128a2ba6 100644 --- a/dynamics/src/include/FreeDriftDynamicsKernel.hpp +++ b/dynamics/src/include/FreeDriftDynamicsKernel.hpp @@ -53,8 +53,8 @@ template class FreeDriftDynamicsKernel : public CGDynamicsKern protected: const DynamicsParameters& params; - const double cosOceanAngle = std::cos(deg2rad * params.oceanTurningAngle); - const double sinOceanAngle = std::sin(deg2rad * params.oceanTurningAngle); + const double cosOceanAngle = std::cos(radians(params.oceanTurningAngle)); + const double sinOceanAngle = std::sin(radians(params.oceanTurningAngle)); const double FOcean = params.COcean * params.rhoOcean; const double FAtm = params.CAtm * params.rhoAtm; const double NansenNumber = std::sqrt(FAtm / FOcean); From 55c35624f726135311bd9455bc0872444353eba5 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Einar=20=C3=96rn=20=C3=93lason?= Date: Fri, 6 Dec 2024 09:48:42 +0100 Subject: [PATCH 16/21] Bugfix for era5_topaz4_test_data.py Strangely, time step two of the TOPAZ file was always NaNs. I don't understand why the model still worked. --- test/era5_topaz4_test_data.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/test/era5_topaz4_test_data.py b/test/era5_topaz4_test_data.py index b8917804f..22b3d65f3 100644 --- a/test/era5_topaz4_test_data.py +++ b/test/era5_topaz4_test_data.py @@ -74943,5 +74943,5 @@ def get_topaz_data(name): for field_name in ocean_fields: data = datagrp.createVariable(field_name, "f8", timefield_dims) data[0, :,:] = get_topaz_data(field_name) - data[1, :, :] = get_era_data(field_name) + data[1, :,:] = get_topaz_data(field_name) topaz_root.close() From 9a7b73f9b18a3e51649efd08684e1630bc98e144 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Einar=20=C3=96rn=20=C3=93lason?= Date: Fri, 6 Dec 2024 09:49:25 +0100 Subject: [PATCH 17/21] Add the ssh field to the integration test Derived from the TOPAZ4 data, like the rest. --- test/era5_topaz4_test_data.py | 6295 +++++++++++++++++++++++++++++++++ 1 file changed, 6295 insertions(+) diff --git a/test/era5_topaz4_test_data.py b/test/era5_topaz4_test_data.py index 22b3d65f3..ae3295e6a 100644 --- a/test/era5_topaz4_test_data.py +++ b/test/era5_topaz4_test_data.py @@ -65934,6 +65934,6301 @@ def get_topaz_data(name): NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN, NaN ]).reshape(ny, nx) + elif name == "ssh": + return np.asarray([ + -0.0868183370924603, -0.089341159284328, -0.0918638337506942, + -0.0943865001245788, -0.0977150590327191, -0.0892366898251004, + -0.0890712894114064, -0.090171369996953, -0.0870636540293484, + -0.0783521928641463, -0.0759410800650877, -0.0736210589383276, + -0.0689901127456709, -0.0635312217523215, -0.0580536129041905, + -0.0526300815857452, -0.0508412245323887, -0.0522562189533646, + -0.0536801514624587, -0.0557573175381244, -0.059090382560744, + -0.0624619895300646, -0.0658334915536261, -0.0692048900127067, + -0.0726420256799616, -0.0762688567665493, -0.0777145936734787, + -0.0797372228471002, -0.0816713133268973, -0.0835124308132434, + -0.0851644990996683, -0.0867638395491782, -0.0882717891443069, + -0.0892349665536078, -0.0881378731099148, -0.093868588609729, + -0.103219738683597, -0.112426227540183, -0.126801788681579, + -0.150439743397797, -0.17474903336094, -0.181109917906971, + -0.170395862356832, -0.175570412731864, -0.184405276581518, + -0.190956811080763, -0.196805731103579, -0.199893172912187, + -0.200342098115023, -0.196166077733582, -0.19619991974209, + -0.195383824115324, -0.205190915704842, -0.224202760307731, + -0.230051112810474, -0.230006589184024, -0.235076118217792, + -0.241772953209502, -0.244019339817805, -0.244032186289731, + -0.243846921852219, -0.242632013108465, -0.240907365214924, + -0.238553086947927, -0.238537578868193, -0.239625522793643, + -0.24097988398586, -0.24233790432564, -0.243695963338588, + -0.245053974559006, -0.246138092559083, -0.246285996651627, + -0.245185409098329, -0.241732858167274, -0.241739268071758, + -0.239916201853032, -0.238458775939067, -0.237803451089347, + -0.23745015224596, -0.237215287590803, -0.234525492502841, + -0.230525009878291, -0.225044083694261, -0.221461077039504, + -0.217390424516883, -0.215876713761474, -0.214943314013396, + -0.214009903930757, -0.213076520531585, -0.213664718828681, + -0.21452477692894, -0.214990919057298, -0.215683542270684, + -0.216681492895629, -0.217679438874853, -0.218677391974251, + -0.219675335659615, -0.220673283435759, -0.221671227511231, + -0.22202881320563, -0.221176502127719, -0.221424121163787, + -0.222915038556093, -0.224632570208798, -0.226350143366902, + -0.228067704828177, -0.22978519098518, -0.231502650960392, + -0.233220108835977, -0.23493763415849, -0.236655130150788, + -0.238372574721937, -0.239538694241097, -0.24124032268673, + -0.243715396356927, -0.244853696583232, -0.240102946936866, + -0.229889792505533, -0.224134005505313, -0.220893596822407, + -0.221564236323102, -0.229262180538929, -0.247662861062564, + -0.273122729530476, -0.301947842328857, -0.332310582203402, + -0.361180658714681, -0.394667917662002, -0.443866308235587, + -0.489840913489839, -0.513726859420282, -0.507241945699202, + -0.512897410152168, -0.539233565549273, -0.557272019306156, + -0.566647449021133, -0.569606166791729, -0.558437588822677, + -0.541979455573373, -0.525135349956854, -0.51836468407699, + -0.509062294133873, -0.497499448995094, -0.476636375544623, + -0.46568808876615, -0.465741890481201, -0.468410553937006, + -0.470014055615595, -0.469757629343667, -0.472598741734072, + -0.476033651892072, -0.472311989637427, -0.460215883666163, + -0.438518775071006, + -0.0870355367713493, -0.0895228995277252, -0.092045626819707, + -0.0945682129529378, -0.102633747852942, -0.0890499796244511, + -0.0902743901026209, -0.0917877313865309, -0.0734356440782685, + -0.0727796454157167, -0.0695225387145394, -0.0672708800609484, + -0.0650193238938415, -0.0618776445844806, -0.0564608732974948, + -0.0506525976297247, -0.047557848546747, -0.0489532731594746, + -0.0508217285381447, -0.054193488722533, -0.0575651577922957, + -0.0609564242872276, -0.0646558776238751, -0.0688244412558303, + -0.0731240320985498, -0.0759751912928202, -0.0772901377218655, + -0.0780449578862671, -0.0799313593583376, -0.0817509570249021, + -0.0832943049559624, -0.0849604833594341, -0.0866155840827853, + -0.0882295226762572, -0.0916258772628074, -0.101669822617928, + -0.111312054929091, -0.120398356432769, -0.134477719177154, + -0.154593595695102, -0.175044051405492, -0.187566608381268, + -0.180169667814054, -0.175934138217217, -0.181565187709908, + -0.187223927877653, -0.192815600002831, -0.195796808109072, + -0.200330583020003, -0.194510407752732, -0.195802962242659, + -0.197569742219537, -0.20835644196516, -0.227595091920024, + -0.22647307032496, -0.226116408380347, -0.235476392530161, + -0.241367511544322, -0.241876422122457, -0.242805041773711, + -0.242691953216458, -0.241477116511126, -0.240262257877841, + -0.238700686747899, -0.236675325931901, -0.237376783775802, + -0.238442151580718, -0.239795800488148, -0.241153862110879, + -0.242508429400755, -0.243011699251158, -0.243123324605962, + -0.241758121951788, -0.239432533069934, -0.238155822842284, + -0.23721493263548, -0.23691155682793, -0.236676678613407, + -0.236441773038503, -0.236206912321703, -0.234217980628851, + -0.230707153477139, -0.228933303646152, -0.230416851447482, + -0.224259265656842, -0.218537781688478, -0.217464831882346, + -0.216014050677913, -0.214996087182503, -0.214062684018353, + -0.213435524023425, -0.215208009790793, -0.215722320163798, + -0.216646769188466, -0.217644715900395, -0.218642660637449, + -0.219636082044881, -0.220283503870733, -0.219438156930895, + -0.220877835005204, -0.222595365627463, -0.22431291490419, + -0.226030487717191, -0.22774799451032, -0.229465544183549, + -0.231183074471053, -0.232900583735625, -0.234618135831976, + -0.23633562593141, -0.238053076676146, -0.239770508740649, + -0.241449586562353, -0.242788009061992, -0.245041049905552, + -0.245317931912366, -0.246423243584082, -0.24398975525627, + -0.234263668473704, -0.229342599689882, -0.228889781236947, + -0.231458834773111, -0.23986200864035, -0.258161060406119, + -0.285555576269625, -0.316346186339374, -0.348486869585261, + -0.38175266560298, -0.425829210424714, -0.463944999166494, + -0.494572295939206, -0.51387015590204, -0.51100765198487, + -0.502458219414193, -0.516928218201945, -0.535360782951109, + -0.545997216609464, -0.546594769348597, -0.526510414877722, + -0.511230997041673, -0.499562546726232, -0.498705412755008, + -0.486562160110059, -0.479668005063598, -0.467000311661144, + -0.456002376839079, -0.449919556106911, -0.448140816238663, + -0.448212311519091, -0.444184643612429, -0.438849492979665, + -0.436209977144621, -0.435889935838042, -0.430906163278472, + -0.408669807360972, + -0.0878965943221418, -0.0897045741120234, -0.0922272677021947, + -0.0947498983045236, -0.102233283224057, -0.0897165391730862, + -0.0897666311609447, -0.0827360817966673, -0.0618622982637814, + -0.0665629173315008, -0.0631041499080924, -0.0608526620210495, + -0.0586011245065034, -0.0563496631646693, -0.0539022556218943, + -0.0493393866672501, -0.0442757022393373, -0.0460236101941138, + -0.0493013858152691, -0.0530928246134593, -0.0577522457761196, + -0.0622883211650989, -0.06599781736051, -0.0692303417265886, + -0.072420335167002, -0.0755927272862203, -0.0778907755612832, + -0.0781301015088324, -0.078371078833969, -0.0798807509881985, + -0.0814241178259573, -0.0831572167460695, -0.0852146111716817, + -0.0875775752589702, -0.0985960568584474, -0.111700827423436, + -0.12171855908681, -0.131276492931309, -0.147851993685159, + -0.165242291548071, -0.174163288405959, -0.179642834038003, + -0.176996454489254, -0.175847739265527, -0.177703405427159, + -0.183300651143544, -0.188616014745142, -0.193306338217271, + -0.195553398493226, -0.201356215193527, -0.205566596686111, + -0.213024577437798, -0.221099710329419, -0.227506719038028, + -0.226158705535795, -0.224653928224795, -0.230709209396775, + -0.238105386389523, -0.240414269468614, -0.241577911534285, + -0.241537036279437, -0.240322201834495, -0.239107370461603, + -0.237892548292817, -0.236441916567147, -0.235297690046582, + -0.236216013935587, -0.237253736225072, -0.238611769216118, + -0.239723048052794, -0.239850991172312, -0.23996055774755, + -0.238330968050458, -0.236791673740579, -0.236372987975, + -0.236138095003937, -0.235903199344481, -0.235668305181859, + -0.235433456163978, -0.235198572135016, -0.233910431580783, + -0.230399664670469, -0.228017774399454, -0.226821626489171, + -0.226987795132843, -0.222191040910817, -0.221263702640727, + -0.219736964896469, -0.218635936308017, -0.217453476036687, + -0.215024790465196, -0.214170435558052, -0.215732644942119, + -0.216612057520706, -0.217609994808005, -0.218055905956787, + -0.218967804772427, -0.220558189147935, -0.222275707883797, + -0.2239932987617, -0.225710869661144, -0.227428400777832, + -0.229145979327762, -0.230863446135894, -0.232580950386173, + -0.234298433038918, -0.236015950997184, -0.237733466151589, + -0.239451000539196, -0.241168435506976, -0.242885913862981, + -0.244335544501658, -0.245781021723198, -0.245948353708734, + -0.247314211467919, -0.248153053153479, -0.245087511617906, + -0.237459879075843, -0.23481090953308, -0.23802957901215, + -0.241709600800631, -0.250590516072255, -0.268406783286001, + -0.295171476594481, -0.326428877460203, -0.359489386031145, + -0.392951333168907, -0.431298765776664, -0.46247940701343, + -0.485391334814686, -0.507531752494688, -0.51587093585591, + -0.499525228548594, -0.500814580200975, -0.519096517097155, + -0.520043515489135, -0.515596199187458, -0.495404142615838, + -0.483000408242056, -0.476635283203042, -0.475232994971029, + -0.466763616607949, -0.462839117772348, -0.453015178867006, + -0.438962233020687, -0.426838774929186, -0.420980419837863, + -0.418314946210826, -0.414338066612509, -0.406707951161784, + -0.397456164609813, -0.395275160353329, -0.397953342909474, + -0.382163514501779, + -0.0913631886523462, -0.0898862900563396, -0.0924088952204376, + -0.0949315664434464, -0.0968673884282147, -0.0856949106056535, + -0.0835114260460506, -0.0690129694076909, -0.0584423964365191, + -0.0583595287630792, -0.0572245618315363, -0.0549311488471931, + -0.0526551362513629, -0.050405605424606, -0.0481561056285225, + -0.0459067119628295, -0.0416858542049939, -0.0467420873509977, + -0.05141443670726, -0.0556267175755769, -0.059242520508342, + -0.0626991114293533, -0.0658716562474397, -0.0690440870554737, + -0.0722165148217778, -0.0753888494222126, -0.0782873140883886, + -0.0791464425653973, -0.0782221846612709, -0.0783567884816699, + -0.0807678123524734, -0.0839412516575803, -0.0883547330970904, + -0.0946755235104966, -0.106507236138496, -0.118934211293316, + -0.129668122771752, -0.14090340478729, -0.156983979399086, + -0.168563069172814, -0.173256949556793, -0.175348799252121, + -0.177228015224767, -0.177245804170956, -0.17870100870248, + -0.180332769621423, -0.184134159305589, -0.185772483256843, + -0.19431643337487, -0.205461901288405, -0.2134234089426, + -0.220430630001494, -0.224614009480802, -0.227530458453562, + -0.224526242203447, -0.223046428308772, -0.222095293356046, + -0.230226685367766, -0.238271137672546, -0.240350782051172, + -0.240382111973933, -0.239167302720691, -0.237952453205994, + -0.236737642998116, -0.235522877372373, -0.234210817759597, + -0.234117022803871, -0.235055263027525, -0.23608259346233, + -0.23679104565383, -0.237371567470665, -0.237408453562907, + -0.236063432245173, -0.235599127253837, -0.235364644066752, + -0.235129743897474, -0.234894884448696, -0.234659971808229, + -0.234425116774173, -0.234190257214176, -0.233391175806826, + -0.230092191573572, -0.227710370849215, -0.226323143291886, + -0.222875696337757, -0.227005200980088, -0.224436291728373, + -0.220778050017985, -0.21972514425262, -0.218936894134113, + -0.218388642557222, -0.218798598922918, -0.215228826351382, + -0.216411393076066, -0.21806315921302, -0.21985579719072, + -0.221648354361878, -0.22343861682127, -0.225179025001773, + -0.226914549106901, -0.228650176459695, -0.230385718253873, + -0.232121269877304, -0.233856818641421, -0.235592305310907, + -0.237327850900452, -0.23906332146494, -0.240798745132603, + -0.242534217700867, -0.244269608384675, -0.245895286478916, + -0.246359318386631, -0.246486896029267, -0.247988333462633, + -0.247679595935503, -0.247529137217593, -0.247825493725682, + -0.241451803344363, -0.243147445219704, -0.256395216090319, + -0.265323925680033, -0.275042177498316, -0.291081978750904, + -0.313345179347724, -0.339452836735524, -0.369116495379096, + -0.396893287551962, -0.435102286061298, -0.476706888473269, + -0.490538438281075, -0.505835496381906, -0.512972083496209, + -0.494314137170553, -0.492432512709944, -0.506621782269599, + -0.49225633862609, -0.480293311204075, -0.471061145888772, + -0.460242354419031, -0.453222614715661, -0.446608693795807, + -0.441009131785007, -0.436216021323516, -0.425619648785881, + -0.410522173499038, -0.398062077373336, -0.391917221680383, + -0.388294962737605, -0.386284304093036, -0.382854612192365, + -0.375616872357722, -0.373220359568061, -0.371699268946775, + -0.364900166133622, + -0.0975044962883877, -0.0900679839260513, -0.0925905953036438, + -0.0951132412828582, -0.0971853698082962, -0.0862304057085752, + -0.0783548642661262, -0.0729556464720623, -0.0612259081544466, + -0.0592839387452847, -0.0581311961690329, -0.0560938000901166, + -0.0538769467970601, -0.0512502639284315, -0.048661118383469, + -0.0461005788664967, -0.0448861560207247, -0.0489263223795893, + -0.0528350444915692, -0.0561444517674455, -0.0593226620391699, + -0.0624952693454803, -0.0656677460226866, -0.0688401931519153, + -0.0720127146411016, -0.0751849743862559, -0.0783572477999482, + -0.0810246942350825, -0.07917458010203, -0.0809473233562138, + -0.083297359636447, -0.0890532471743368, -0.0956257193178322, + -0.102994498616203, -0.112070411465167, -0.123117642134052, + -0.135752749881551, -0.151126751395581, -0.16439781923504, + -0.172462346698854, -0.173915367017746, -0.174684991186537, + -0.177409981906396, -0.17861753345781, -0.180070425517701, + -0.181522683202941, -0.184928554482107, -0.188307369539081, + -0.197402787084381, -0.206737250904088, -0.213403737474169, + -0.218990744045371, -0.221497841751365, -0.224169304147272, + -0.222844949769883, -0.221815036646708, -0.222311283872909, + -0.226421648353465, -0.235725027049291, -0.238824046562253, + -0.239227219234211, -0.238012400296794, -0.236797564414433, + -0.235582758990097, -0.234369117919129, -0.23315863046668, + -0.232263315341002, -0.233379751072367, -0.235143608092324, + -0.236713278483815, -0.237214360092317, -0.236494348869492, + -0.235480188681541, -0.234582856298925, -0.234356299156381, + -0.234121396734158, -0.233886537369936, -0.23365166397067, + -0.233416782319151, -0.233181950918712, -0.232732406674908, + -0.229784660608858, -0.227402965359863, -0.22639923505262, + -0.224072944184098, -0.227034482546308, -0.226356867343353, + -0.219652273484722, -0.216371822111377, -0.212845001607749, + -0.210503683273999, -0.213328418296244, -0.214949505272878, + -0.21542595749888, -0.215460290462911, -0.217200946865792, + -0.219266483741428, -0.221331972526271, -0.223397564807682, + -0.225463118167918, -0.227528664515216, -0.229589681403342, + -0.231604796884515, -0.233613485885563, -0.235622139186269, + -0.237616757140983, -0.239436457867197, -0.241237568582644, + -0.243038683501456, -0.244839836746111, -0.24681286564768, + -0.248322441620058, -0.248600158492325, -0.248635948394634, + -0.248033142486088, -0.251136009716983, -0.255923503722542, + -0.249703321033981, -0.254984500123422, -0.274984608767874, + -0.293827829952868, -0.308994161720986, -0.326757335362032, + -0.344980298568485, -0.360131086334378, -0.385542140410234, + -0.423112092750828, -0.462715568206066, -0.49682447026374, + -0.507415941735723, -0.510715602496889, -0.503094210606196, + -0.479218404613741, -0.476324832474096, -0.476397212860018, + -0.457326311608842, -0.44833895203525, -0.447761237268902, + -0.437933170123946, -0.428395458695808, -0.41868601913252, + -0.412328281363998, -0.406020966856853, -0.397388346099716, + -0.388170212826106, -0.381740966787847, -0.377224996004545, + -0.375607932652152, -0.374336550633603, -0.373966779129564, + -0.373906794058364, -0.377370464796788, -0.375196974890535, + -0.37208169655473, + -0.103378296042247, -0.0902495809067684, -0.0927722546265285, + -0.0952948434288961, -0.0974554727955824, -0.0877303150141396, + -0.0760120147081701, -0.0706917170779615, -0.0620238327427033, + -0.0591123539942092, -0.0590371775900556, -0.0571081166066372, + -0.0548775648654809, -0.0529089567877513, -0.050684812056154, + -0.0476137624907805, -0.0467985787478856, -0.0498383117816921, + -0.0529214287785609, -0.0560041958289317, -0.0591188086669433, + -0.0622914592021079, -0.0654639266584176, -0.0686363909741551, + -0.0718088391616567, -0.0749810619044081, -0.078153316207133, + -0.0815604977722749, -0.085590334335247, -0.0850553321130542, + -0.0884939627156555, -0.0948335017277812, -0.103189082409409, + -0.111133338517286, -0.117877669527371, -0.126835987396708, + -0.1430266435201, -0.160262104726533, -0.165482926142303, + -0.169423210407558, -0.173363441632541, -0.176214181518629, + -0.177927289192794, -0.178696068395979, -0.179721484321024, + -0.182771219429048, -0.188744675396585, -0.197013456646582, + -0.202915873407153, -0.207243030315909, -0.211296287490989, + -0.215460802841525, -0.21696111623989, -0.217083427913142, + -0.219961322741204, -0.221096579623832, -0.221584069420884, + -0.223938233879682, -0.233765213563227, -0.237848608524057, + -0.238252026248874, -0.237161880908919, -0.235913599071486, + -0.234539816602031, -0.232923908559985, -0.231609380940341, + -0.231455473978392, -0.232177668954293, -0.23543513421091, + -0.236159797741632, -0.235950889913713, -0.2359110687058, + -0.234896899197215, -0.233728805363788, -0.233313612702501, + -0.233111360818546, -0.232878217257036, -0.232643340324323, + -0.232408491260275, -0.232173628068144, -0.231797128063409, + -0.229477182558142, -0.227095575379507, -0.22639246741431, + -0.226656713445963, -0.226973022053872, -0.227213001659678, + -0.224270067630012, -0.221886384160394, -0.214715214634743, + -0.206571495779056, -0.20688022823578, -0.210738153450339, + -0.21175252907505, -0.21326125101152, -0.214162347801944, + -0.216080454766157, -0.218146015881181, -0.220211518306099, + -0.222277061653071, -0.224342658639137, -0.226408236437261, + -0.228473829109952, -0.23053934471004, -0.232604994286188, + -0.234706098862324, -0.23696125256909, -0.239262963483182, + -0.241870229369568, -0.244014340710608, -0.247494653299791, + -0.252106354532305, -0.253233553026904, -0.2500508196926, + -0.252998782839494, -0.258243665255916, -0.260690660930433, + -0.26519011778707, -0.27317105619653, -0.288720200443606, + -0.310083540247406, -0.331113673229242, -0.353853630777788, + -0.373212202970942, -0.3797319841065, -0.40979846687722, + -0.461603407318924, -0.483157724271918, -0.500546342404062, + -0.511625584049197, -0.509319421792374, -0.482013526511815, + -0.460477879537479, -0.455022170468962, -0.444731247997719, + -0.43392227831942, -0.430779559315616, -0.432538595113589, + -0.426553821283456, -0.419797133760217, -0.410811073958708, + -0.405976810983696, -0.40456737663919, -0.398718840161222, + -0.394619773829832, -0.391522614110421, -0.380300340969479, + -0.381257451108985, -0.383611469787115, -0.383066156946162, + -0.385131007453877, -0.39579034950566, -0.394043597304037, + -0.393796208497608, + -0.119620388891931, -0.090431161286249, -0.0929538585268752, + -0.0954763994856824, -0.0978757739192433, -0.0883992593571142, + -0.077833474086259, -0.0676338012196063, -0.0610970312806746, + -0.0590418296856446, -0.0589650225193632, -0.0589680276241557, + -0.0581150908597494, -0.0548641164608973, -0.052513757980165, + -0.0504663686916181, -0.0494487979828739, -0.0521375425964625, + -0.0549641969961085, -0.0578557762634907, -0.0607474450354201, + -0.0636389927400293, -0.0665318736422025, -0.0694259860816425, + -0.0723389053663904, -0.0752584591694447, -0.0781778219445655, + -0.0807727975112542, -0.0818798363983728, -0.0859246625081119, + -0.0912937413981278, -0.0994316105041814, -0.110297217854101, + -0.119569307087336, -0.124590577674304, -0.132103717397933, + -0.149225904189572, -0.160485802273319, -0.164123658212068, + -0.168006369554639, -0.171903914980193, -0.174243456748224, + -0.17581413063905, -0.178157811004656, -0.179575705230444, + -0.182918322715049, -0.192696929838932, -0.202229885242822, + -0.20511761038298, -0.207547698272324, -0.210249479012756, + -0.21293002627653, -0.213506327701725, -0.21315697389731, + -0.215162086949279, -0.21428456113161, -0.215931583109257, + -0.221217853572564, -0.23192157686605, -0.237364373563358, + -0.237111390465255, -0.235495370691489, -0.233879392958218, + -0.23226350412401, -0.231070197400993, -0.230950379191673, + -0.230850828998178, -0.232748995474104, -0.23510023844999, + -0.234821812407993, -0.234665699442388, -0.234767535863995, + -0.234313635510539, -0.233056315238659, -0.232236496473557, + -0.232065737324971, -0.231869924786748, -0.231635030422799, + -0.231400161021245, -0.231165319426296, -0.23083650826786, + -0.229169711117433, -0.226854536110143, -0.226392391807997, + -0.226611044717103, -0.226979801249108, -0.227602799638782, + -0.228439296210546, -0.229091590151205, -0.223135748234907, + -0.211216990540785, -0.204981116668773, -0.205930764316831, + -0.208370863776398, -0.211957281632351, -0.212052389874783, + -0.212977024533864, -0.214959950313929, -0.217025516304844, + -0.219090983100591, -0.22115660321185, -0.223372444728392, + -0.225952963164585, -0.22854256941925, -0.231165566326332, + -0.233788533937587, -0.236411513883167, -0.239034492638953, + -0.242833492486959, -0.245573054510774, -0.25316037760274, + -0.26089794977645, -0.262766189999014, -0.261371920275249, + -0.263337200385381, -0.266410134744609, -0.26993252349676, + -0.27898281170682, -0.292634893057606, -0.308308839178002, + -0.32766852313345, -0.348528889625876, -0.371505374850928, + -0.389291328593945, -0.40194724429577, -0.45236866165055, + -0.491059724595953, -0.493509971101769, -0.49420075076448, + -0.503556046596142, -0.491379928284371, -0.456775266966353, + -0.44457102828705, -0.438320902302177, -0.432105229282741, + -0.434415055284585, -0.430877939066814, -0.42654591252145, + -0.427666845016838, -0.427217710036509, -0.421352379877, + -0.419761121113933, -0.422758020468268, -0.418582873055651, + -0.416321534760795, -0.409111474984626, -0.395645584565133, + -0.398273024127513, -0.406926274474767, -0.400623060976978, + -0.399631159342666, -0.406172213871104, -0.405249256847143, + -0.40452330731216, + -0.124770822892163, -0.090612751105881, -0.0931354709538213, + -0.0956580444692562, -0.0980940776822708, -0.0891061885472104, + -0.0783462030494994, -0.0675716221989947, -0.0612768639596784, + -0.0597339730931923, -0.0594414859328168, -0.0591946344995778, + -0.0589477850524501, -0.0586990402317769, -0.0556030311172612, + -0.0545070021073732, -0.0510096346791556, -0.0530634965864942, + -0.0563710312291494, -0.0596784838900982, -0.0627991356279344, + -0.0658592466167528, -0.0687117749720661, -0.0716050922307397, + -0.074498236398799, -0.0773912865656796, -0.0802843203634072, + -0.079919345031216, -0.0807155475425058, -0.086044461586461, + -0.0929859960913506, -0.103674078909423, -0.116946730418647, + -0.126975864553706, -0.131927885375145, -0.139851945123778, + -0.154293570837475, -0.159447497132282, -0.163063859687902, + -0.166589586107288, -0.16999507109704, -0.172020557122961, + -0.174420200170662, -0.179002408237589, -0.179982062529812, + -0.181072978939746, -0.192574556744869, -0.200902709450131, + -0.203109711647256, -0.206944942123798, -0.2094484646109, + -0.210624394059921, -0.212036051559429, -0.210814155133798, + -0.209910854511461, -0.211451506795133, -0.213720259812387, + -0.219315594507429, -0.228906939964573, -0.234120878874752, + -0.234654122098636, -0.233219041576056, -0.231603093848642, + -0.230543173363562, -0.230416278583958, -0.230112159961154, + -0.230020811737063, -0.232107517171411, -0.233729582948162, + -0.233727241104012, -0.233380534542001, -0.233167821439119, + -0.233710360801506, -0.232544124527232, -0.231577431665963, + -0.230998712823287, -0.23081784531241, -0.230622047120085, + -0.230391876327923, -0.230157037825933, -0.229857688388425, + -0.228862213069677, -0.226731871711726, -0.226392310912509, + -0.226565376557149, -0.22654265993544, -0.227216315985547, + -0.229297763745794, -0.231004655554803, -0.229145686775831, + -0.219037460718396, -0.207105252114321, -0.202826692481669, + -0.204698878718925, -0.208649876382047, -0.210697603856612, + -0.210167542941398, -0.211693549924939, -0.214709958577637, + -0.217838050887992, -0.220461011314326, -0.223083972994364, + -0.225706930624992, -0.228329889290889, -0.230952850847068, + -0.23357584066759, -0.236198809797653, -0.24041337828348, + -0.245150613057506, -0.248321631073085, -0.263562026456686, + -0.272374212186507, -0.274667044504458, -0.274153871525232, + -0.276430138001588, -0.280928944530095, -0.286561133563878, + -0.298491132817586, -0.314887491741851, -0.332332800673711, + -0.349648218220778, -0.366861879786132, -0.385388223467181, + -0.398811789508331, -0.423878880318982, -0.478387617237211, + -0.496237355085156, -0.481851599655479, -0.472962100808797, + -0.4770309244145, -0.462547282057305, -0.446003500199039, + -0.442613880783571, -0.438707322036206, -0.437505033993111, + -0.440775946966643, -0.440156470958682, -0.435115630771107, + -0.433275682647562, -0.431053856176346, -0.430617910328499, + -0.430951458610274, -0.429301426033438, -0.427803890178067, + -0.4303235799711, -0.427509127417483, -0.42098886896344, + -0.421132216674063, -0.420335144810011, -0.408056678106558, + -0.404071452078909, -0.405851217774358, -0.407590270017595, + -0.408483672026586, + -0.12987091404052, -0.0909026681286664, -0.093316951944594, + -0.0958396045561985, -0.098307301434777, -0.0903992153586764, + -0.0789699198382486, -0.0685463225045073, -0.0618787562347245, + -0.0607612252904762, -0.0600003664807564, -0.0592070601428032, + -0.0584283226338119, -0.0580180870487666, -0.0585538164688747, + -0.0568825851164286, -0.0524771096299263, -0.053341226085023, + -0.0566486880653975, -0.0599561725494725, -0.0632635041879286, + -0.0665707955853361, -0.0698780023535355, -0.0731852072704668, + -0.0764921751126381, -0.0795403842084919, -0.082451983402502, + -0.0805594164801474, -0.0812682073009862, -0.0872679246071515, + -0.0965273147645758, -0.11039486836578, -0.125037249747503, + -0.13503923834583, -0.141896816035879, -0.148368428410545, + -0.153063335255287, -0.158916649507481, -0.162316048747577, + -0.165171650695045, -0.167884357530111, -0.170285397416277, + -0.173267008445882, -0.177642959205528, -0.178456658399831, + -0.180865277984545, -0.191607871038136, -0.197465721589968, + -0.199289141237937, -0.204365303827894, -0.207640060946983, + -0.209476455790779, -0.211623501004289, -0.210855746963626, + -0.210000960400593, -0.209293314978569, -0.212225659806438, + -0.218994875409468, -0.225921726109878, -0.229429310580342, + -0.231780051333681, -0.230942722905936, -0.2299625892118, + -0.22946067946808, -0.228244017120391, -0.228619338670316, + -0.227854754316093, -0.230964803924505, -0.23244206464209, + -0.232459893651018, -0.23209532137045, -0.231744802414922, + -0.232598619034849, -0.232042458292747, -0.23070513161181, + -0.230009034834312, -0.229759664595716, -0.229569994951656, + -0.229377005142006, -0.229148738514849, -0.228871473057119, + -0.228211329708594, -0.226683742219087, -0.226393261135281, + -0.226243230866189, -0.225734398511882, -0.226869167906646, + -0.229552257778613, -0.23185171647347, -0.232418820222395, + -0.225918268162486, -0.213605153814244, -0.20699988956427, + -0.209432065150266, -0.214013274422698, -0.214150111705064, + -0.21111625582517, -0.209553695399705, -0.208902324384938, + -0.211939984212161, -0.215852030731269, -0.219764119763799, + -0.223676152897469, -0.227588443630577, -0.230618863120276, + -0.233322291141637, -0.237439896860746, -0.247997526302033, + -0.250948229987538, -0.259818877626556, -0.274426213427996, + -0.285695104258276, -0.289432560216068, -0.289481000919762, + -0.291514041513227, -0.29784959663583, -0.30884393692371, + -0.324515663255562, -0.341105095645649, -0.356167003342034, + -0.370418290865686, -0.384358556454535, -0.399573835661535, + -0.406558961017399, -0.432582644358571, -0.490518878947138, + -0.488419955202289, -0.463504356961216, -0.456484717662606, + -0.455258649778257, -0.444924644643896, -0.444513868319375, + -0.448141641189456, -0.44863944134605, -0.444720381404262, + -0.439608377044744, -0.440792516290763, -0.438503983545307, + -0.439765065280584, -0.437630018298527, -0.43425204694856, + -0.432720843493852, -0.429087513044759, -0.428421441315108, + -0.427196622432886, -0.426739868717228, -0.432302226073356, + -0.433480402894174, -0.426997972516708, -0.413787375172442, + -0.408879525403903, -0.408109352105735, -0.40718098226409, + -0.408392630409227, + -0.134971586803856, -0.0938174543006709, -0.0934984523650463, + -0.0960210397942831, -0.0985209403419677, -0.0918065016980751, + -0.0796392401154083, -0.0688718479484736, -0.0630523569097713, + -0.0616601361504951, -0.0606980740289461, -0.0593622849184893, + -0.0579174710258352, -0.0568123636875723, -0.0595484388313369, + -0.0579539653470697, -0.0538324681544842, -0.0536189710766699, + -0.0569263515197209, -0.060233780576932, -0.0635411376448093, + -0.0668484070417001, -0.0701557097619825, -0.0734627591237102, + -0.0768156300792785, -0.0803230300493748, -0.0838707440978983, + -0.0823592028040165, -0.0826726614962636, -0.0891411776716699, + -0.100869713363431, -0.117632541347874, -0.133831738354452, + -0.142140236504949, -0.144487875908553, -0.148738025004257, + -0.153648439392574, -0.158052679430463, -0.162404325309927, + -0.16371262162448, -0.166662658526015, -0.169569639963736, + -0.172150995162598, -0.174399873251632, -0.175875308986072, + -0.180432450225735, -0.190580690171566, -0.195507421487564, + -0.197310153857237, -0.199973272571732, -0.205686578820375, + -0.21031413130786, -0.211632456922166, -0.209596337988464, + -0.208372958028466, -0.209149782272613, -0.211679895115993, + -0.216856150955681, -0.221105929255909, -0.220821612118659, + -0.224050554915262, -0.227707768598925, -0.227181498093953, + -0.226537203675793, -0.226986586903626, -0.226400446181998, + -0.225911476713633, -0.227014246181574, -0.231099721271314, + -0.231174697924485, -0.230810190495301, -0.230444091295824, + -0.230884241159364, -0.231549765796961, -0.22995108447991, + -0.229367562954637, -0.228677745848198, -0.228512012800123, + -0.228322138457881, -0.228130176681739, -0.227885290177443, + -0.227271619601233, -0.226683361283558, -0.226560930161036, + -0.226502874805956, -0.22634356129081, -0.22758197192762, + -0.230011085626106, -0.232443239581152, -0.233908219609465, + -0.231367999027107, -0.22446453002777, -0.22082259581932, + -0.224511246500013, -0.229449158491604, -0.228943744873555, + -0.223686839536178, -0.217879406611272, -0.211734884184406, + -0.208169044466615, -0.209158116944054, -0.211856327351181, + -0.215718534185785, -0.219580730340769, -0.224960181605181, + -0.234282903462433, -0.254233550914403, -0.270259107677151, + -0.274588571790621, -0.279461917126508, -0.290038416021483, + -0.301067806978561, -0.305139984882748, -0.305246611336287, + -0.30769598887783, -0.316603857851121, -0.33097268531896, + -0.346859547434636, -0.360605536489761, -0.372234741783964, + -0.384163833378422, -0.397379100520595, -0.413679506048604, + -0.424734574232893, -0.464241645429367, -0.507626340919874, + -0.499545869580017, -0.470670518164038, -0.457146650093007, + -0.458144095680072, -0.45050771131643, -0.448582402580386, + -0.448010744918111, -0.442998713547434, -0.438129004139511, + -0.429951622852848, -0.431772796407845, -0.435204461262444, + -0.438791172378256, -0.439243034392685, -0.435486221470888, + -0.431295151229136, -0.428445083980731, -0.42835909863463, + -0.427477923168612, -0.430963970343673, -0.436050808985945, + -0.434267930136929, -0.430012263101138, -0.418283767317473, + -0.410997505890662, -0.409598918613776, -0.40690967720261, + -0.408033786995527, + -0.140072258078583, -0.101356793253206, -0.09368000349545, + -0.096202517091717, -0.0987249780307497, -0.0934988421317371, + -0.0803087588899055, -0.0695411590332797, -0.0642953820928051, + -0.0622315745164283, -0.0613010184253592, -0.0602051012578702, + -0.0584274696828739, -0.0572690594117653, -0.0585954560184144, + -0.0574077450531116, -0.0551161283583918, -0.0538966303463246, + -0.057204091261884, -0.0605114655919094, -0.0638188327074725, + -0.0671644165382663, -0.0705335941333013, -0.0738122147696967, + -0.0760885924132817, -0.0783808495184402, -0.0830924072393327, + -0.0847474370756543, -0.0844421393421115, -0.0908041077780153, + -0.104820790729393, -0.123802100608536, -0.138890916427189, + -0.142110676016255, -0.143101465196174, -0.147682145684541, + -0.153008814783801, -0.158335356587681, -0.163202095144721, + -0.164083621503598, -0.165080002500988, -0.167635331844783, + -0.170389270258058, -0.171887313422604, -0.173224737116709, + -0.178308145533362, -0.185882595752903, -0.192105504917683, + -0.194547333233152, -0.196291752608261, -0.203469158063111, + -0.210058991050589, -0.210100088663114, -0.207127560400347, + -0.207871925094549, -0.208022058614279, -0.209457646190545, + -0.212958773333427, -0.216620581981035, -0.216777980572319, + -0.21415040565466, -0.218708356799095, -0.22350836318522, + -0.225279633554708, -0.224769582161042, -0.22395861781685, + -0.223412014662035, -0.225259269623546, -0.230092427412604, + -0.230162183691815, -0.229555086526183, -0.229160568284064, + -0.229185933511724, -0.230418172697248, -0.229347183370205, + -0.228562161808509, -0.22764638131517, -0.227440659377459, + -0.227264530119815, -0.227074331955223, -0.226903169795247, + -0.226047314048322, -0.225486068819176, -0.226054536606012, + -0.226684330501021, -0.227238903838604, -0.227989758685944, + -0.229538270789348, -0.231569781261153, -0.233266226304168, + -0.233520668112463, -0.232274022154932, -0.2327810531815, + -0.236458786245237, -0.2400232334991, -0.240676731611138, + -0.239127473578422, -0.235276980294507, -0.228519468022579, + -0.22054291749036, -0.217139590282766, -0.218621838754914, + -0.222437634809336, -0.227238902979829, -0.232471211537451, + -0.253750271729004, -0.273975966089441, -0.283886765152878, + -0.290341240172671, -0.297211837594583, -0.30663763278514, + -0.315489051253426, -0.318683806926144, -0.318893068078424, + -0.321788459248735, -0.331201045971446, -0.345163025075011, + -0.359322655766598, -0.371024181701454, -0.381196585145303, + -0.392655635733946, -0.407150943501194, -0.426595839262242, + -0.448117579816616, -0.485349368466938, -0.502264973017922, + -0.499106044203201, -0.498355571861707, -0.480686815312133, + -0.467552692630354, -0.45998662179721, -0.453208943495131, + -0.440366385268074, -0.431589144507159, -0.429947426786133, + -0.429652766404224, -0.429700358690795, -0.429735816138896, + -0.431935788300304, -0.435778123836634, -0.434232399740632, + -0.431122196980509, -0.428012046957698, -0.427333322653623, + -0.427620521822865, -0.43145314354717, -0.432059289261293, + -0.431123716657171, -0.428518090110967, -0.4194022414122, + -0.411346389755285, -0.408982569897879, -0.407956118511907, + -0.410189782486057, + -0.145172826578164, -0.113700970313872, -0.0938614508806709, + -0.0963840967390459, -0.0989064678507868, -0.095645135649877, + -0.0809778909404611, -0.0702105700009753, -0.0661696279738258, + -0.0634336737942851, -0.0619326061229161, -0.0608539235947583, + -0.0594986660182078, -0.0582921516381427, -0.0583149478291683, + -0.0570332277316532, -0.0551568035778046, -0.0541741650699819, + -0.0574899869843785, -0.0603486630486628, -0.0628940770205724, + -0.0651590251355116, -0.0674239393840902, -0.0696887779116365, + -0.071953584439841, -0.0766912634176691, -0.082360787620012, + -0.0863808132205384, -0.085581785698577, -0.0922239013059371, + -0.108721096563451, -0.128474341649459, -0.138516769856547, + -0.140959609880681, -0.141715478712208, -0.14662643108042, + -0.15195299509592, -0.15756619578864, -0.16343711817087, + -0.164814995008805, -0.165351087228927, -0.16634306246808, + -0.168542673253396, -0.169224377197144, -0.171838953859449, + -0.176098305895958, -0.181032244087048, -0.185270446765145, + -0.187814432941902, -0.191767503709891, -0.199773966460939, + -0.206771584745594, -0.20720343247307, -0.207026562423508, + -0.207393064458466, -0.207536418001924, -0.207732312666214, + -0.209074742910958, -0.213225660453302, -0.215462251818415, + -0.213635338249542, -0.213093538813863, -0.215162190298647, + -0.219149597806809, -0.221810210726061, -0.220791167056139, + -0.221285389723455, -0.223780915000642, -0.229175037283889, + -0.229264154634528, -0.229134062755613, -0.228233270664763, + -0.227512821308941, -0.228599110038685, -0.228259101657398, + -0.227025639683713, -0.226520603618701, -0.225978259957967, + -0.226222553454551, -0.226441120826559, -0.224776101676466, + -0.222813944376943, -0.222692714352431, -0.223611942276968, + -0.224487461638142, -0.224649932707153, -0.225052021431296, + -0.226833839365858, -0.228935434198636, -0.230429677525354, + -0.230909396036724, -0.230907695780304, -0.231445170273092, + -0.232688986985643, -0.23434556414054, -0.236118150743206, + -0.238679009128662, -0.241370101191757, -0.240692034168829, + -0.236762902979266, -0.235466017335602, -0.237846602006348, + -0.241343140370659, -0.245140645562394, -0.250787914766182, + -0.263595835955433, -0.277325362723405, -0.289623919888746, + -0.299604465128721, -0.308594956309139, -0.318049812076164, + -0.325517195382171, -0.328465637665362, -0.329166153012893, + -0.33194257951061, -0.33985378360214, -0.351908263874414, + -0.365112372954823, -0.376691651454391, -0.386569571622714, + -0.398324518506029, -0.415868075354042, -0.438852764804079, + -0.455293158138188, -0.468437085829221, -0.473704391042588, + -0.46912603294502, -0.479151894341199, -0.489211299392173, + -0.481816937664836, -0.464340090677681, -0.447386292015227, + -0.43191089803852, -0.429766345468955, -0.430572002899936, + -0.430412311685845, -0.430674979189334, -0.430998861190524, + -0.431322756083124, -0.431607742808595, -0.430887490072244, + -0.430949342336264, -0.427839131159829, -0.426186646849234, + -0.426592561067757, -0.427124789688251, -0.427742561269923, + -0.427799190850322, -0.426228768156432, -0.421021179257685, + -0.412369137651747, -0.407499776696002, -0.407779771739838, + -0.410601013716454, + -0.15027329493693, -0.117659651864813, -0.0940429394144917, + -0.0965654852683864, -0.0990879789620518, -0.0978568700602819, + -0.0816474345802776, -0.0708803569200323, -0.0680789951829304, + -0.0649683566381849, -0.0629619281102124, -0.0615143166925489, + -0.0594087075411336, -0.0569382558673074, -0.0567438011184989, + -0.0555858803697833, -0.053097774605107, -0.0525654929684088, + -0.0542367992445995, -0.0564939705940248, -0.0587589707983019, + -0.0610239344256032, -0.0632888346284141, -0.0655537373043405, + -0.0702899461132414, -0.075952661818056, -0.0811669160970539, + -0.0855256781273646, -0.0881886013950366, -0.0932885564207375, + -0.109162932124177, -0.128745335008358, -0.138159947685812, + -0.139510998252221, -0.140343247025432, -0.145838956274769, + -0.151494388330411, -0.15645802302028, -0.161012466854783, + -0.164452936540052, -0.166189766361347, -0.167907405301814, + -0.169112213303715, -0.169977832886525, -0.171558210683282, + -0.174931724994841, -0.177971975061851, -0.17955556473992, + -0.181169971226962, -0.186278965327567, -0.193908053827539, + -0.200321053218798, -0.204415979233128, -0.206400479236089, + -0.206508188362574, -0.206228483287766, -0.206097138962473, + -0.207116456778811, -0.210255399564117, -0.21409883931921, + -0.212674053260642, -0.20798883006373, -0.206220200087171, + -0.20871879694247, -0.210915839591984, -0.212505325801173, + -0.216894125141438, -0.221294696923945, -0.22502845997229, + -0.226121646373453, -0.224749042845292, -0.220830572836819, + -0.218106721632243, -0.219813158143477, -0.220324454861336, + -0.219444562090213, -0.219456435728679, -0.219984229974528, + -0.221219749935549, -0.221296995761609, -0.219572907330813, + -0.218674387329017, -0.218596500372652, -0.219158370020693, + -0.219783716463951, -0.219967871280638, -0.220854999918676, + -0.22280489651084, -0.224549565984222, -0.225587410162404, + -0.225398243705469, -0.224278119753996, -0.223263486435015, + -0.223321061429526, -0.224769728559285, -0.226990217193668, + -0.22992291967372, -0.234784694953522, -0.238769995409282, + -0.239797304104828, -0.240778387992964, -0.242023392906191, + -0.242630790609116, -0.242778700284717, -0.247453488968647, + -0.26105875830719, -0.27888334644939, -0.295561732390579, + -0.307263747011572, -0.316159156375043, -0.324512701812949, + -0.330902733919258, -0.334388034241969, -0.336215472463776, + -0.338929483608879, -0.34531800716424, -0.355794409404099, + -0.368269738666784, -0.37970626280567, -0.38998954442851, + -0.402942144268089, -0.423236901338895, -0.449508822623176, + -0.469002479063256, -0.475382585949762, -0.479508371384415, + -0.480535708642202, -0.477040298494758, -0.482354486198666, + -0.480987320683112, -0.459855424676151, -0.440998468004206, + -0.431654418596764, -0.431455860268238, -0.431159051916841, + -0.431236830518794, -0.4311825264185, -0.431506413828178, + -0.431830302857367, -0.430807908242381, -0.427069807878713, + -0.426987876757804, -0.426462979649962, -0.425179940774805, + -0.425039274316473, -0.423963132332198, -0.423630240982569, + -0.42568704453887, -0.427051757431681, -0.4217380759446, + -0.411719585241333, -0.406529011532508, -0.407511671446906, + -0.411211035680697, + -0.155373982002476, -0.129852754257174, -0.0944294496988321, + -0.0967469044950193, -0.0992693386799495, -0.0990896964123199, + -0.0823169107940737, -0.0715498803686989, -0.0701515293281989, + -0.0671720538021936, -0.0641627662910015, -0.0615857837578667, + -0.0574241740865932, -0.052702959474383, -0.0501528209390616, + -0.049519515547969, -0.0487167821182009, -0.0503177857062629, + -0.0515211718014463, -0.0524623141809803, -0.0546238706862636, + -0.0568888876223614, -0.0591538235810746, -0.0638883688046428, + -0.0689067887333374, -0.074204054437987, -0.0788925613569978, + -0.0835399976802414, -0.0882190599143055, -0.0919705154911694, + -0.10305419464998, -0.120768303186511, -0.134623704324297, + -0.139089749185857, -0.139740264638809, -0.14439581134303, + -0.148952241854701, -0.153506823040524, -0.158061290339383, + -0.162602302859718, -0.16551113599562, -0.170154443882751, + -0.171303837587789, -0.170766905912054, -0.172019828945002, + -0.175358086826806, -0.177148881731981, -0.177505437683231, + -0.178321580434313, -0.181455205423504, -0.185575895018357, + -0.190093840782019, -0.195777247473734, -0.20143702357375, + -0.203917242529527, -0.204363203149574, -0.203626833523788, + -0.205966914152872, -0.209244970667038, -0.210479841620179, + -0.207618412108244, -0.201038625182888, -0.197431561845877, + -0.198595060148943, -0.200007990747973, -0.203043585242727, + -0.209940774367109, -0.214149798555753, -0.212443511376897, + -0.209786057798966, -0.208086203784967, -0.204657941407463, + -0.203731368863015, -0.206879066189689, -0.209412443122255, + -0.210992244134852, -0.212749973604365, -0.21437720685865, + -0.215672182034026, -0.215699307436453, -0.215119345067095, + -0.214394396851581, -0.213251667090197, -0.212892116738653, + -0.213549359057033, -0.214993395778676, -0.216820238944181, + -0.217840743007766, -0.218389044670454, -0.219093217677506, + -0.219061243208701, -0.217916948087643, -0.217103236435487, + -0.218262574569587, -0.221055015276937, -0.223813736586256, + -0.226061662563148, -0.229132927865368, -0.23332677268009, + -0.235793906943517, -0.237304158876104, -0.237731733437009, + -0.237333985893418, -0.237588029596619, -0.244864438177429, + -0.261868947241693, -0.283137324824455, -0.301717948676584, + -0.313459643990756, -0.321011372946736, -0.327496186964541, + -0.332935100197032, -0.337210821159841, -0.340764957868971, + -0.344471309726478, -0.350200335834943, -0.359118546374483, + -0.370034822401452, -0.380720425043658, -0.391386111115191, + -0.405489744771982, -0.426517829663356, -0.4515863447802, + -0.47214105896833, -0.486283695800159, -0.494657368387894, + -0.493180591169509, -0.488526532973842, -0.493612673006939, + -0.487074129054399, -0.462037004697464, -0.441250284304862, + -0.433965655842372, -0.43289375170273, -0.432017681554376, + -0.432680036052882, -0.431690070038684, -0.432013961376716, + -0.432337824056359, -0.428917215148655, -0.424442964929143, + -0.42352964189827, -0.423586070741076, -0.423870575429083, + -0.424793671860039, -0.4264687673622, -0.426459566103128, + -0.43366623408873, -0.432030473136651, -0.417083618104705, + -0.408210908138503, -0.408804895223365, -0.413048883176577, + -0.414637251051463, + -0.160475210249506, -0.135191237656181, -0.094589402804267, + -0.0969282843324468, -0.0994507023746897, -0.0995797386334086, + -0.0832012779193132, -0.0722870623012101, -0.0718653465813777, + -0.0703872899501928, -0.0662950409009142, -0.0617112896039126, + -0.0543109096152909, -0.0462553351046542, -0.0409804765603509, + -0.0407198285545745, -0.0446556904475438, -0.0503927231399396, + -0.0530878380426179, -0.0524604877498379, -0.0517627651974647, + -0.0528103239818663, -0.0574750360807205, -0.0628907625566083, + -0.0677403520818099, -0.0724253528043752, -0.0772296028160006, + -0.082104372803897, -0.0870886719711124, -0.0903463301403006, + -0.0961087768781802, -0.112062956584377, -0.130379354312283, + -0.138740721551879, -0.14114747738139, -0.14320019128251, + -0.147471344507625, -0.152026051321624, -0.156580858795191, + -0.160882483616463, -0.165107964809359, -0.170554835167611, + -0.171230957279882, -0.171002537269299, -0.173624859404963, + -0.175366484672972, -0.175495115504425, -0.175755209169126, + -0.176714495953056, -0.178027893176998, -0.178042900232309, + -0.179313508342273, -0.182029467117402, -0.188219704072175, + -0.194516843505899, -0.197256460969975, -0.19886605827372, + -0.203622149656447, -0.207964012892679, -0.208262358404335, + -0.203334655732254, -0.195151364207199, -0.19114672038113, + -0.192644277466467, -0.194616956763872, -0.198716096973626, + -0.204221559112098, -0.203743840512825, -0.197221197603912, + -0.192046985785693, -0.190532092798222, -0.190518802533012, + -0.192883439393126, -0.197041252878838, -0.200605243873458, + -0.203746839592577, -0.206713613742703, -0.208660983350875, + -0.209613174044444, -0.209911852308876, -0.209261345010474, + -0.207216422445087, -0.204930843249409, -0.204063191604601, + -0.205518005561105, -0.208621936905428, -0.210825896056736, + -0.210707641501142, -0.210484768846522, -0.211400447936421, + -0.212317467805277, -0.212542710688683, -0.213466935537883, + -0.216648272829973, -0.221016264545166, -0.224691899394838, + -0.227261630317609, -0.230673777102608, -0.232033954919972, + -0.233664716867993, -0.23436284696221, -0.234803688903726, + -0.23463969305318, -0.236367905473764, -0.246339255271421, + -0.264819038605665, -0.285965509162288, -0.304034745752978, + -0.315584227172262, -0.322545212584933, -0.327779617446514, + -0.332752885298222, -0.337899138146035, -0.343092886288085, + -0.348198441132915, -0.354063972202107, -0.361610352281008, + -0.370481951574907, -0.37938074364123, -0.38863324516468, + -0.401667612653331, -0.421761831339858, -0.445423361194052, + -0.466971983120114, -0.4864845059752, -0.498518201448576, + -0.498276445733101, -0.493412969067093, -0.494748001636683, + -0.488536270152155, -0.464636113746411, -0.442506024021096, + -0.437188189022017, -0.433208574110573, -0.432876293926124, + -0.433538653872151, -0.432308020059683, -0.432521513457946, + -0.431500692152645, -0.427026495024783, -0.422552247039416, + -0.41905051338032, -0.420740682128518, -0.422355788165817, + -0.425473800039625, -0.43079912246013, -0.433701141226025, + -0.440822339358911, -0.428951184412999, -0.409786420409789, + -0.406435445994867, -0.412071257814884, -0.417109347134434, + -0.417141988837356, + -0.165576399542654, -0.140292872306032, -0.0955835165332811, + -0.0971096341690566, -0.099632142153755, -0.100069836860941, + -0.085461942268295, -0.0736372491751007, -0.0735636429412832, + -0.071284057928351, -0.0682243609567636, -0.0626227558289493, + -0.0520905574345721, -0.0411608787211276, -0.0354755387482934, + -0.038221294260062, -0.0468575447256291, -0.0526217075554148, + -0.0546629887619844, -0.0530412719546777, -0.0522269703380113, + -0.0522411382193562, -0.0569190199110705, -0.0619118637185526, + -0.0668924651114832, -0.0718771617497086, -0.0768614603656971, + -0.0818458585530279, -0.0868301963697396, -0.091029119411969, + -0.0936774022662661, -0.108650778542052, -0.128891788639948, + -0.139637236576139, -0.142608013609017, -0.144532780559042, + -0.146457146981141, -0.150604999785953, -0.15515977132486, + -0.158707636907719, -0.162979410524799, -0.168961778325941, + -0.170011144589159, -0.171293216206662, -0.173974866043507, + -0.174943573763818, -0.173553024811352, -0.174175533759379, + -0.174865256292232, -0.176092642707885, -0.175861881097865, + -0.174857368682707, -0.174101866694178, -0.178275407260969, + -0.184600975194925, -0.189119301759267, -0.193835194576789, + -0.200196638486479, -0.204527848298001, -0.204669357604497, + -0.19980017004243, -0.191168884390221, -0.18672773804743, + -0.188104915151137, -0.190197009064365, -0.193621595297992, + -0.195693730314393, -0.191510564655164, -0.184006579941962, + -0.178496624225351, -0.177306412239516, -0.179330512833691, + -0.182605806070193, -0.185688867635022, -0.18889827192414, + -0.193290737845485, -0.197453865979171, -0.199726648089542, + -0.200203858407815, -0.199867060180241, -0.198703118422848, + -0.196567543261493, -0.194390833613997, -0.193618127249832, + -0.195519824348434, -0.199135092309081, -0.201355623814395, + -0.201517990355934, -0.201878144009976, -0.203682676662409, + -0.205862775742052, -0.20780537250964, -0.210455998433537, + -0.214931901881201, -0.220371436945069, -0.225365558129041, + -0.229265119699038, -0.233445801831478, -0.234619553883045, + -0.235395464582032, -0.235208327441951, -0.234956647379293, + -0.235053370243779, -0.238767339919042, -0.250251428761188, + -0.268732035918819, -0.288414170598065, -0.304678329198655, + -0.315225336238037, -0.321566695930672, -0.326158670263283, + -0.3310464250459, -0.337248666348294, -0.344089516621011, + -0.35043287693013, -0.35634515260115, -0.362694543352084, + -0.369600594103457, -0.376302323540518, -0.383172639115148, + -0.394532419702155, -0.414756129538779, -0.439649544436701, + -0.463909892807887, -0.486560654211496, -0.499688827263315, + -0.502397923305602, -0.499828300890203, -0.494128469761734, + -0.482667202617633, -0.462439935402754, -0.447045168737885, + -0.442873469557276, -0.435454228693709, -0.433407411666354, + -0.434423486940694, -0.434230762057198, -0.43302905973326, + -0.429609924571331, -0.42522580683548, -0.423591916135042, + -0.421601372241705, -0.421173987429713, -0.422115897767341, + -0.426690494924443, -0.433335730874328, -0.438991770697662, + -0.439248344408111, -0.42194476082316, -0.413314344979081, + -0.419429872336819, -0.422816168632693, -0.419302748931161, + -0.417377220455112, + -0.170678510475436, -0.145394080533306, -0.101467635802753, + -0.0972910141924479, -0.0998134262086661, -0.100559873278823, + -0.0878239525003165, -0.0750847844362579, -0.0745294902316748, + -0.0718356753262467, -0.0697036687639616, -0.0641795023734319, + -0.0524829700354067, -0.0411982232726492, -0.0379236444200841, + -0.0450334385035348, -0.0543910916431499, -0.0551397764563743, + -0.05493516553574, -0.0539450873911021, -0.0529382248345149, + -0.0505844082914103, -0.0539539784214791, -0.0608320175972413, + -0.0667145518389058, -0.0717084677866679, -0.0767473196680623, + -0.081812890052808, -0.0867268706886369, -0.0914808250808707, + -0.0941218845858487, -0.108685815422308, -0.129328459769075, + -0.140804370449627, -0.14384529048252, -0.146323320690051, + -0.14796342150554, -0.149809267497679, -0.153468237985877, + -0.156618944873827, -0.160448326272888, -0.167936662911077, + -0.170659847831946, -0.172007075696376, -0.173714475561705, + -0.174788719652468, -0.172915916256971, -0.172194118985167, + -0.174991716187243, -0.17515237196676, -0.174383402136137, + -0.172773587700784, -0.171379460890198, -0.174939866112447, + -0.180592542690174, -0.185569853610003, -0.191010406994913, + -0.196328857182576, -0.198436226970965, -0.197058659786478, + -0.192916781650483, -0.185945697493131, -0.181059963694618, + -0.180157901797349, -0.18023409245271, -0.180938510934076, + -0.179970854112252, -0.175718420838925, -0.170708145886739, + -0.166949035187456, -0.166274158192947, -0.168012275793207, + -0.170029975078788, -0.17157266337876, -0.174321394561826, + -0.179551622989817, -0.185339455154292, -0.188659918255689, + -0.188528107972132, -0.186517366620047, -0.184641741572552, + -0.183085552836614, -0.181693590878836, -0.18124925415053, + -0.182897466649328, -0.18631126954341, -0.189311056909381, + -0.19124769489509, -0.193252541719398, -0.196245748325543, + -0.199624161713513, -0.202985612494885, -0.206910146960206, + -0.211810612001247, -0.217879537171689, -0.224483528463697, + -0.230371982120329, -0.236400579695217, -0.238198692317733, + -0.238644835739195, -0.237731533236978, -0.237115998714451, + -0.238307036199812, -0.243647057327656, -0.255233070295552, + -0.272581987178152, -0.290836084039481, -0.304860340012108, + -0.31322031509614, -0.318486365748353, -0.32299209097679, + -0.328407801242795, -0.335804141478594, -0.344027357489861, + -0.351113952954399, -0.356999661600161, -0.362796089303576, + -0.368562412555216, -0.373661752747745, -0.379163887075929, + -0.390176928661769, -0.412177146497205, -0.440279518274208, + -0.467415016705926, -0.48974605800053, -0.50042734756526, + -0.503137309605527, -0.503035298272809, -0.498614158006878, + -0.488311216736111, -0.471146510783252, -0.450036737102897, + -0.441962361263823, -0.434675010812423, -0.432522315440197, + -0.434802607414203, -0.438236906871299, -0.432720691961476, + -0.430347138011442, -0.430422083098202, -0.427346736208408, + -0.425974028602279, -0.426958363979914, -0.427393919698499, + -0.430453194030803, -0.435754744175874, -0.441963366379238, + -0.437355594811357, -0.418331999714666, -0.417798534071103, + -0.427267599022804, -0.426476948675405, -0.418680069869586, + -0.415875489614848, + -0.175780217164837, -0.150496647505763, -0.108445390969259, + -0.0974722994646352, -0.0999948090543758, -0.101035911277719, + -0.0906359864772551, -0.0766159231527425, -0.0746933632244182, + -0.0727289772002262, -0.0720606854271821, -0.065542977969598, + -0.0538579122721594, -0.0444179842245174, -0.0451480986009151, + -0.0541951770738296, -0.0569805564173736, -0.0550532711743081, + -0.0539967184215386, -0.0534163486539649, -0.0512033996257374, + -0.0487674282027238, -0.0491016593624346, -0.056162005790484, + -0.0631637161718716, -0.0701654338361261, -0.0763546692313332, + -0.0813357447239756, -0.0863199449789048, -0.0914741182512079, + -0.0930263848345328, -0.106421677423202, -0.126345545007879, + -0.14028627152794, -0.145775152392867, -0.148017472396155, + -0.149634973597139, -0.151322796236492, -0.156085056749852, + -0.163365775947955, -0.16925898233104, -0.172662933588606, + -0.174189746499675, -0.173866212676442, -0.174436512628235, + -0.174980944169152, -0.173467201581749, -0.173550869342705, + -0.173610992596767, -0.173867542989659, -0.1731218636791, + -0.1688954303495, -0.168185669635701, -0.172827413673104, + -0.178780286706321, -0.183674844502158, -0.188079226704548, + -0.191063045855358, -0.190372801500168, -0.186942093954741, + -0.18274297119945, -0.17703690429778, -0.171232442339021, + -0.166802101381557, -0.163692550639961, -0.161861377753492, + -0.160219145371623, -0.158155082123097, -0.156066324823822, + -0.154110161196957, -0.153620387462243, -0.154465389453765, + -0.155700284278326, -0.157193727204226, -0.160301311714127, + -0.16596993288632, -0.17258993202319, -0.176671091843471, + -0.175999789369865, -0.172684970171675, -0.169828400461044, + -0.167983972869607, -0.167028302470936, -0.16720310422687, + -0.168921526479011, -0.172234152703602, -0.176069453572596, + -0.179931766073776, -0.183954439728027, -0.188389446854614, + -0.192781903912922, -0.197222646350271, -0.202256457958225, + -0.207780100369678, -0.214463276875081, -0.222237426436321, + -0.230000448914442, -0.238253032363576, -0.241873312926873, + -0.243245267654831, -0.242405415652394, -0.242105766668346, + -0.244236937137405, -0.249834682767181, -0.259740126004035, + -0.274551423989365, -0.290537449483324, -0.302509924752471, + -0.309301881630322, -0.314305007577103, -0.319744590172782, + -0.326235524251756, -0.334368708150803, -0.343048185243125, + -0.350244035242142, -0.356195324941662, -0.362544388151867, + -0.369117837125009, -0.374145675506917, -0.37866632852877, + -0.388505152877477, -0.41053269846995, -0.440795689695892, + -0.470361618733357, -0.492159739297128, -0.501060557706692, + -0.50293984158904, -0.502311540781207, -0.496711165557795, + -0.485456361514182, -0.470399891675915, -0.452133922706532, + -0.437743553556012, -0.431337804513148, -0.434554815615441, + -0.434060025653645, -0.432136088685378, -0.431198498255603, + -0.429646270103083, -0.43283764868603, -0.428539552700885, + -0.429578932955452, -0.432008343464964, -0.432671952454383, + -0.435543088524216, -0.438631324060112, -0.443165446232977, + -0.446000737302451, -0.435531159059702, -0.430496587580631, + -0.433452906329133, -0.428246500270749, -0.414109537490296, + -0.40639813311812, + -0.180882657823658, -0.155597999512787, -0.129912162029214, + -0.0976536314236676, -0.100176007975487, -0.101427500090314, + -0.0935699636869654, -0.0776249557623565, -0.0752128662381412, + -0.074823887721286, -0.0742991462284575, -0.0666854935442748, + -0.0554547102664209, -0.048876956675025, -0.054055082411928, + -0.0589374838163531, -0.0554401771030517, -0.0538741356765211, + -0.0536461888996464, -0.0523763106241383, -0.0497741933727837, + -0.0468493818489623, -0.0454136527206671, -0.0513681098992424, + -0.0583699647440838, -0.0653714961270759, -0.072372988325773, + -0.0793744734245755, -0.0860081658991234, -0.0911968675864699, + -0.0909216605967863, -0.101035601751245, -0.118450061194374, + -0.135700366926186, -0.148967843814842, -0.152114822218089, + -0.15395468258628, -0.159151941326141, -0.165656180090048, + -0.168178029040421, -0.170112941913496, -0.173205298001927, + -0.175038452086029, -0.174864172609529, -0.174845788702958, + -0.174207845354433, -0.172048194773679, -0.173410024808563, + -0.173573819118666, -0.171801083471618, -0.167338159600729, + -0.162367075573343, -0.164144990456559, -0.170064122591793, + -0.175751992119783, -0.179715574969821, -0.182252094193171, + -0.182708096752581, -0.179929182811436, -0.175315917679016, + -0.170417775436625, -0.164466586348076, -0.157494505699646, + -0.150451042675827, -0.144783267134175, -0.14150027166398, + -0.140374574811504, -0.140235354090087, -0.139933158644309, + -0.139120477573801, -0.138612923646022, -0.139063755536419, + -0.140724881712888, -0.14353442147552, -0.147610256296511, + -0.153167993550408, -0.159310429578821, -0.162914877269301, + -0.161691490737252, -0.158083692596908, -0.154654557642203, + -0.152368678482983, -0.151920095458834, -0.153050614820654, + -0.155435536000757, -0.15901373527047, -0.163436875177385, + -0.16855145111847, -0.174248772472302, -0.180169167395203, + -0.185654764345404, -0.191009830702895, -0.197005369487744, + -0.203463993933952, -0.2107495166776, -0.219042843194818, + -0.228124986800961, -0.238365256935234, -0.244977400732129, + -0.249021338334006, -0.250283791686171, -0.251064992267125, + -0.253244766795523, -0.257556090271534, -0.26485581579074, + -0.276468320016271, -0.289107137318417, -0.298699411016145, + -0.305237253467074, -0.311219398447374, -0.318085429545046, + -0.325426321666816, -0.333223575572314, -0.341027130998501, + -0.347620236102175, -0.353687117759721, -0.361643497504792, + -0.371302956460968, -0.378392090144007, -0.382056152938205, + -0.388914564585006, -0.407420931800805, -0.435027308358085, + -0.463578305027754, -0.485703323992511, -0.496504912724662, + -0.500228163145893, -0.498889484274944, -0.488564766724566, + -0.474629370792271, -0.463569308519066, -0.45088649809098, + -0.436004823299347, -0.433680165487483, -0.4366086443002, + -0.434918457896106, -0.433114475751658, -0.430829112189185, + -0.428887488447003, -0.42709289027936, -0.421802938239034, + -0.423741066516738, -0.427142212180274, -0.429789932698402, + -0.433126807502879, -0.436644003243515, -0.444365266471671, + -0.452785912991928, -0.453237960939264, -0.451500615245551, + -0.446236928432585, -0.432986161911132, -0.412659418131219, + -0.400076489200331, + -0.185721480368288, -0.160700574881248, -0.135417243019166, + -0.0978348912511491, -0.100357299962247, -0.101819398801311, + -0.0965859394290626, -0.0803011334037839, -0.0786053968133148, + -0.0784784600350155, -0.0759583230217972, -0.0683057683112799, + -0.0583394496989119, -0.0532020954833937, -0.0584100612151285, + -0.0571758110417832, -0.0538835397702409, -0.0533552167334481, + -0.0530221327825004, -0.0508276224615392, -0.0482006868814943, + -0.0444037343813439, -0.0431354524736283, -0.0465650242353921, + -0.0535761340488926, -0.0605777046527258, -0.0675791928547873, + -0.0745806556752733, -0.0815818604315876, -0.0904939641647515, + -0.0921594724385539, -0.0992458517239783, -0.113580952372631, + -0.131605411515339, -0.14813817078798, -0.154458353744655, + -0.15800252458366, -0.164053100735943, -0.166264261151482, + -0.168838619721996, -0.170520114216976, -0.172368859566169, + -0.174532957313282, -0.17482565257797, -0.173300958340046, + -0.172485160870502, -0.171015301124323, -0.171477883054757, + -0.168644594620876, -0.163278728280376, -0.158176417591844, + -0.156059686265684, -0.159562671739936, -0.165130005939988, + -0.16957934973049, -0.171974809788187, -0.172551695682739, + -0.171037865683963, -0.167149297021612, -0.162070135226316, + -0.156521190796189, -0.150272422599457, -0.143279399573063, + -0.135829072057681, -0.129374783504869, -0.125458743853033, + -0.124153160279033, -0.124250071777233, -0.12458543083164, + -0.124581848532496, -0.124430985645905, -0.12497036680263, + -0.12724093634908, -0.13100761619807, -0.135380720916209, + -0.139887222188753, -0.144286239567256, -0.146367056880489, + -0.144790027628461, -0.141532191913756, -0.138449152443223, + -0.13678101346046, -0.137461159897028, -0.14004227814751, + -0.143709731728071, -0.148004759772226, -0.153019779339785, + -0.158972687847853, -0.165647183619876, -0.172524012293087, + -0.179167866266529, -0.185594033119556, -0.19225287176067, + -0.199296035049421, -0.207004272793489, -0.215611465563403, + -0.225624613385994, -0.236986105629059, -0.246697766271615, + -0.253751585413071, -0.258131108229, -0.260999397834872, + -0.263572835811336, -0.26653760387896, -0.271245800087965, + -0.279664278641347, -0.289180793330712, -0.296719956241901, + -0.303497191815177, -0.310822567734774, -0.318459898127341, + -0.325579989402221, -0.331982425886077, -0.338018412333701, + -0.343644562730223, -0.350138662693863, -0.36047513296342, + -0.373974962369504, -0.384256687946063, -0.388151202742318, + -0.392064656501902, -0.404942015715462, -0.425989895332266, + -0.44844384060413, -0.467538562807912, -0.480873374369968, + -0.489259920271653, -0.49532614086537, -0.485528908038047, + -0.472008776726491, -0.461852045289377, -0.444310803440388, + -0.434499070479756, -0.437101407126071, -0.437542862915717, + -0.435060413985928, -0.432694163519085, -0.430612697320783, + -0.428414108741854, -0.426272425674486, -0.420737473884713, + -0.420536830306173, -0.423263089586698, -0.426460976598827, + -0.430873271035905, -0.435520371104405, -0.44209667676772, + -0.448179914190554, -0.450829501737837, -0.451235276385241, + -0.442424307204478, -0.428554657423484, -0.416349648737816, + -0.402998116741806, + -0.189671843206964, -0.165802874639077, -0.140520713546731, + -0.100697611850733, -0.10053855011543, -0.102211511347709, + -0.0978225716955391, -0.0857851814338789, -0.0818645939217746, + -0.081279616985819, -0.0764982230630031, -0.0721933584392633, + -0.0650205685242706, -0.0572526791405048, -0.0542224517705068, + -0.0533600823103477, -0.0530214114333057, -0.053045875801602, + -0.0518811437276083, -0.0492541238587023, -0.0466271993925012, + -0.0420290725426191, -0.0410151339575622, -0.0410636405797866, + -0.0487821756548866, -0.0557838366257979, -0.062785400797566, + -0.069786753127764, -0.0787565302274917, -0.0918385515002764, + -0.0957609264797757, -0.10264325898492, -0.114154197997227, + -0.12958636049379, -0.146202758991636, -0.157248989730605, + -0.160929725593316, -0.165589794443154, -0.167109091462982, + -0.169499264093405, -0.171199671193698, -0.171830866329673, + -0.174035709710606, -0.174770031461932, -0.174723441298764, + -0.172731355435261, -0.169861077897149, -0.165932899812248, + -0.159841920946772, -0.154118299720141, -0.15065277806742, + -0.150187419101091, -0.153094232665314, -0.157009120160319, + -0.159803546091935, -0.160739323595931, -0.159951641926783, + -0.157284437411868, -0.152883534864534, -0.147484051930888, + -0.141692728471087, -0.135976037312951, -0.130305691940087, + -0.124295472365133, -0.118777784897304, -0.115120466340304, + -0.113392244724281, -0.112686383937036, -0.112684344071728, + -0.11312507889015, -0.113675106000302, -0.114402795677051, + -0.116366734949944, -0.119502472684858, -0.12267196760292, + -0.125087142021337, -0.126949455566363, -0.127637010149719, + -0.126663162089378, -0.124795403104589, -0.123111060740931, + -0.12298265425773, -0.125481701876178, -0.129674014761358, + -0.134456314052912, -0.139418269239752, -0.144891862249611, + -0.151359742829736, -0.158537270249133, -0.16600154074743, + -0.173658912164215, -0.181257739435207, -0.188404226420578, + -0.195786755608881, -0.204074755881102, -0.213151879469271, + -0.223731867128725, -0.235559810879132, -0.246727188663634, + -0.255826625867107, -0.262950074191516, -0.268471548371013, + -0.27273064998032, -0.275528737260289, -0.278122735879598, + -0.283117213582334, -0.289732923370708, -0.295993789351628, + -0.30328391254357, -0.311720147772416, -0.319736044149838, + -0.326099324124175, -0.330928321784408, -0.335264476159613, + -0.340033718231004, -0.347426624943403, -0.360137436343258, + -0.376266011840097, -0.389026975725342, -0.39433416838671, + -0.396917461190462, -0.404462023185682, -0.418097218669529, + -0.432406197721014, -0.44468814796075, -0.457545957941414, + -0.470904818031507, -0.487340287282988, -0.492560126298102, + -0.480410675571429, -0.466655131477205, -0.45137086216851, + -0.444118779843224, -0.440007198296478, -0.436847282113678, + -0.434505950664953, -0.432312195552624, -0.430111991169428, + -0.427911748355412, -0.426621671186367, -0.420152672260727, + -0.419982138610441, -0.422036163301604, -0.425288111701979, + -0.429428198373736, -0.433706635436588, -0.437756391932635, + -0.441047414689685, -0.434457457556283, -0.423310272191681, + -0.416864882889308, -0.409386294499926, -0.401819095713457, + -0.390340492006128, + -0.190365816631471, -0.170905970677354, -0.145622540920968, + -0.10048676773801, -0.100719826535765, -0.102603882344064, + -0.0989352591912056, -0.0917802790401416, -0.0853604612593759, + -0.0830083102226185, -0.0784668387784265, -0.0749984737865955, + -0.0693623443062364, -0.0590000957248319, -0.0483330007744783, + -0.0457158346926822, -0.0506216416820447, -0.0525704701515526, + -0.0503076628408788, -0.0476806196440394, -0.0450537756040855, + -0.0418323294429927, -0.0385527084179312, -0.0386025978915298, + -0.0439882081826909, -0.0509901193398183, -0.0579915623548887, + -0.066878628471049, -0.0794456805161621, -0.0911223236152426, + -0.0988883592345761, -0.109391433926621, -0.119809370817781, + -0.132025823192162, -0.14756492844548, -0.160978981337839, + -0.163488576631902, -0.166690351441363, -0.16904583925284, + -0.17020558232114, -0.172046788457874, -0.172017823110209, + -0.173230620502734, -0.17360927102428, -0.172032806873987, + -0.167949335697086, -0.163173052392885, -0.157206047351155, + -0.15029748842499, -0.145004833866308, -0.142206805710776, + -0.141726470426707, -0.143180903468734, -0.145260419144076, + -0.146480078678462, -0.146216640100273, -0.144536914482427, + -0.141245498700088, -0.136664012678989, -0.13144930468423, + -0.126134201681258, -0.121409228773452, -0.117448820543042, + -0.11371021798164, -0.11039293471559, -0.108237672499604, + -0.107057807682868, -0.106022281841861, -0.105315526006583, + -0.105335461266995, -0.105876119759577, -0.106342741638452, + -0.106917426905137, -0.107756593902901, -0.108480245620706, + -0.108507834122562, -0.108490191535491, -0.108986033867426, + -0.10967298743426, -0.11016343962825, -0.110827499593392, + -0.112941915032948, -0.117286613923128, -0.122682373403615, + -0.128128965042147, -0.133441297240946, -0.139111774483535, + -0.14561201683389, -0.153039522643974, -0.16091893113665, + -0.169215942909306, -0.177620320057758, -0.185357233466672, + -0.19347539086674, -0.202568005320855, -0.212089472686422, + -0.222646081803152, -0.233954439332294, -0.244812413202764, + -0.254810755747464, -0.263952834529845, -0.271896440821929, + -0.278335951595406, -0.282504659015798, -0.284796759337593, + -0.28733264900103, -0.2913054978239, -0.29679995116246, + -0.304269604857409, -0.312862717524749, -0.321036442757668, + -0.327213368792217, -0.331296625489164, -0.334650008174843, + -0.339019427627786, -0.347236847031611, -0.361198906823892, + -0.377545087174045, -0.390763348199847, -0.39803754254043, + -0.401563515795602, -0.406054767699583, -0.414072663556624, + -0.422684401732381, -0.430335002103448, -0.440888064777784, + -0.455565822296565, -0.47680318495329, -0.494762072376836, + -0.487690635906908, -0.473392258963273, -0.458453200242205, + -0.446957612406179, -0.439806073429349, -0.43656682111257, + -0.434577606245748, -0.432109748037695, -0.429762774531531, + -0.427435074269103, -0.423302638350613, -0.418980654509472, + -0.418250227977728, -0.420097984307598, -0.425513500498192, + -0.430688545674283, -0.434662605897948, -0.439523382362805, + -0.440218558871024, -0.422029882456886, -0.394149804588304, + -0.384860540671535, -0.381779183566128, -0.378096081963959, + -0.373848226693655, + -0.190372204268868, -0.176008692413313, -0.150725735425988, + -0.106709330830182, -0.100900992988876, -0.102996502068978, + -0.100196116283006, -0.0947372059455666, -0.0847597165700366, + -0.0791625809221269, -0.0779779214625973, -0.0770227981316067, + -0.0721333192228903, -0.0616399487360159, -0.049281431289975, + -0.0424787531910755, -0.0467914541806252, -0.0511450098829008, + -0.048703091687393, -0.0461037833673657, -0.0434802940274108, + -0.0408534906276474, -0.035502248010766, -0.036095062655314, + -0.0387099147167968, -0.0461961298708745, -0.0550244184337644, + -0.0666439206697439, -0.0771186174720246, -0.0951487485322727, + -0.105709077229944, -0.118431751175382, -0.128013153402464, + -0.137127980190688, -0.14939520620554, -0.160010727749934, + -0.164345221087145, -0.168582103465833, -0.171141692356617, + -0.17142989229563, -0.171066474099128, -0.172141574530605, + -0.171186197499642, -0.167959479016228, -0.163834032292072, + -0.159085080073357, -0.153528127954685, -0.146934183694819, + -0.139915782263172, -0.134359558199019, -0.131163929949297, + -0.130062060986909, -0.130444293962781, -0.131104824389308, + -0.130845456039096, -0.129352337784002, -0.126812949775881, + -0.12321588860192, -0.119132790321329, -0.115031937395058, + -0.110884924752715, -0.107203650210027, -0.104564303677815, + -0.102857897759135, -0.102055358597262, -0.102214235941753, + -0.102659974407203, -0.10224739618705, -0.101044256889906, + -0.100046710606587, -0.0996658687049533, -0.0992426051563166, + -0.0981090201798502, -0.0962045914762095, -0.0943857077178918, + -0.0929424580250692, -0.092584542743124, -0.0939612984419071, + -0.0965250775895445, -0.0994068607301388, -0.102575200869711, + -0.106861662154121, -0.112675432273245, -0.118909879772584, + -0.124724861680253, -0.130253538915249, -0.136002894724606, + -0.14227584707077, -0.149598118112382, -0.157797288241588, + -0.166565972449003, -0.17562820883545, -0.184530144331679, + -0.194060438246145, -0.2039658216242, -0.213454687264025, + -0.223013359228364, -0.232804264150622, -0.242410178264974, + -0.252295444390299, -0.26225651193315, -0.271456155692633, + -0.279191760581851, -0.284887955729396, -0.288639938360716, + -0.29156057348326, -0.29488759270128, -0.300104547448868, + -0.307335096776592, -0.315410307967313, -0.323292363200904, + -0.329670481283299, -0.333988267637652, -0.337137610483243, + -0.341307590211358, -0.349693882379124, -0.36303235156186, + -0.377521706097346, -0.389735397723898, -0.398433745703845, + -0.404089976383783, -0.408142428819747, -0.412874026005237, + -0.418410347539709, -0.424515387104676, -0.434505798714976, + -0.449889645449758, -0.468537949944769, -0.489072889045406, + -0.490065848338091, -0.476670307991748, -0.461097689736611, + -0.452780394113447, -0.443864748069225, -0.43746708312537, + -0.434850931625045, -0.432172201770789, -0.429130285522282, + -0.425029492441142, -0.418192911758017, -0.418245957259498, + -0.41834794064342, -0.422521070140253, -0.428237291999951, + -0.434954222147815, -0.439532901059584, -0.443934484154169, + -0.441447742483941, -0.418107786990063, -0.387918642219124, + -0.377362528399133, -0.37076860625248, -0.367084701215145, + -0.366300448300379, + -0.193163642656662, -0.181112082640252, -0.155828923175522, + -0.119554506576831, -0.101082187770306, -0.103389232038394, + -0.100316383825361, -0.101347806405093, -0.0972960795020852, + -0.0922758895936109, -0.088863223180373, -0.0819306360685576, + -0.073640011033541, -0.0637895014671239, -0.0529540509403301, + -0.0452493971650274, -0.0465604898479043, -0.0526433020814407, + -0.0438698423176142, -0.0420348163977593, -0.04067081500985, + -0.0389400999684262, -0.0327762326256389, -0.0333497365995154, + -0.0342463362320989, -0.0419271170879443, -0.0511000574868872, + -0.0620187853061483, -0.0853202066417606, -0.0996425804752579, + -0.115137620256368, -0.128490604332193, -0.137923813831562, + -0.145414374793385, -0.154339391314059, -0.161662850310671, + -0.165282236305446, -0.169170323170786, -0.170079894194175, + -0.16870847045979, -0.167028421639456, -0.164817413186659, + -0.161860645972002, -0.156993041121185, -0.151651167640094, + -0.146840521922714, -0.141591777457325, -0.135175825500349, + -0.127978267756553, -0.121816319276392, -0.117904342967507, + -0.116136009428096, -0.115925733314711, -0.115684919023571, + -0.114126446215631, -0.111389008295908, -0.108259383752005, + -0.105238150808623, -0.102736452013346, -0.10051406238792, + -0.0979366018424979, -0.0953069301332024, -0.0936666649603929, + -0.0934862356027863, -0.0946689507790323, -0.096919153010469, + -0.0991254147462016, -0.099666943601121, -0.0983271634944739, + -0.096439422412985, -0.0949055269575582, -0.093293462613548, + -0.0908788678007264, -0.0874144822847586, -0.0843278811755042, + -0.0827719971180851, -0.0830383725474872, -0.0853647068425144, + -0.0891277325423962, -0.0935475882453968, -0.0982249028180263, + -0.103832752175747, -0.110641090888429, -0.117660066798055, + -0.123890631917384, -0.12968496726255, -0.135485808712913, + -0.141429197876634, -0.148102437442099, -0.156122978619086, + -0.165395776983113, -0.175527808179599, -0.186105550269691, + -0.197320367354375, -0.207864474244322, -0.217084054255633, + -0.227668390970478, -0.233624094727428, -0.242346628039122, + -0.252163919855742, -0.262433040605772, -0.271683304068101, + -0.279350605339566, -0.285803035211908, -0.291122915457737, + -0.295665354534723, -0.299816479660245, -0.305171685704814, + -0.312020211693488, -0.31952742373628, -0.326863088614372, + -0.333379381233337, -0.338373121981839, -0.341982698192452, + -0.346075341884639, -0.353886150399655, -0.365274952616677, + -0.377054401564521, -0.387539869777771, -0.396343923491337, + -0.403679205815247, -0.409057371320944, -0.41315246043513, + -0.417606838455986, -0.423303001842351, -0.431541875880583, + -0.443558243634722, -0.455893916550628, -0.473033142039666, + -0.48856699330268, -0.4851666536637, -0.472006257819362, + -0.463364910845935, -0.453819011113973, -0.440643622602529, + -0.431987820281652, -0.428840455947514, -0.425070718480541, + -0.417273413866787, -0.415569328289603, -0.418995356328158, + -0.422729961871645, -0.426522945774613, -0.432179651888746, + -0.437874172167691, -0.440120934324212, -0.43707500262, + -0.427014837061964, -0.405675302202971, -0.389803077804308, + -0.383357614444632, -0.375210473546036, -0.369236180460705, + -0.365220865833433, + -0.180652956998712, -0.186215677684315, -0.160932056116803, + -0.123493780070976, -0.101263375968534, -0.103771797789083, + -0.100008876426912, -0.0876282265456125, -0.0753293661327453, + -0.0982209847179601, -0.109998787371876, -0.0940250409753294, + -0.0792110648444236, -0.0691297841919709, -0.0597282659165946, + -0.0510016924387661, -0.0498203218328008, -0.0553014982568284, + -0.0467625188397925, -0.0387322695117862, -0.0405558240922755, + -0.0487685746546369, -0.0558034117647426, -0.0577386516768792, + -0.056073761572545, -0.0560761586661545, -0.0595651820306717, + -0.0729889430434475, -0.090977306682802, -0.106111287028801, + -0.120890742984458, -0.134394407847919, -0.144733068970288, + -0.152485822514595, -0.15940322223393, -0.165167350164742, + -0.165766649045176, -0.16658517536617, -0.16594968503512, + -0.162489669363306, -0.156379224210559, -0.151878515836518, + -0.148499551952023, -0.143456880271457, -0.137415488844487, + -0.132423060662053, -0.128237224068639, -0.123018574834011, + -0.116160455795103, -0.109687232306111, -0.105184049016011, + -0.102715815084577, -0.101849515805962, -0.100929021908266, + -0.0986297677082886, -0.0953254581174388, -0.092296998658281, + -0.0904330916772441, -0.0897404812819844, -0.0894080923161669, + -0.0883622954519509, -0.08688864325468, -0.0862816723631013, + -0.0870913702671357, -0.0893229465941542, -0.0927689519590044, + -0.0960859642024008, -0.0973447765298878, -0.0962118185245941, + -0.0940237747349213, -0.091608334820526, -0.0889133282826995, + -0.085786273438604, -0.0820816370643565, -0.0790420241064669, + -0.0781017630322208, -0.0790748097119797, -0.0818465725074319, + -0.0861051377456223, -0.0911897306925919, -0.096605167482699, + -0.102793378005939, -0.110067548127302, -0.117693407817775, + -0.124525531727156, -0.130647481829416, -0.136388607178648, + -0.14193732051367, -0.147985828646751, -0.155680853450788, + -0.165413547120272, -0.176786129046019, -0.188982716891732, + -0.201519288825325, -0.212639248963725, -0.221833424802533, + -0.231003968948599, -0.236550163464034, -0.244790684237787, + -0.254488489017783, -0.264407527673231, -0.272865318644966, + -0.279981608973424, -0.286617314990624, -0.292802018296675, + -0.298575300529186, -0.303706364103546, -0.309566720681353, + -0.316633826844407, -0.324222312556612, -0.331759549899195, + -0.338907268420119, -0.344717557930881, -0.348901844582092, + -0.352785882995629, -0.359390772054816, -0.368643159631195, + -0.378652088855034, -0.388094802551833, -0.395848517458999, + -0.402975766469449, -0.409569490033499, -0.415050032510176, + -0.419688300364174, -0.424759492134274, -0.430946881676549, + -0.437862289733138, -0.445051047782355, -0.45739268129064, + -0.479585676593808, -0.491987085485993, -0.486090771725815, + -0.477133885758774, -0.468984099791817, -0.452177690313383, + -0.431080262426106, -0.420016897945422, -0.414577404088379, + -0.412112754933894, -0.413542427725846, -0.416713314942268, + -0.421780179648601, -0.427804536186871, -0.43527155873187, + -0.437392338872306, -0.433480599136017, -0.424642423753216, + -0.414298467169674, -0.403859833218948, -0.395907074432145, + -0.389457621109087, -0.386194171151283, -0.383046521909082, + -0.373377277791229, + -0.168657394315446, -0.191319064498219, -0.166035731076811, + -0.139364077878176, -0.101444461718923, -0.103966752698517, + -0.0996999445080263, -0.0702107299282474, -0.040073928150531, + -0.0397108998920511, -0.0819784899594233, -0.0967220519839655, + -0.0955615824712747, -0.086503720794568, -0.0751156717740734, + -0.060297175651228, -0.0522222734489871, -0.0542666927860256, + -0.0582735240916381, -0.061260471177596, -0.0657421877855482, + -0.0705350899482583, -0.0723558590414172, -0.0724468243017602, + -0.0723689457010948, -0.074688021012285, -0.0812292526440315, + -0.0903060107688943, -0.0961340103663273, -0.104241849544851, + -0.116690714569791, -0.129290120913233, -0.140061270788124, + -0.148348088610084, -0.153979890933961, -0.157037543108145, + -0.157769861335426, -0.156937720340532, -0.153216989401117, + -0.146945210219309, -0.141068835330881, -0.136751799116097, + -0.132629190110038, -0.12679925222021, -0.120311057778568, + -0.115795397222546, -0.113725275109172, -0.111227313420964, + -0.105949156595675, -0.100085509015166, -0.0956833996889168, + -0.0928697812530537, -0.091395012707192, -0.0898021177197625, + -0.0871757436542707, -0.0841429004902169, -0.0819210885091543, + -0.0810348251900309, -0.0812675214038837, -0.0818715858245843, + -0.0819148828077294, -0.0815344939668605, -0.0817930023092962, + -0.0830908476646764, -0.0856259718243747, -0.089468622912627, + -0.0932433970614074, -0.0950402928554935, -0.0944833709338594, + -0.0925124777941463, -0.0895946436643985, -0.086145063834534, + -0.0826976217038482, -0.0792485970034622, -0.0768244823071987, + -0.0766002521486217, -0.0779531485218821, -0.0809264699759338, + -0.0854819777892965, -0.090967898127571, -0.0967792845144383, + -0.103016921481441, -0.110251091206403, -0.118118642878142, + -0.125295246606373, -0.131549244997159, -0.137155421790122, + -0.14245357809025, -0.148384639616079, -0.156309887750102, + -0.166460647301101, -0.178443899476715, -0.191591154500557, + -0.205195064704012, -0.217192715591072, -0.226980472429683, + -0.23577673236752, -0.24140963351396, -0.249295829819122, + -0.258503933246785, -0.267433492553619, -0.274946830589606, + -0.281619638058956, -0.288227327182618, -0.294494956124142, + -0.300759991802742, -0.306418238563509, -0.312472791564874, + -0.319338164421056, -0.327201901266726, -0.335826655412142, + -0.34401222256905, -0.350662727878568, -0.355527917343034, + -0.359711635411697, -0.365733265663887, -0.374248395028794, + -0.384839891279582, -0.395085164612706, -0.401510635555874, + -0.406262688434299, -0.411729121097732, -0.417700193856385, + -0.423131537096108, -0.427725301175926, -0.431940443629773, + -0.435896140993961, -0.44067517827723, -0.450005433772985, + -0.469047356930375, -0.487260304305128, -0.485181316440758, + -0.472627840028422, -0.456599943967531, -0.437118644399659, + -0.421559393078874, -0.412881567044493, -0.409256812596248, + -0.410751356797793, -0.412730286402607, -0.415490669607926, + -0.421119967576174, -0.429392480600613, -0.436168814163457, + -0.434020276918984, -0.427198401523327, -0.422705895885109, + -0.4202166167066, -0.416894463585726, -0.408968060991209, + -0.398643085549122, -0.39999149893515, -0.400688669703491, + -0.383609564482368, + -0.179055540990181, -0.196422940161963, -0.171139339291949, + -0.145856635731595, -0.101625534268702, -0.104147834143307, + -0.0993897011432643, -0.0534678614621403, -0.0252819919732154, + 0.0142578203572124, -0.0120511494586684, -0.0589418922090341, + -0.112093607407544, -0.114592352551236, -0.0978039947546225, + -0.0735455511002835, -0.0559760174134768, -0.0540408513331801, + -0.0589758682948644, -0.0640690757362827, -0.0681173847484344, + -0.0704092820404575, -0.0719781731840339, -0.0742394323956044, + -0.0777623440591636, -0.0821508743528824, -0.0857653222414322, + -0.0876951766338659, -0.0896494263198881, -0.0963828475984545, + -0.106494101110975, -0.117190337912652, -0.127256288769209, + -0.135628134989257, -0.141099503890582, -0.142792518333073, + -0.141229454191751, -0.137860055173979, -0.133010660501075, + -0.127348124534373, -0.122961050315835, -0.118680613181896, + -0.113254864491527, -0.106371625317495, -0.0996964896184199, + -0.0962936242369942, -0.0970849686195042, -0.0984629829698417, + -0.0963910125171956, -0.0925680889102563, -0.0893722889169657, + -0.0868778732653536, -0.085057100224845, -0.082839046097515, + -0.0800926365089331, -0.0776627749357385, -0.0762418377386389, + -0.0758893386163928, -0.0762906060428931, -0.0768867744664656, + -0.0772432249364911, -0.077706722883274, -0.0788397918061492, + -0.0806829084251959, -0.0833196822905419, -0.0868297451347606, + -0.0902860062410091, -0.0923912645951213, -0.0925759641466672, + -0.0911482807012663, -0.0882935451584778, -0.0847833184814162, + -0.0814502051310209, -0.0784251932123856, -0.0766389517992847, + -0.0768648734477788, -0.0784177733653866, -0.0814309974311277, + -0.0861171492616843, -0.0919398645205507, -0.0980729641046634, + -0.104288539914416, -0.111203141321153, -0.118749335047717, + -0.125724782550729, -0.131757727850579, -0.137090023386038, + -0.142252458420014, -0.148459579044309, -0.156874556090954, + -0.167507994951078, -0.179865511042976, -0.193464100670454, + -0.207900159716497, -0.220977964201417, -0.23177395808167, + -0.240813385668353, -0.246793050288529, -0.25411386302031, + -0.262242834642401, -0.269994444593858, -0.276835560047007, + -0.283314166877182, -0.28987354649386, -0.296167813959087, + -0.302535964581704, -0.308377660885052, -0.314529311772284, + -0.321236498173932, -0.329523876206056, -0.33919243556467, + -0.348551661890009, -0.356320749999696, -0.362153216274336, + -0.367205500548206, -0.373539649697995, -0.382496438379372, + -0.394327489742041, -0.404868811717586, -0.410541606065577, + -0.413336035155086, -0.416460490675124, -0.420982723623611, + -0.426056045117346, -0.429952234109044, -0.432485519715208, + -0.434945836210592, -0.43977295640265, -0.450377658235989, + -0.467332551925613, -0.482266401154342, -0.473772756319465, + -0.447043757030662, -0.429759426211397, -0.418572532018198, + -0.411003230554404, -0.407824472356815, -0.408937847902016, + -0.410042637716248, -0.412224016992303, -0.416364284532733, + -0.42293600105928, -0.431436972613116, -0.435498809470273, + -0.431163394733351, -0.428647831667205, -0.430346147057041, + -0.432001974231648, -0.430569138210685, -0.420086800310784, + -0.408617100070438, -0.411344326997006, -0.409107950893401, + -0.38483334135799, + -0.19144659352409, -0.20152712669947, -0.176242982086036, + -0.150960844009729, -0.107300173527667, -0.104328914932642, + -0.0990779585383803, -0.0369306826610259, -0.0110367782358229, + 0.0297246284177086, 0.0397837977315068, -0.0280654027768045, + -0.11009987312756, -0.12732330157181, -0.113019566719139, + -0.0836820272575268, -0.0580986146136545, -0.0520622984977016, + -0.0552935642941247, -0.0590735384625777, -0.0616266780369766, + -0.0626253080250964, -0.0624338264979346, -0.0650286402833492, + -0.0700986581684395, -0.0745403435472965, -0.0757658011074594, + -0.0756757074125858, -0.0783168529495048, -0.0843140778879778, + -0.09213638489996, -0.101065202527394, -0.109989495906213, + -0.118178235145846, -0.123723985886875, -0.124548265970054, + -0.12113596318029, -0.115740990660852, -0.109949886437259, + -0.104898708661428, -0.100933076487086, -0.0961304477668851, + -0.0898633477988239, -0.0825465856646727, -0.0762386856869735, + -0.0741975113482732, -0.0773155703776088, -0.0821264083123541, + -0.0843668591296137, -0.0840744548007899, -0.0830942904463125, + -0.0819244128662403, -0.080525433896101, -0.078359992433425, + -0.0758282979291911, -0.0738910193943393, -0.0729541595936327, + -0.0727643944967259, -0.07286253569815, -0.0730384805240031, + -0.073446947093108, -0.0746637970383664, -0.0767157204938388, + -0.0792531961937459, -0.0821688447352798, -0.0851322838424955, + -0.08761388228713, -0.0893485938575144, -0.090076030577197, + -0.0894929936060465, -0.0874029584838116, -0.084476216760837, + -0.0816746615646131, -0.0792774172962024, -0.0781293289442011, + -0.0787064922439004, -0.0803063137945068, -0.0831517988751621, + -0.0877241797541678, -0.0937246631879139, -0.100223065486165, + -0.1065528431925, -0.113020693155307, -0.119889587639106, + -0.126440518361255, -0.132087123858972, -0.137061345313651, + -0.14205051043261, -0.148318388603486, -0.15704420344791, + -0.16821980249393, -0.181205058445945, -0.195428256452598, + -0.210306902960556, -0.224095329071494, -0.235871129224967, + -0.245148632453049, -0.251704538188555, -0.258157960707647, + -0.26490385015332, -0.271510571687699, -0.277937578812362, + -0.284409271259253, -0.291130854065228, -0.297755224246006, + -0.304235795499577, -0.310165096668832, -0.316651627978907, + -0.323543858056429, -0.331895293258782, -0.341788317894968, + -0.35201045683335, -0.361300228128077, -0.368668065914085, + -0.37499477919798, -0.382089443002797, -0.391705108436694, + -0.403536865175434, -0.413278147055509, -0.418840270778974, + -0.421502804035741, -0.423386897581444, -0.426244003977819, + -0.429725026208694, -0.431978111962274, -0.433032104601559, + -0.435386907231546, -0.441858796551734, -0.454188137825399, + -0.467128185995936, -0.475696515188264, -0.466790576635077, + -0.440762613473601, -0.423060026126119, -0.413541086755961, + -0.40854347098403, -0.407271189337758, -0.410731014454437, + -0.411453811995142, -0.413845201354894, -0.418722432760112, + -0.425613995166764, -0.433596635878363, -0.435677050499477, + -0.433079997104681, -0.433908282506183, -0.436743116395106, + -0.43967147788354, -0.439507242830669, -0.428361188156141, + -0.418449750471695, -0.420039501509965, -0.413175320272667, + -0.386330985296522, + -0.203839133775581, -0.206076709973993, -0.181347535545825, + -0.156064696941322, -0.107295738971057, -0.104509960297415, + -0.0987659022690163, -0.0221964191132071, 0.00320775071737065, + 0.039805965707738, 0.0167300936091962, -0.0450731682730723, + -0.1048012520312, -0.127508210144969, -0.118110597750627, + -0.0852110227878753, -0.0545371228136602, -0.0475082506932049, + -0.0484528333649209, -0.048842167032305, -0.0477494448029126, + -0.0454512211688698, -0.0436611596287053, -0.0452641976829935, + -0.0494068180979303, -0.0533600387853893, -0.0552012254915362, + -0.0572360989965803, -0.060962516167226, -0.0658887013036127, + -0.0724421005782349, -0.0800349493077037, -0.0875058402184472, + -0.0944158499658722, -0.0989474510578846, -0.0991231171377424, + -0.0954056906096968, -0.0896055153108036, -0.0834729341806651, + -0.0782475195598365, -0.0740834158801282, -0.0693619518496804, + -0.063607498115262, -0.0576339785555921, -0.0535212435640798, + -0.053318773974965, -0.057267540024217, -0.0633983385552276, + -0.0688645115956367, -0.0725933499350295, -0.0747613007302451, + -0.0756945676863565, -0.0756838540116767, -0.0746106047543878, + -0.0728254103387933, -0.0713001718966612, -0.0705150054533087, + -0.0701061067483203, -0.069686063667571, -0.0694847606679913, + -0.0700864468566031, -0.0720902246602918, -0.0750537887494578, + -0.0783165763036752, -0.0815090270624118, -0.0840475491983976, + -0.0855678733851411, -0.0866161459526857, -0.0874544574468233, + -0.0876779237780975, -0.0866651092953562, -0.0845894697522768, + -0.082516140934958, -0.0808613462565656, -0.0804791645448634, + -0.0814521154450254, -0.0830342570780827, -0.08561373164705, + -0.0900439687310827, -0.0962952157242586, -0.103141902554595, + -0.109632909709507, -0.115873763460019, -0.122254244620168, + -0.128342537220364, -0.133507340900197, -0.138010703240831, + -0.142742065679894, -0.14891251578001, -0.157826431318823, + -0.169488250172823, -0.183184307312183, -0.197987969800954, + -0.212913053457954, -0.226909524350052, -0.239403287114758, + -0.25045685401201, -0.255599423532936, -0.261075353203826, + -0.266445149427097, -0.272139003244193, -0.278311170760325, + -0.28491300096009, -0.2919481206444, -0.299149911305795, + -0.306174987636377, -0.312681368045904, -0.319631980036565, + -0.326509227528612, -0.334211341722869, -0.343532719149605, + -0.354063049964432, -0.364544381217948, -0.37345261189638, + -0.381058992129759, -0.388833087835828, -0.398251223306942, + -0.408674070924701, -0.417735942957453, -0.423971863126144, + -0.427658899465833, -0.429739382673287, -0.431615640313732, + -0.433242278311258, -0.43374077631337, -0.43438032758372, + -0.437800856193251, -0.445231151132084, -0.456523326541141, + -0.466547678458442, -0.468855460787848, -0.458684321691891, + -0.439960460629955, -0.425565554396328, -0.417087256525775, + -0.41347284356669, -0.413228470262242, -0.414521824621164, + -0.415958991683738, -0.418462217667921, -0.423007326433005, + -0.429438024009902, -0.43616228294486, -0.437665842551881, + -0.436048479025036, -0.435799264572888, -0.437001731525187, + -0.441450083241068, -0.444460522876567, -0.437804291000682, + -0.430330353385135, -0.427676205709267, -0.418245632131535, + -0.395136160496163, + -0.21623366216784, -0.209914039655721, -0.186451714145554, + -0.161168707547311, -0.114477266395009, -0.104690966907246, + -0.0984528442776136, -0.0109544856929759, 0.0174522705367414, + 0.025636982293495, -0.00815913099570776, -0.0616183085671644, + -0.102675759430678, -0.123977344646794, -0.114201149475998, + -0.0762899647637909, -0.0437859948592391, -0.0362710142063387, + -0.0342416878468033, -0.0311616469141721, -0.0270143095811769, + -0.0231379542262083, -0.0210593310395469, -0.0213956748027269, + -0.0237421987169704, -0.0268893879502806, -0.0297223055423352, + -0.0329404880492714, -0.0363700884378063, -0.0404851346761789, + -0.0465073310904993, -0.0532702739066539, -0.0590732262421743, + -0.0636996360418952, -0.0664269489226227, -0.066410707441696, + -0.0640222061200623, -0.0596391185971632, -0.0539561138898513, + -0.0486281109868409, -0.0449148024514681, -0.0414442445151915, + -0.0378233588708489, -0.0352074216096818, -0.0350753239672687, + -0.0377949347809302, -0.042785633862598, -0.0491955491699083, + -0.0557407093522548, -0.0615166676446666, -0.0660371670674426, + -0.0693451109559605, -0.0710080929914849, -0.0710232544865308, + -0.0700040170609143, -0.0688479482723161, -0.0679919192616495, + -0.0671908231295522, -0.0664227417587481, -0.0661592714111972, + -0.0670461392010302, -0.0696159461842495, -0.0733306728768371, + -0.0772368938355364, -0.0806120993364961, -0.0828876064724262, + -0.0839897803471788, -0.084635478599843, -0.0853746205108583, + -0.0859799299794892, -0.0856821261201277, -0.0844030886335006, + -0.083097549713152, -0.0823035390114517, -0.0826901979346228, + -0.0841075114169605, -0.0859615938067291, -0.0887064161828231, + -0.0932342458540868, -0.0995077112716876, -0.106515009195369, + -0.113364538329163, -0.120030231344817, -0.126415456829929, + -0.131969572634879, -0.136332188302277, -0.140099727136751, + -0.144464320196661, -0.150563888596907, -0.159811793584114, + -0.17188758426833, -0.186037034844676, -0.200896242431526, + -0.215536599770869, -0.229480327178188, -0.242220542515296, + -0.252940989598392, -0.258225930275002, -0.262881609504099, + -0.267183371210266, -0.272237116364086, -0.278235921569151, + -0.284981155114894, -0.292345238627156, -0.300170006930408, + -0.30800636929002, -0.315408581778722, -0.322845945937034, + -0.329496762511697, -0.336141945004942, -0.344322206759278, + -0.354379210741625, -0.36509294859461, -0.374736160507195, + -0.383089876261977, -0.391000864365342, -0.39957833172333, + -0.408504981111745, -0.417117956517694, -0.424680507777195, + -0.430196241616573, -0.433243965931992, -0.434843179702512, + -0.435358980403011, -0.435239253271769, -0.436475704898128, + -0.440642517247678, -0.446429228804979, -0.451460893375573, + -0.454913060010253, -0.45385868515089, -0.44555657362403, + -0.435040381782925, -0.426705161160583, -0.421962477825902, + -0.419368659009688, -0.418273368737305, -0.419502992301939, + -0.421135827868844, -0.423580693088606, -0.427745686551913, + -0.432669455428033, -0.437109969867523, -0.437019435067452, + -0.433846970526385, -0.432983244829469, -0.43504020087834, + -0.440689501994561, -0.445999054684865, -0.444295020367123, + -0.438688744659741, -0.434409260839024, -0.425381022724372, + -0.402396407627445, + -0.228628635595655, -0.203963844984289, -0.191557085124106, + -0.166273010561969, -0.137601000416967, -0.104871954126385, + -0.0981393882377108, -0.000331204087114845, 0.0253552347103386, + 0.0125759209749377, -0.0374705586916435, -0.0804601901028665, + -0.109578352163996, -0.11930451664309, -0.0966660269704122, + -0.0558363214493724, -0.0272050046522837, -0.0186961655446712, + -0.013776478059198, -0.0093364100912056, -0.00510833100043994, + -0.00163403948759313, 0.000930864657665694, 0.00259556735931681, + 0.00263386260433443, 0.00104107440163278, -0.00124594167443441, + -0.00366296149082848, -0.00584946190694996, -0.00894262085717885, + -0.0144253551151304, -0.0206871232667107, -0.025539169888768, + -0.0289779885895838, -0.0311033405452931, -0.0317588409493444, + -0.0311367039176259, -0.0286567115667056, -0.0243091455530592, + -0.020182392709285, -0.018329445627859, -0.0173782906535379, + -0.0171150153399877, -0.0188553884038281, -0.022858198633499, + -0.0283215422340975, -0.0347669268158323, -0.0417081592389394, + -0.0484069908471622, -0.0546622939528216, -0.0601250377846436, + -0.0644523892581045, -0.0668505431072136, -0.0674577628998449, + -0.066833774405908, -0.0657622985168076, -0.0646452545425866, + -0.0637052110389665, -0.0631882582157608, -0.063306967929927, + -0.0644767361203977, -0.0671807094960863, -0.0711084032940582, + -0.0752591601170134, -0.0786611159736221, -0.0809543008166082, + -0.0823018416873208, -0.083196896589617, -0.0839962391290725, + -0.0845541257302288, -0.0843925063950232, -0.0836531370406135, + -0.0832085647158413, -0.0832782458856373, -0.0844080899469444, + -0.0864628187069473, -0.0891159921622945, -0.0926052260357869, + -0.0972550068200655, -0.103192624071621, -0.110180345081224, + -0.117687505703562, -0.125377694104219, -0.132320240630756, + -0.137423861759545, -0.140751754421434, -0.143574692055594, + -0.147357784668702, -0.15325012413712, -0.162608147014997, + -0.17495848082969, -0.189213805204676, -0.2038412787527, + -0.217959833519656, -0.23155444262373, -0.243770158359845, + -0.253651643862181, -0.258873232796684, -0.263157976559421, + -0.267183421173171, -0.272203460049833, -0.278163978294383, + -0.284892386474107, -0.29235352497746, -0.300716186214944, + -0.309292544400178, -0.317694827099229, -0.32540372431443, + -0.331536541675955, -0.337166904151822, -0.344046524772671, + -0.353056660737413, -0.362962264235549, -0.371840834294036, + -0.379840017578915, -0.38763039860537, -0.395337664864257, + -0.402906209726019, -0.411100359930543, -0.420367829282202, + -0.428629031640927, -0.433488887874339, -0.435584324732898, + -0.436280063832125, -0.436654720282808, -0.438423124176733, + -0.441850159392446, -0.443871234860681, -0.442840660013094, + -0.441859898999218, -0.440488051601925, -0.436686956439805, + -0.43189326946369, -0.42823105619438, -0.426314854724515, + -0.424073768009251, -0.422204955167899, -0.422992181312976, + -0.42505530231151, -0.428229704227075, -0.432218192524062, + -0.435516142720174, -0.436869471079205, -0.434309003859357, + -0.430259010524886, -0.429493116326162, -0.433197789092953, + -0.438903837488465, -0.444017828568789, -0.444407610189992, + -0.441305183056209, -0.439223797055703, -0.43179567322915, + -0.408668003367912, + -0.241024596364634, -0.194221632249723, -0.19666106837495, + -0.171378107789181, -0.143109651575658, -0.105053017472628, + -0.0978254559471776, 0.0102943099044794, 0.0168692328756923, + -0.0248654820674848, -0.0697428704824203, -0.101770588215623, + -0.118410926990105, -0.111927771236417, -0.0728801404291492, + -0.0317886808236442, -0.00888138919704744, 0.000661133209347646, + 0.00728616654427448, 0.0117471636888884, 0.0151258645237538, + 0.0183268675855022, 0.0221563781578131, 0.0260714629807815, + 0.0283396743915665, 0.0286266071586485, 0.0278885471107446, + 0.0272653568482426, 0.0267986173775896, 0.0249277750340749, + 0.0203512453588612, 0.0143636545541478, 0.00912996795978039, + 0.004948263593959, 0.00172481744760754, -0.000423918829201102, + -0.00132334153987043, -0.000430617100811899, 0.00186212757116765, + 0.00349084423631218, 0.00247487235356926, 0.000286690938316819, + -0.0031113814110536, -0.00880508168112576, -0.0160560121645242, + -0.023539958894389, -0.0311459245918289, -0.0384969644323691, + -0.0450562730126233, -0.050984979400928, -0.0562755188212607, + -0.0604353524740519, -0.0628138654299042, -0.0634841324082295, + -0.0627299449578338, -0.0613811478140779, -0.0600751787633102, + -0.059461031655571, -0.0596518973683792, -0.0605278557087908, + -0.0621900081961266, -0.0648970491021394, -0.0684946648100275, + -0.0723624601517727, -0.0757166900692763, -0.0783520760380163, + -0.0804051363592149, -0.0820439029545409, -0.0830511749724957, + -0.0833838001290055, -0.0831835997148035, -0.082917450776743, + -0.0832432005424042, -0.0839574551693649, -0.0856651548015648, + -0.0884185165587547, -0.0922752738051805, -0.0968800492419518, + -0.101773465582741, -0.107457954416557, -0.114458883155382, + -0.122659231441249, -0.131346260094231, -0.138896388594542, + -0.143803576060454, -0.146383936987397, -0.148391880692145, + -0.151398273612485, -0.156691894206754, -0.165663073857205, + -0.177959373795935, -0.192278603685808, -0.20679163513658, + -0.220368841729296, -0.233325618889177, -0.244366613726206, + -0.252707620320713, -0.257645161576213, -0.261873650465869, + -0.266197664071108, -0.271469739840288, -0.27768406804496, + -0.284566533390992, -0.291980037226265, -0.300857236807427, + -0.310042249344785, -0.319204358288314, -0.326957483406425, + -0.332739215668582, -0.337600162204843, -0.343328131299599, + -0.350942661317817, -0.359070888194751, -0.366380592082972, + -0.373686771181946, -0.381145550092062, -0.388193472358011, + -0.395099529182596, -0.403246601956612, -0.413597841984934, + -0.424419150770289, -0.431951962261962, -0.435318830745347, + -0.436658415364717, -0.437635763544154, -0.439429941255805, + -0.441142387541174, -0.439787316260166, -0.436597781127456, + -0.435524525010249, -0.435894396962655, -0.435470092723899, + -0.4334346382365, -0.431348099889959, -0.430014970935437, + -0.427745408634368, -0.425743819835704, -0.426001261929025, + -0.428777185833823, -0.432445342308373, -0.435846110008024, + -0.437558737437259, -0.436327062767812, -0.432940357737012, + -0.429948116494842, -0.429716290456303, -0.434156076080976, + -0.43942591084732, -0.442959440904836, -0.44383581401501, + -0.443081589831462, -0.442199767164063, -0.435564714721932, + -0.417458640956144, + -0.253420950348565, -0.199866804658609, -0.201766212918958, + -0.176483435758171, -0.150380752045365, -0.107823272578853, + -0.0975111627338147, 0.0179101778482454, -0.00341861816019144, + -0.0444988219608253, -0.0814590982160036, -0.11005595607125, + -0.118449187334855, -0.098313235473224, -0.0520699016973617, + -0.0127301533839562, 0.0075466821226824, 0.018459860544233, + 0.0259128060449814, 0.0302558668377774, 0.0335070067637041, + 0.0371575641697331, 0.0421836586353674, 0.0476179608124691, + 0.0515278124702883, 0.0535663315887603, 0.0545856339274428, + 0.0556145262078228, 0.0564995529245182, 0.0556780988308504, + 0.0520756688845077, 0.0460974001160899, 0.0394629152343917, + 0.0332367999251022, 0.0280680440477819, 0.0241965088616708, + 0.0221010274061496, 0.0217706597074904, 0.0219768129784166, + 0.0207879432281979, 0.0167755581055937, 0.0116555522930975, + 0.0054234228014005, -0.00295293239904524, -0.0123728316412187, + -0.0212685081373809, -0.0295869338507785, -0.0369815292766876, + -0.0430126985522649, -0.0478473472155681, -0.0520525738566104, + -0.0554643330459318, -0.0574199113454682, -0.0577721017756201, + -0.0567022954423514, -0.0550726856640065, -0.0540002445153818, + -0.0541484964180237, -0.0554225208412975, -0.0574446634951434, + -0.059957317157133, -0.0628447058055669, -0.0660793531229229, + -0.0696411867882383, -0.0731947631152244, -0.0764072291447223, + -0.079127671802429, -0.0812268414838094, -0.0822954888295494, + -0.0826161517228204, -0.0827003780971613, -0.0830068108858155, + -0.0837581396229287, -0.0845635685501861, -0.0865149551950317, + -0.0901940283112911, -0.0956443139378501, -0.101567685508603, + -0.106957722968848, -0.112569467460151, -0.119614459177512, + -0.128198159979185, -0.137328712876779, -0.145245510538457, + -0.150439198960375, -0.153143525497192, -0.154898458156658, + -0.157052067776843, -0.161129189984765, -0.169165765079878, + -0.181134380784489, -0.195582807085457, -0.210051909775394, + -0.223044365104593, -0.234934595923317, -0.244569705894762, + -0.251211940766291, -0.255626781355233, -0.259756459855296, + -0.264317326071835, -0.26974149746275, -0.276174828437241, + -0.283361557488433, -0.291170978608409, -0.300708881137612, + -0.310258560401929, -0.319523978460501, -0.327221832499871, + -0.33333082977863, -0.338165288850132, -0.342977037856178, + -0.348831577701473, -0.354693272473805, -0.360605183603615, + -0.367152244067759, -0.374183178637825, -0.381280243334878, + -0.388577374635764, -0.396933159049871, -0.407721207815643, + -0.420223317718238, -0.430389478925798, -0.435595011334955, + -0.437650264683288, -0.438823711520616, -0.440018333316009, + -0.439763634925671, -0.436795359985995, -0.434075006535842, + -0.434574298912951, -0.436563509521456, -0.437095783162019, + -0.435674151147944, -0.434006502308655, -0.432847248714004, + -0.431297228639275, -0.429897181059456, -0.430282177486278, + -0.432527837198041, -0.435727719096313, -0.438750832352599, + -0.439626493027769, -0.437671792676174, -0.434497716576059, + -0.432275376166872, -0.43254045536965, -0.436702744602101, + -0.441805838099818, -0.443178029424029, -0.441996830396137, + -0.441525637977505, -0.440001637492924, -0.432739733715999, + -0.416063318699044, + -0.265818069954898, -0.203536904693372, -0.206871834028581, + -0.181588759866881, -0.156307057286473, -0.107244306757774, + -0.0971974201605442, 0.0159573198205771, -0.0136467661629462, + -0.0551731252877503, -0.0834148462958583, -0.107699601018846, + -0.10884862506011, -0.0763641736994218, -0.0299353177253165, + 0.00265910113080569, 0.0210945958896212, 0.0332322229221259, + 0.0413345864606598, 0.046007705878798, 0.049731995699815, + 0.0540104984846659, 0.0596766873913996, 0.0657682913163931, + 0.070461674484358, 0.0733837598523987, 0.0752606716603409, + 0.0767801440018604, 0.0777111025757106, 0.0768561581329779, + 0.0734939260808357, 0.0677118854126451, 0.0607502027448445, + 0.0535891856304888, 0.0471585897413374, 0.0421213474185295, + 0.0390062465022089, 0.0374287116232983, 0.0356362351869849, + 0.0320299327172197, 0.0257602931097105, 0.0186831669266624, + 0.011000855732805, 0.0016638444867737, -0.00863387955145544, + -0.0184398088346447, -0.0272215749438044, -0.0345245591164045, + -0.0399154888331471, -0.0434596111691057, -0.0460999791172376, + -0.0483798276118023, -0.0498257786852029, -0.0500424778791891, + -0.0490147838691833, -0.0476188669575438, -0.0471513531163679, + -0.048243234732025, -0.0507094707380095, -0.0540224891636303, + -0.057608688723327, -0.061054309204761, -0.0644368858554427, + -0.0681536274942398, -0.072217396797334, -0.076125025422141, + -0.079284184265183, -0.0813808486248217, -0.0824035454553234, + -0.0829417168879425, -0.0834146736647711, -0.0840200029271088, + -0.0849591773985579, -0.0857064759233699, -0.0878598606285655, + -0.0926119778072341, -0.0994412164067266, -0.106641739130705, + -0.112772796858875, -0.118495143100933, -0.125472738418049, + -0.133955230029638, -0.14298787005187, -0.151185085836298, + -0.157140829739909, -0.160815756207069, -0.16304655343516, + -0.164725091042535, -0.167399041508966, -0.174024579420169, + -0.185393085358491, -0.19976198417304, -0.213797513256259, + -0.225907808521046, -0.236472180950426, -0.244702165163213, + -0.250154414527903, -0.254080721235761, -0.257960541121812, + -0.262470792867941, -0.267989657007903, -0.274548317051198, + -0.281918602580574, -0.290159790768028, -0.300319805390697, + -0.309833397203815, -0.31870576428425, -0.326452958129226, + -0.333179382352051, -0.338368526019238, -0.342489307816962, + -0.346661017060694, -0.351013697217371, -0.356165107628427, + -0.362463689044598, -0.369483816072198, -0.376722273963782, + -0.384237885067681, -0.39265933633431, -0.403938136541891, + -0.41799487451416, -0.430448642146712, -0.437467038965421, + -0.44012827031088, -0.441027207652345, -0.441107045167903, + -0.439227553252606, -0.435838410764498, -0.434021030921635, + -0.434891140753012, -0.435678869819551, -0.435179188109795, + -0.433908397368058, -0.433203158673722, -0.434153659888904, + -0.434849634512136, -0.434624296952541, -0.434888594991229, + -0.43585197041299, -0.437990322605337, -0.44060934671415, + -0.441183298363266, -0.438512427655909, -0.435656973681167, + -0.435100316477691, -0.435743771456679, -0.436284910658645, + -0.43800704981612, -0.437981353379446, -0.43507191482066, + -0.437486587727964, -0.436534548851259, -0.426688493175639, + -0.408202536769103, + -0.278214621992199, -0.203119322641293, -0.21195957601238, + -0.186694709640394, -0.161412769963558, -0.116268236880826, + -0.0968836963090838, 0.011501742505686, -0.0185610027217962, + -0.064215354622897, -0.0874987753581379, -0.102803150233023, + -0.0934254372312288, -0.0497962225375258, -0.00747376603122479, + 0.0170809921434974, 0.0328969228480139, 0.0450309520431124, + 0.0533284898247152, 0.0585777938284827, 0.0629347671518675, + 0.0677509816061848, 0.0736159815185267, 0.0797023138979804, + 0.0844464463936345, 0.0873538534265757, 0.0890178230388695, + 0.0900319860441643, 0.0900333600085054, 0.0882276267285003, + 0.0844101740051242, 0.0790087524456284, 0.0729460265369606, + 0.0666932173617128, 0.0605697330928757, 0.0551370798993028, + 0.0510677917760533, 0.0479877753306648, 0.0442857420221775, + 0.0388522869104622, 0.031106560010203, 0.0229622961397427, + 0.0148721723280942, 0.00580274768195163, -0.00415385413970117, + -0.0140595378461459, -0.0230470053286759, -0.0302002378494093, + -0.0351930810575018, -0.0381416233891035, -0.0397489471020122, + -0.0408136195957666, -0.0415441122726261, -0.0417278041375722, + -0.0412665696434906, -0.0407137876849801, -0.041036873759485, + -0.0429485831915314, -0.046375407054938, -0.0506849071244278, + -0.0551569346896761, -0.059383596543329, -0.06338093882535, + -0.0675863825757112, -0.072081658807654, -0.0764127759677524, + -0.0799966497475512, -0.0823862980562614, -0.0836520368534382, + -0.0845039497028438, -0.085159561790379, -0.085823142285738, + -0.0869435835133191, -0.0880946451637455, -0.0907252675740551, + -0.0959052254881165, -0.103317263229462, -0.111494129621404, + -0.118637545231884, -0.124855284128672, -0.131833010822667, + -0.13988563137389, -0.148554273848745, -0.156838794700525, + -0.163543397020124, -0.168399819225552, -0.171600659675456, + -0.173405426129159, -0.175242543512967, -0.180513959725109, + -0.190868953319458, -0.204569486895434, -0.217707774459245, + -0.228778571653014, -0.237934490749014, -0.244923492342533, + -0.249699426200593, -0.253406704351027, -0.257082976763536, + -0.26148862483906, -0.267089846895543, -0.273703996620482, + -0.281123404433868, -0.289529647101542, -0.299792505812062, + -0.308671180412437, -0.316812062568437, -0.324306166573307, + -0.331344714933562, -0.337054175235519, -0.341042086481687, + -0.344380432559883, -0.348229906077311, -0.353525663062772, + -0.360268910023738, -0.367425518661325, -0.374266923747458, + -0.381289132018901, -0.389483248895806, -0.401387583046982, + -0.417115386997088, -0.431731831777693, -0.440272902533628, + -0.443248545457854, -0.44359799949481, -0.442615937510618, + -0.439861079287786, -0.436398894266344, -0.434328183537595, + -0.432059377495135, -0.4282355517018, -0.426536366284086, + -0.427546774667512, -0.42998022717004, -0.434462681925975, + -0.43691640602016, -0.436916989871556, -0.438196842112794, + -0.438790175225616, -0.438220769652545, -0.438285069321864, + -0.438102046056145, -0.436197804545311, -0.435685312811476, + -0.43666332144154, -0.436420604166467, -0.431481730072529, + -0.426426063338003, -0.423453655550194, -0.424740678220419, + -0.432150072720035, -0.433997343919858, -0.425207290469244, + -0.404459513676719, + -0.246858205058287, -0.213058232475306, -0.217000051841048, + -0.191800290175539, -0.166518506143902, -0.123954159635724, + -0.0965710024141067, -0.00083342564427715, -0.0248732178372963, + -0.070591747777077, -0.0908773341503814, -0.096146872022611, + -0.0732669115497809, -0.0255709085431371, 0.0106225786943177, + 0.0296767489596908, 0.0432611578867361, 0.0540975538610194, + 0.0619645016642668, 0.0676257129019096, 0.0726406013109383, + 0.0779894027833339, 0.0840690743436681, 0.0901682183568446, + 0.0947155512722876, 0.0972354182339945, 0.0981921906366838, + 0.0982128650074616, 0.0970994263456324, 0.0944145407275241, + 0.0903065571304959, 0.0854353175037293, 0.0804111747976649, + 0.075216953253996, 0.0696978257280925, 0.064131552001131, + 0.059126015915675, 0.0545048652631659, 0.0491844202079461, + 0.0426081748630467, 0.0341197874908818, 0.0255825960253896, + 0.0175088450602143, 0.00888957333121231, -0.000357223429094438, + -0.00957914126935795, -0.0179666239205075, -0.024652742479462, + -0.0293751646758723, -0.0322963996082762, -0.0339187087894018, + -0.0346282418196051, -0.0347542459128161, -0.0346938750900781, + -0.0348294715007638, -0.0353499530869136, -0.036541953841162, + -0.0391118462597844, -0.0432686853368444, -0.048139737444521, + -0.0529359177327203, -0.0576654250973378, -0.0623267095938798, + -0.0670091545690138, -0.0715120158609736, -0.0757347570712717, + -0.0796365126849228, -0.0828253094865547, -0.0849966634565964, + -0.0865034568444868, -0.0874880381467146, -0.0884340029855973, + -0.0899771340435073, -0.0916532140251207, -0.094645169964733, + -0.0999680389639437, -0.107559702315315, -0.116357416689105, + -0.124390636509385, -0.131288250806764, -0.138167888696288, + -0.145613710333495, -0.153673663928422, -0.161540238920193, + -0.16835823921021, -0.173946692659349, -0.178159516500468, + -0.180911800020417, -0.182982944049544, -0.187471797343482, + -0.196493347120189, -0.208944752117115, -0.220941942222837, + -0.231103015398477, -0.239289538530191, -0.245511667677001, + -0.249989249986458, -0.25379283327925, -0.257571920955924, + -0.261992911304755, -0.267451866174174, -0.273944214437867, + -0.281393981288455, -0.289724927864971, -0.299465022413725, + -0.307202461650321, -0.314322768119776, -0.321165441010575, + -0.328054522432168, -0.334273529629139, -0.338966221640052, + -0.342653337393524, -0.346888654274025, -0.35278859747014, + -0.359864527087763, -0.36662294842758, -0.372758706289202, + -0.379111961118727, -0.387153949765279, -0.399422875929146, + -0.416087449732472, -0.432125732349508, -0.441616221850439, + -0.445111045219622, -0.445385587015541, -0.443895199718959, + -0.440594844399946, -0.436687029285755, -0.432915476784417, + -0.427434521917936, -0.421142669642837, -0.41874353866185, + -0.420831014693828, -0.425259513297492, -0.430111600062014, + -0.430859054458355, -0.430104102270472, -0.435698673312095, + -0.439416769217072, -0.436752418693547, -0.433147115152607, + -0.431700499372531, -0.431313696118411, -0.432950684682641, + -0.43554985199736, -0.432697328889646, -0.422578814060756, + -0.416708751230821, -0.415295658270927, -0.416547107748228, + -0.41929828416114, -0.419939646470756, -0.418926406858197, + -0.406836190993536, + -0.264299059457764, -0.225457452296466, -0.221752879762668, + -0.196906451179425, -0.171623794269973, -0.128527593250065, + -0.0962603180773233, -0.030956062024151, -0.0465262349792113, + -0.074143612373094, -0.085226847178845, -0.0817050907811994, + -0.0493372727325887, -0.00519939309427401, 0.0234053458807496, + 0.0394417877051531, 0.0516692423114579, 0.061058035264351, + 0.0683172805528759, 0.074254342686128, 0.0798605295923556, + 0.0858773319563678, 0.0924781841594028, 0.0988764974617883, + 0.103262314237878, 0.105206151868252, 0.105226406138652, + 0.104141369679944, 0.102066698199046, 0.0988779064578113, + 0.0948341806367327, 0.0904858879123497, 0.086008896190184, + 0.0810760369196324, 0.0754506969863031, 0.0694114359013367, + 0.0634961881663094, 0.0575355965433095, 0.0509308896559798, + 0.0437679675713224, 0.0354029362571446, 0.0273163953959012, + 0.0195818901690155, 0.0111122405057445, 0.00222517097536599, + -0.00611383789349618, -0.0132797280363578, -0.0188630679988626, + -0.0230304057268876, -0.0260848941436997, -0.0282133991473248, + -0.029404853966714, -0.0295195582201391, -0.0294438982138443, + -0.0301780426389212, -0.0317126957458133, -0.0337336733008546, + -0.036795544742788, -0.0413268817250966, -0.0463197780192095, + -0.051254273511477, -0.0560701596050562, -0.0609756425420619, + -0.0658498579580001, -0.0701306815967897, -0.0738824024658305, + -0.0777290989885842, -0.0816562859433827, -0.0850525626438367, + -0.0876578232016413, -0.0894959524908159, -0.0912680628710467, + -0.0934075700654737, -0.0954556131221621, -0.0988610014500338, + -0.104758097046727, -0.112776724338107, -0.121767565216448, + -0.13002642322637, -0.137125004402114, -0.143710768462552, + -0.150345898549589, -0.157331623484683, -0.164192005503548, + -0.170459664878848, -0.176128263950617, -0.181145184858431, + -0.18533525861624, -0.188870459434709, -0.193449257833873, + -0.201300861585335, -0.212130128599874, -0.222921965394172, + -0.232472256260585, -0.240287140347326, -0.248914360920951, + -0.251156469897428, -0.255241740631569, -0.259298464505013, + -0.263751001682722, -0.268855321604437, -0.275113997317597, + -0.282549192430828, -0.290608954888604, -0.299533731114814, + -0.306384416619514, -0.312768725988166, -0.31897110448765, + -0.325435669560031, -0.332038447435501, -0.337751747538002, + -0.342263645167524, -0.347031366132175, -0.353146232134862, + -0.359799866347912, -0.365937933577656, -0.371508764939649, + -0.377405612915526, -0.385153921232141, -0.396933019548537, + -0.413120465331717, -0.429318333389818, -0.439616202856183, + -0.444274527025473, -0.445417403242168, -0.444146783818479, + -0.44022348856936, -0.435310833179403, -0.43013709159578, + -0.424056024688373, -0.419334603823739, -0.417460271562893, + -0.417426906205652, -0.419068060493328, -0.421335587840089, + -0.419449833940638, -0.417800699628328, -0.424242247270564, + -0.432949073628713, -0.433384457319533, -0.427975933484872, + -0.424793232499893, -0.42504418430347, -0.428527598213227, + -0.434974492264042, -0.427984518371014, -0.413676247315352, + -0.410960465532743, -0.411964142328178, -0.41049573756024, + -0.406129707697753, -0.40198922414152, -0.403903346680783, + -0.403910088737888, + -0.274504766964971, -0.237857761493428, -0.225670140975191, + -0.20201248764366, -0.176730519018676, -0.147891440294756, + -0.0983535319885691, -0.0658372810120595, -0.0670080225535888, + -0.0753390783302972, -0.0731049392249939, -0.0547214859753182, + -0.0200497794140966, 0.0122122724587213, 0.0326118224159616, + 0.046942537896875, 0.0587471128027415, 0.0676919151158349, + 0.0747029955708522, 0.0807715129481845, 0.0867496476086207, + 0.093272428960547, 0.100357070403825, 0.106948687901148, + 0.110964871931955, 0.112121039581775, 0.111128145087173, + 0.109019329191255, 0.106234595592513, 0.102843970481575, + 0.0989341360507182, 0.0945947817954227, 0.0897635979058062, + 0.0841596987449355, 0.0776987016359626, 0.0707210241836737, + 0.0638026865561954, 0.0568118393875768, 0.0494387794578507, + 0.0421897059567852, 0.0345441143314468, 0.0276959453516306, + 0.021059067700495, 0.0131808919029682, 0.0046858045844593, + -0.00298687462349, -0.00905664770263449, -0.0135086385628602, + -0.0170121170523957, -0.0199381330247469, -0.0223477504748907, + -0.024107096561397, -0.0250690699795485, -0.0259299750948968, + -0.0276110376988944, -0.0299411072058459, -0.0324200669861889, + -0.0357124732481138, -0.0404365376053617, -0.0455969778756762, + -0.0503943713028793, -0.0548903644664772, -0.0594807663341565, + -0.0640648639171494, -0.0680240139068193, -0.0714289180139589, + -0.0750793331990184, -0.0793240152614562, -0.0836770587585183, + -0.0874768596640365, -0.0904624390321744, -0.0932868506034629, + -0.0960743781364578, -0.0986824457392019, -0.103068191498621, + -0.110124728498224, -0.118833392519892, -0.127577350482094, + -0.135228652752051, -0.141725359836612, -0.147656298980592, + -0.1533641703672, -0.158911736067718, -0.164359736661681, + -0.169714668323694, -0.174988718106423, -0.18036856636704, + -0.185865346347812, -0.19116864586847, -0.196938467169104, + -0.204557730150807, -0.21411014262581, -0.223792254602289, + -0.2329425817543, -0.240775714720066, -0.249440786481084, + -0.252713484414582, -0.257513833330326, -0.26189420312007, + -0.266099062464189, -0.27067086642724, -0.276542105706937, + -0.28382281662797, -0.291723820803922, -0.299827152360317, + -0.306213052454188, -0.312797891529215, -0.319024661436895, + -0.32528420962867, -0.331955653730137, -0.338070243532746, + -0.342894328312804, -0.347657197587376, -0.353167160895862, + -0.359014402102198, -0.364446325157541, -0.369509478690706, + -0.375100246622253, -0.382299630984915, -0.392646253006354, + -0.406640821975701, -0.421374369208146, -0.43247424972784, + -0.439093314528169, -0.442283752882067, -0.442281958671046, + -0.438491972592821, -0.433076825300018, -0.428042043022507, + -0.423407923659332, -0.420719289682669, -0.419459639977966, + -0.41810457122348, -0.416754402635283, -0.415993742182522, + -0.413122286626696, -0.412161724923886, -0.41346017314584, + -0.419452136136607, -0.424113979329267, -0.42414848800348, + -0.422501160373689, -0.424266413272931, -0.42862697143265, + -0.432582910412072, -0.417459332562654, -0.394526050223881, + -0.396372755979065, -0.401929581691713, -0.400358660413901, + -0.39782807220233, -0.38940805829777, -0.384254280752218, + -0.381239708589212, + -0.108649030327797, -0.250258787618701, -0.228764931795541, + -0.207119093732025, -0.181836591784545, -0.156554128520774, + -0.105670138484883, -0.0854865112018309, -0.0771982791614761, + -0.0695129970245615, -0.0524614236147726, -0.0238399178908833, + 0.00615080254868346, 0.0261682505902793, 0.0412409788731922, + 0.0546615497354999, 0.0665498306573802, 0.0758062114210647, + 0.0829907089171707, 0.0891595105702193, 0.0951825696738235, + 0.101720131105266, 0.108686651919387, 0.114833665963285, + 0.118065110064168, 0.118257520654137, 0.116312158711869, + 0.11330105592469, 0.10979868468852, 0.105975687392063, + 0.10176309254017, 0.0969125176778222, 0.091240376713767, + 0.0846170885587278, 0.0771666027645114, 0.069165161580628, + 0.0611205762481894, 0.053217592557286, 0.0454409784042595, + 0.0384143575298825, 0.0316808864798605, 0.0262635502620327, + 0.0212637212860823, 0.0148323279862267, 0.00743124716937744, + 0.000575190398219684, -0.0048465923994631, -0.00867788917428573, + -0.0116851953308581, -0.0142879972443701, -0.0167584188673991, + -0.0192145445466789, -0.0215802094262419, -0.0239487566468634, + -0.0265825307868841, -0.0293089349614446, -0.0320395156735158, + -0.035657001344524, -0.0405840960207361, -0.0459481880192076, + -0.0504960497162965, -0.0544057130356145, -0.0583470359640812, + -0.0622552394333498, -0.0657745575565814, -0.0690844703554244, + -0.0727189450091928, -0.0770783326167573, -0.0819505328779959, + -0.086748025994295, -0.0908524502013069, -0.09462474993666, + -0.0981217792387811, -0.101563420367033, -0.107218876982868, + -0.115583075200896, -0.124935590116415, -0.133232886333723, + -0.139741099439083, -0.14507176923266, -0.149980887790341, + -0.154643780846964, -0.15895142443623, -0.16331428155514, + -0.16766112230249, -0.172200452887138, -0.17743931651912, + -0.183734720955893, -0.190521701326114, -0.197743456357997, + -0.205947322346325, -0.214972513740893, -0.224030179834043, + -0.233020657568525, -0.241248453560242, -0.25026211663664, + -0.254487286854893, -0.2599371758944, -0.264606444586474, + -0.268663668676898, -0.272818639453974, -0.278183712118318, + -0.285017865846971, -0.292734733218627, -0.300407019846326, + -0.306868648886506, -0.313807822808454, -0.320617424715669, + -0.327330187144865, -0.333790334462432, -0.339309083841997, + -0.343548555812037, -0.3476187238859, -0.352308150970101, + -0.357197515726163, -0.36136295139213, -0.365446156118182, + -0.370715147275229, -0.377646233185553, -0.386666351371626, + -0.39810208203612, -0.410437322634586, -0.421250232787868, + -0.429884355580901, -0.436131279618929, -0.43848279484465, + -0.43588565524708, -0.430987395957681, -0.427356895256547, + -0.425559559485799, -0.424213785319474, -0.422391429778079, + -0.420460536624108, -0.417903432676147, -0.416279364697804, + -0.414239735759848, -0.412002645246399, -0.409513682224585, + -0.411500502860592, -0.415654418881155, -0.422697026267651, + -0.424480214930439, -0.42706493786962, -0.430904925758553, + -0.431512430977383, -0.411251179459119, -0.376783026869719, + -0.380286093799775, -0.392452117994115, -0.39147931701162, + -0.390960624043544, -0.387401198844937, -0.380831421014779, + -0.372188102508578, + -0.117730939024839, -0.262659590473524, -0.226449840427117, + -0.212225813586848, -0.186943440998705, -0.161661127407698, + -0.115282061420175, -0.0936514807554062, -0.0786423095744388, + -0.062345598873789, -0.0362994447772464, -0.00414632313453884, + 0.0208308430180891, 0.0364872817315738, 0.049859489149388, + 0.0626545742176535, 0.0746169411594598, 0.0845806167113839, + 0.0927438041699266, 0.0995741758805361, 0.105667819140134, + 0.111649679285068, 0.117588356444674, 0.122407006894287, + 0.124393804683238, 0.123550780614653, 0.120747608959327, + 0.116833300964661, 0.112327587010114, 0.107535268469437, + 0.102455087989119, 0.0968281775901899, 0.0904144127728921, + 0.0830783167523043, 0.0748691798599882, 0.0660230074829763, + 0.0569104115402477, 0.0480423445100396, 0.0399113528650125, + 0.0332063652718204, 0.0272619904051735, 0.0231105850148883, + 0.0198653122274326, 0.0154645683899203, 0.00983001258307527, + 0.00405934285964786, -0.000990422012999727, -0.00475402642462233, + -0.00756678205714391, -0.00996353005400726, -0.0125592443600248, + -0.0157128122415537, -0.0193388967026246, -0.0228899139245615, + -0.0260526292015708, -0.0289915630098147, -0.0322422897159311, + -0.0365108218427633, -0.0418679930284911, -0.0473078047207546, + -0.0517192374651592, -0.0551665972795312, -0.0584434240026879, + -0.0616649331682178, -0.0646984562422128, -0.0678589848579534, + -0.0713465362901896, -0.0755304324400476, -0.0805738774406331, + -0.0861127124854374, -0.0911241767840156, -0.0958156412460541, + -0.100165584280693, -0.104623835657052, -0.111332719035876, + -0.120449714792109, -0.130120436893282, -0.138034127467951, + -0.143483641706694, -0.147547664709753, -0.151173120599293, + -0.154660638469304, -0.158041299129278, -0.161659123484743, + -0.165273993331304, -0.1690561466132, -0.173880049997767, + -0.180355230672072, -0.188077964920731, -0.19658621199576, + -0.205586890622509, -0.214726766010964, -0.223715214620142, + -0.23282475703394, -0.24158567750311, -0.250927617833444, + -0.256243287235065, -0.262318420523883, -0.267403035029023, + -0.271528107113308, -0.275394691620598, -0.280279531292671, + -0.286458144561458, -0.293982916383468, -0.301468104062865, + -0.308309713974692, -0.315460168075137, -0.32261203484779, + -0.329577091939973, -0.335540806847645, -0.339825910703174, + -0.343129689828488, -0.346621909906347, -0.350653517244156, + -0.354159984956708, -0.356511382961903, -0.359341251712429, + -0.364309916247231, -0.371593871599313, -0.380628520650938, + -0.390680174398649, -0.401041360209945, -0.410748703391861, + -0.420238563794031, -0.429158029958815, -0.433955482036398, + -0.432002189500503, -0.426462794865549, -0.422859050324492, + -0.422623737172282, -0.423360012152184, -0.42301733639478, + -0.421178606762727, -0.418316861472613, -0.414230041090418, + -0.412219234725104, -0.410953563007069, -0.40467643297007, + -0.408647675000262, -0.411863466900069, -0.419082218595186, + -0.423107007715067, -0.427490036096587, -0.431820452633151, + -0.429426502216355, -0.402114824306762, -0.366332402350152, + -0.367589513332805, -0.383295355941433, -0.385524145022382, + -0.385617068360859, -0.385681887609057, -0.384439067461339, + -0.379091859428573, + -0.115166330258982, -0.275061930100275, -0.207709538516361, + -0.21733299688446, -0.192050391040949, -0.166768351635199, + -0.111347586694053, -0.0861538276543266, -0.0732496610756087, + -0.0571753989181272, -0.0297208541249762, 0.0023577289444001, + 0.0264026251332374, 0.0428897392959154, 0.0559653903081507, + 0.0678282443084846, 0.0796254833921202, 0.0911706203643113, + 0.101482699964907, 0.109905567061584, 0.116507432164952, + 0.121814367772819, 0.126286539066314, 0.129341466431584, + 0.129894108916526, 0.128043196779407, 0.124376728973153, + 0.119408606830573, 0.113594708501035, 0.107413195130555, + 0.101028396970565, 0.0943858901530531, 0.0874099412716632, + 0.079923111691111, 0.0716681647202258, 0.0625742677436884, + 0.0528908352252742, 0.0433149187963704, 0.0347387440195419, + 0.0280598230498849, 0.022468319444818, 0.0190735439399318, + 0.0172027384397011, 0.0147631344230457, 0.0110928331919133, + 0.00654880859109404, 0.00184397886448188, -0.00203171385271337, + -0.00490199400651336, -0.00724000158210603, -0.0098860111034778, + -0.0133568856079421, -0.0174377143287465, -0.0213415851858131, + -0.0247573810466366, -0.0281951413516812, -0.0324417388574437, + -0.0378470801324698, -0.043954477206168, -0.0495316867441569, + -0.0539909749225567, -0.0575511125140067, -0.0605576858093089, + -0.0631328439906155, -0.0655921842702507, -0.0681668422462242, + -0.0709889191733672, -0.0745836044594652, -0.0794787399686523, + -0.0853917672574928, -0.0911176749257412, -0.0968695774144625, + -0.102431939108008, -0.108048664976647, -0.115416209863956, + -0.124674607660922, -0.134242813828826, -0.141763807839997, + -0.146532604348095, -0.149583445737658, -0.152065195775801, + -0.154483004688468, -0.156952726033486, -0.159786997643126, + -0.162794994325759, -0.166099211730337, -0.170526202911302, + -0.176721129121372, -0.184570457071426, -0.193737275816091, + -0.203494379866021, -0.213218308337945, -0.222654686417069, + -0.232117785979974, -0.241346487198264, -0.250843391456805, + -0.257461113485182, -0.264334664252106, -0.270176973544829, + -0.274745435314592, -0.27861140447741, -0.28311527737955, + -0.288519794362732, -0.295713456339552, -0.302795471585321, + -0.309734164424247, -0.316962658055151, -0.3240793435413, + -0.330589032385876, -0.335360154437494, -0.338317915124266, + -0.341171340624617, -0.344827522302545, -0.34837095619349, + -0.350386764390548, -0.351233317000255, -0.353170900156599, + -0.358002879962819, -0.365717608992858, -0.375728343554087, + -0.38649430147671, -0.396535911340369, -0.405785541850654, + -0.415252892914143, -0.424363944685465, -0.429659064685624, + -0.427535921407358, -0.422474568725796, -0.418475802977239, + -0.416436272682575, -0.416586361737859, -0.417134316238833, + -0.417419316179174, -0.417227564278787, -0.416398975626802, + -0.427608003488798, -0.413226070725785, -0.407379231043285, + -0.409095003038274, -0.411924166990945, -0.415715027024089, + -0.418302212873617, -0.423717338571415, -0.429267420736464, + -0.422598818117832, -0.393873599343687, -0.361366536214894, + -0.354396822489705, -0.363253002060769, -0.371272514459832, + -0.377632162336197, -0.380648742192754, -0.383647468013386, + -0.382817068632488, + -0.12469974097268, -0.287462896381945, -0.209908261446126, + -0.222439821223852, -0.197157407763583, -0.171875305241001, + -0.120422352943986, -0.0897248232409226, -0.0739563848308656, + -0.0544334217735508, -0.0276469541336822, 0.00187456028796965, + 0.0262697850428605, 0.0438750218651228, 0.0556805954945363, + 0.0660987467776653, 0.0781576109370815, 0.0927612776187995, + 0.106966311896981, 0.118124186914121, 0.125737744934965, + 0.130603698435391, 0.133740965180258, 0.135133216697477, + 0.134377575328468, 0.131674673028829, 0.127221209374233, + 0.121181160048248, 0.113925356522828, 0.106031436374073, + 0.0978958487877333, 0.0898577190243632, 0.0822142294737419, + 0.0749809748054833, 0.0674647419559881, 0.0590273419477699, + 0.0495888642333511, 0.0399101755420912, 0.0310061321756031, + 0.0239580406813048, 0.0181638518685762, 0.0149434119936576, + 0.0138901025884666, 0.0129245262701021, 0.0108785507244767, + 0.0074691286101687, 0.00326160446670737, -0.000577895765804383, + -0.00345267112097231, -0.00563282364342619, -0.00799214628989873, + -0.0111248567453076, -0.0148400831941432, -0.0185893144806906, + -0.0224251809889096, -0.0268911331331095, -0.0326101033759163, + -0.0394356747415072, -0.0464342408645571, -0.0523736308804125, + -0.0571110962428947, -0.0611786791749241, -0.06432946179138, + -0.0662784354739847, -0.0678884788599967, -0.0695285493309084, + -0.0713611819975452, -0.0739783887555189, -0.0782267250576611, + -0.0841363188994897, -0.09054850684246, -0.0976808621658892, + -0.104832938058345, -0.11158330211154, -0.119271528508304, + -0.128263912980449, -0.137444049424339, -0.144702739810462, + -0.149118146979147, -0.151455870512847, -0.153041506414509, + -0.154590415691855, -0.156184642742271, -0.158222930818948, + -0.160685011148329, -0.163660376211006, -0.167753683576245, + -0.173417527018908, -0.180506781217421, -0.189210018070639, + -0.199221329527599, -0.209771803561338, -0.220244151613496, + -0.230525263366953, -0.24050792310511, -0.250045871635958, + -0.258079500166128, -0.265805494643702, -0.27248687707791, + -0.277811337540682, -0.282227799323647, -0.286725035468479, + -0.291532696933214, -0.298391470509354, -0.304816751365814, + -0.311365081230302, -0.318092023631465, -0.324557265106457, + -0.329609956384453, -0.332561943198761, -0.334645987063263, + -0.338177883504431, -0.342550056448918, -0.34552982243263, + -0.346495979002007, -0.346887928014365, -0.349108668230609, + -0.354133368201854, -0.361903602200866, -0.372515312941898, + -0.384749781102808, -0.396188960607208, -0.405931133087206, + -0.415010940376468, -0.422557028509281, -0.426309402427883, + -0.425208392306712, -0.42247384795631, -0.419902100095745, + -0.416148456789998, -0.413832805249997, -0.41254218053996, + -0.411913487805203, -0.412592809352109, -0.415466477769436, + -0.418874009865537, -0.411996734485559, -0.409853748106921, + -0.412864276261604, -0.414732377219838, -0.415437215335234, + -0.413124860561211, -0.417339713347448, -0.422476700453493, + -0.41419141744094, -0.390005596299693, -0.362662006815696, + -0.35202626986664, -0.352957684734831, -0.359827064142462, + -0.368434046530466, -0.373027319513456, -0.377649916947685, + -0.380098411362962, + -0.15213972128327, -0.299867270647687, -0.222314174623732, + -0.227547141862678, -0.202265226684454, -0.176983164150921, + -0.150729556599, -0.133116611069822, -0.10832650335031, + -0.0718350271417085, -0.0355429325187071, -0.0042066222836342, + 0.0210989839291914, 0.0388596238725819, 0.0485871403207522, + 0.0570286457289926, 0.07037471268577, 0.0899116732843532, + 0.109364737948783, 0.123594523216552, 0.132223890317117, + 0.136817040605191, 0.138981443302055, 0.139173777523419, + 0.137532795693824, 0.134182387758527, 0.129183283001258, + 0.122404097315497, 0.113921365982216, 0.104192244510436, + 0.0938879174825291, 0.0838374430757119, 0.0750209599451996, + 0.0679768281914711, 0.0616207693950074, 0.0546057659243917, + 0.0461541401022113, 0.036897866923029, 0.0279166835404027, + 0.0204589080548562, 0.014293246297676, 0.010958639747776, + 0.0102568748296613, 0.0101386684440943, 0.00917121303443388, + 0.00675836269733213, 0.00328353824761402, -0.000175417775243011, + -0.00287526175280472, -0.0048092867310441, -0.00671931873817486, + -0.00912866541587344, -0.0121286629956301, -0.0156710072412646, + -0.0201454833816807, -0.0259254355853884, -0.0332980251370496, + -0.0415891243254608, -0.0495104170303735, -0.0560232253887689, + -0.0613377142642127, -0.0658656611088857, -0.0691627658293908, + -0.0706064532212712, -0.0711520997884968, -0.0716456937102125, + -0.0723831798584326, -0.0737993538189391, -0.0769588595918395, + -0.0824309033497734, -0.0894786282291954, -0.0982394703861939, + -0.106827986988789, -0.11428624912294, -0.122124865735873, + -0.130898188787242, -0.139737756559222, -0.14694297537471, + -0.151379478908523, -0.153411211835949, -0.154352199522742, + -0.155236994714349, -0.1562823259722, -0.157766405593793, + -0.159812688930286, -0.162532555715972, -0.166292273995799, + -0.171309984058306, -0.177419226183327, -0.184993937268005, + -0.194402200046002, -0.205353113535707, -0.217035226441322, + -0.228685215684472, -0.239767763484863, -0.249805557085992, + -0.2587840019169, -0.267108978563804, -0.274414115266576, + -0.280474796275069, -0.28579754748135, -0.290947006781766, + -0.295725115191676, -0.302713623400693, -0.308554784386535, + -0.314504281692348, -0.319944093376546, -0.324490589731718, + -0.327025451070466, -0.327613281065322, -0.32953159136184, + -0.334472165553054, -0.339557643795319, -0.342291231907908, + -0.34302250220786, -0.344097327497549, -0.347691271973335, + -0.353834149246572, -0.361845161741869, -0.372211567715615, + -0.384755602698332, -0.397207364449332, -0.407557322569954, + -0.415930383900182, -0.421722250272464, -0.42443365326246, + -0.424209331580279, -0.422508023497969, -0.420389831870815, + -0.417121041802701, -0.412909796681759, -0.409145165484465, + -0.407554768734571, -0.406536901252386, -0.408634103383819, + -0.409363331145365, -0.405468325256687, -0.407218203792733, + -0.410127689551131, -0.411141717878047, -0.409838300753381, + -0.404229344911069, -0.405555681490835, -0.41004372343965, + -0.406225343343696, -0.390945620099306, -0.37317826510498, + -0.361933096091818, -0.356324700313697, -0.358398317470369, + -0.364267761153824, -0.368803115093469, -0.372796076804051, + -0.377459235967425, + -0.155381262302399, -0.210197611595988, -0.234716096268082, + -0.232647405009956, -0.207372592895757, -0.182090345461213, + -0.158018723479495, -0.163634169576733, -0.155258543480092, + -0.112008763930151, -0.0602441109976988, -0.0175002580472131, + 0.0117005054798867, 0.0292193530004348, 0.0374865576433648, + 0.0453522368745021, 0.0610418808857452, 0.0862482886927032, + 0.110570198145618, 0.127000984247691, 0.13594737380113, + 0.140229776535004, 0.141872344146627, 0.141455880651642, + 0.13922234965863, 0.135534058858807, 0.130170721251421, + 0.122837803054012, 0.113359540355631, 0.10196390546598, + 0.0894019152073405, 0.0770045801577244, 0.0665583110051338, + 0.0592848313246282, 0.0538465710595946, 0.0482850165004469, + 0.041160487040814, 0.0327141964599545, 0.0240223566892667, + 0.0165214818477259, 0.0102162024381181, 0.00686208652606249, + 0.00638479058870247, 0.00669115836691773, 0.00639792730768015, + 0.00485640693959758, 0.00232027803301425, -0.000500170638868118, + -0.0029088351012564, -0.00469829841864948, -0.00632462707512054, + -0.00822048962908095, -0.0106657071756738, -0.0140298136370283, + -0.0190377321039365, -0.0260024946071802, -0.0348484931525194, + -0.0444979247751179, -0.0535111005417898, -0.0608798555490508, + -0.0667976830991166, -0.0715831101653338, -0.0748251937497357, + -0.0758463367069645, -0.075448398781522, -0.0749635094228559, + -0.0748188550006997, -0.0752461371976537, -0.0771553827347438, + -0.0813960246564009, -0.0883004378521634, -0.0979443915860168, + -0.107343446562457, -0.115286401593681, -0.123477312237823, + -0.132533109996843, -0.141463302089662, -0.148788587519528, + -0.153433958635462, -0.155567541367045, -0.156268182613611, + -0.156801371429479, -0.15760795940171, -0.158863911637383, + -0.160721335748809, -0.163211937092767, -0.166629957872679, + -0.171148621654588, -0.176716835352707, -0.183636930290185, + -0.192423606119239, -0.203395506285385, -0.215862077504127, + -0.228574185294247, -0.240444428247391, -0.250932079178078, + -0.260380606982297, -0.269113003748823, -0.276670687442082, + -0.283208099681022, -0.289459412166606, -0.295709807071745, + -0.301385218107423, -0.309043530882289, -0.314598056136008, + -0.319352146327341, -0.322622293007153, -0.324449521416878, + -0.324151336320421, -0.322322744213216, -0.324085825165976, + -0.329888602175038, -0.335546038845037, -0.338746747454671, + -0.340249368194914, -0.34280594657425, -0.348190390574844, + -0.356171513182371, -0.365257165691446, -0.375213386806828, + -0.386752410369605, -0.39854352730959, -0.408188198825534, + -0.415280120095941, -0.420004950564661, -0.422529917102346, + -0.422780531829096, -0.42124990111004, -0.418576625164967, + -0.414809170806716, -0.410039483731016, -0.405656461713352, + -0.404658837688307, -0.404066738172396, -0.407927375944173, + -0.411252040630869, -0.408872904732107, -0.407769840257878, + -0.406460089851603, -0.404835143773105, -0.401622861792595, + -0.396237731650645, -0.393435663672187, -0.394548943491891, + -0.397788926853575, -0.394362856756927, -0.383902586084298, + -0.370481209001159, -0.359183296810403, -0.358367381220779, + -0.363482249227247, -0.366709155960997, -0.365644506348024, + -0.363699197016731, + -0.155381262302399, -0.215070144300227, -0.247121961065208, + -0.236802629454166, -0.212480004269644, -0.187198071968621, + -0.162017061048944, -0.154899169072373, -0.161815136383619, + -0.137208811953576, -0.0864152316951886, -0.0345118692515825, + -0.00156625758637897, 0.0153832156595407, 0.0246456922786239, + 0.0358864211921705, 0.0557059701859298, 0.0849157814809522, + 0.111582264768624, 0.128493630660923, 0.13722054631017, + 0.141294674178901, 0.142816826862241, 0.14206234906661, + 0.139380023251205, 0.135394427433313, 0.129853801183591, + 0.122135788430822, 0.111889553749962, 0.0990948661269893, + 0.0845804811112359, 0.0699475552292197, 0.0576050134856674, + 0.0494001150811038, 0.0439868448809611, 0.0392125735752452, + 0.0333122876282462, 0.0260098498729375, 0.0181504155029237, + 0.0112519876518435, 0.00536480140687256, 0.00230387822460664, + 0.00211567596415134, 0.00278255884262424, 0.00305034808558345, + 0.00231624044765746, 0.000737503439074586, -0.00131464773789419, + -0.00332609481240704, -0.00506329349895666, -0.00670733136802707, + -0.00856970374418734, -0.0109800186183129, -0.0144026020945122, + -0.0196675347383413, -0.0272350131271802, -0.036990325004516, + -0.0478014216241989, -0.058138437514929, -0.0665333389495411, + -0.072937977230287, -0.0776965841027629, -0.0808867304438489, + -0.0819207771734387, -0.0812103905164221, -0.0800272088089056, + -0.0793050187231369, -0.0794025898554898, -0.0805434467822212, + -0.0830540866463153, -0.0882371253922788, -0.0971849754661187, + -0.106504766009829, -0.114941981038764, -0.123886596434187, + -0.133710407413065, -0.143161342295834, -0.150783767332068, + -0.155713529136579, -0.158182885078825, -0.159222202300749, + -0.159898223162195, -0.160826497373293, -0.162111902944438, + -0.163769708379963, -0.165988246366645, -0.169220168314101, + -0.173659938601176, -0.179260878416172, -0.186343307444168, + -0.195320278704789, -0.206471671371646, -0.219286571621004, + -0.232362511677777, -0.2439997764633, -0.254190073151117, + -0.263629985800701, -0.27249994719743, -0.280068217369485, + -0.286750496328351, -0.293555685185767, -0.300765340743411, + -0.307706307361407, -0.316136271566, -0.321427316074316, + -0.324495896690005, -0.32524209434741, -0.324328629069623, + -0.321247549033675, -0.317765012335872, -0.319284804921616, + -0.324814525786507, -0.330566201879927, -0.334679067502464, + -0.337840734605612, -0.342357557832869, -0.349752027892768, + -0.359642736485452, -0.369790433132703, -0.379461113354147, + -0.389519885430742, -0.399531228522414, -0.407510368059943, + -0.413256956211295, -0.417392485677362, -0.420121987606894, + -0.42135611554464, -0.419818727761079, -0.414058154911285, + -0.408138036811326, -0.404496074212928, -0.403128169243818, + -0.402618806999881, -0.403142902105719, -0.406409262821097, + -0.407917510306071, -0.409368090548542, -0.408653116616146, + -0.406170521682735, -0.403108619468767, -0.398088613279321, + -0.392872969438608, -0.387908912675327, -0.384902965997002, + -0.386162587941833, -0.386059573048873, -0.38102963618986, + -0.370049227749962, -0.357255318625693, -0.355282014166059, + -0.358683660502166, -0.358185843520335, -0.350535270912652, + -0.337929234324539, + -0.155381262302399, -0.154975634094175, -0.259526405192721, + -0.240571691498797, -0.217588095556266, -0.192306363262504, + -0.167166547961669, -0.151985544936688, -0.155447027524839, + -0.144072073773494, -0.103632606650634, -0.0527598702550542, + -0.0190411100477922, -0.00117716335843066, 0.0123639904224136, + 0.0295786458019767, 0.053882516670002, 0.0843583846953117, + 0.1111920014693, 0.128148965593229, 0.137076706078784, + 0.141144923757303, 0.142366703252498, 0.141147395033579, + 0.138138619799937, 0.134073078378485, 0.128365593097483, + 0.120423495074641, 0.109660754307086, 0.0958266698302648, + 0.0797032831294545, 0.063210931098355, 0.0491811623359755, + 0.0395879221013178, 0.0332350509011275, 0.0283601804528656, + 0.0232732416264102, 0.017283189280524, 0.0107997880507868, + 0.00504185826322184, -1.12128558424506e-05, -0.00254610252749609, + -0.00245207482293269, -0.00145046923024579, -0.000594331319505419, + -0.000505345013789252, -0.00120233612028044, -0.00250686374081084, + -0.0040524862227099, -0.00567010128784467, -0.00756412362759377, + -0.00999421062371753, -0.0130287289549096, -0.0167746307378637, + -0.0219883613852348, -0.0295119493332324, -0.0394742316389093, + -0.0509642229357414, -0.0623048503655114, -0.0715873720077026, + -0.0784464711713889, -0.0831282199298229, -0.0864717062164723, + -0.088155019249314, -0.0879218071668714, -0.0865526690294919, + -0.0854443246426903, -0.0852376370501645, -0.0857164672277499, + -0.0867404733195498, -0.0897976064328898, -0.0971046948924479, + -0.105732479761664, -0.114594038111621, -0.124297194661193, + -0.135004311817316, -0.145171375819328, -0.153267544057073, + -0.158684505503815, -0.161839590326289, -0.16358348721751, + -0.164788974703051, -0.166030752002921, -0.167348742255235, + -0.168819103676393, -0.170727102607325, -0.173817829682754, + -0.178376700347523, -0.184389912677959, -0.192287112382384, + -0.202114889629435, -0.213693675255807, -0.226413129913391, + -0.239113934244019, -0.25216872624709, -0.259769707432192, + -0.268904939984977, -0.277603139449143, -0.285037159099138, + -0.291524478222725, -0.298316679095375, -0.305896437800204, + -0.313487444953871, -0.322081822951373, -0.326841549920664, + -0.32833571596682, -0.327014033370646, -0.323751145258122, + -0.318637269918036, -0.314645863796475, -0.315722361283288, + -0.320244907774493, -0.325227205798613, -0.329844909649576, + -0.334588529402308, -0.341101896103574, -0.350754586575106, + -0.362592188328134, -0.373555320468572, -0.382801828562437, + -0.39143176799646, -0.399635274259199, -0.406174936999274, + -0.410894797811673, -0.414485417142817, -0.417302413892242, + -0.419009506949074, -0.417073394451282, -0.410323219587343, + -0.404821605917786, -0.402702595734166, -0.404323110045445, + -0.402307125989608, -0.403256382945599, -0.405229492736863, + -0.403652973582984, -0.405271989000721, -0.407491584371179, + -0.408531093486337, -0.407695180058471, -0.400951255441075, + -0.393942003319369, -0.388315080848133, -0.382123270721228, + -0.37962533771848, -0.381279568967394, -0.380344255036716, + -0.368178936879108, -0.352759331595927, -0.347966023019392, + -0.347429633219745, -0.344931053542088, -0.332840602610299, + -0.316620736164503, + -0.152327105402946, -0.152327105402946, -0.271934659293686, + -0.23516965610595, -0.222696895994939, -0.197414806437282, + -0.172317040746644, -0.15540657981374, -0.157042856660261, + -0.150660355882226, -0.123677597679179, -0.0800279600475929, + -0.0431421097993647, -0.0191630944061683, 0.000826922989531075, + 0.0235689007279586, 0.0508877289048722, 0.0812534288928305, + 0.108200656160761, 0.125967810694934, 0.135535673504192, + 0.139686516530711, 0.140483417238527, 0.138746959098306, + 0.13570288576015, 0.131800496612691, 0.126074869604357, + 0.11804725275695, 0.1069486042361, 0.0923280264126368, + 0.0750091193380226, 0.0574163060636081, 0.0422084133012515, + 0.0310857344402199, 0.0232238476187092, 0.0175029019218694, + 0.0126959942689776, 0.00787646217723593, 0.00295820198679298, + -0.0013214266732763, -0.0053209402576273, -0.00732677481721589, + -0.0071139128694707, -0.00598488863038149, -0.00466205414622218, + -0.00379678750620643, -0.00364986942667322, -0.00419545915200824, + -0.00517878222800212, -0.00671051164309161, -0.00933024205865136, + -0.0131174601270239, -0.0173927247221788, -0.0216487687416459, + -0.0266667050573252, -0.0337566146371267, -0.0433053829417526, + -0.054606704861618, -0.0659903428268459, -0.0755584365705544, + -0.0827306533589471, -0.087567549581649, -0.0913464195609052, + -0.0940857613895424, -0.0948152978729283, -0.0940116264003847, + -0.0929122378749936, -0.092131078693499, -0.0913086063521556, + -0.0906334807118188, -0.0918239116713462, -0.0976831389541491, + -0.105643985597378, -0.114787683651808, -0.125208059723831, + -0.136895852798205, -0.147886421508353, -0.156632994629292, + -0.16287356329661, -0.167117260887134, -0.16977119158862, + -0.171471863201627, -0.172827455839417, -0.174039451170181, + -0.175253264607123, -0.176986726105154, -0.180021495016628, + -0.184755596411972, -0.191276143687454, -0.200187566432486, + -0.21111113329303, -0.22315458135725, -0.235522653515386, + -0.247440154803764, -0.259391755837916, -0.266978328920233, + -0.275963871743813, -0.284569291170522, -0.291702057136146, + -0.297593698600654, -0.303747727455333, -0.310880776394531, + -0.318215125879297, -0.326157343673896, -0.330094458552532, + -0.330473826717757, -0.327437497324186, -0.322327310641049, + -0.316663969266137, -0.313340160312753, -0.314030502305964, + -0.317191336824318, -0.320795595927083, -0.324851759413616, + -0.330164154633316, -0.338005648168965, -0.349473928831253, + -0.363266749821436, -0.375739320522537, -0.384948608602962, + -0.392434363055908, -0.399359280170872, -0.40497834708884, + -0.408865781655984, -0.411650537162846, -0.413968510251304, + -0.415572829886495, -0.414744980700697, -0.40973828360408, + -0.402542521279493, -0.399183998361085, -0.399934446531665, + -0.399899939009681, -0.400630290048995, -0.402454109939646, + -0.405933151072043, -0.404368926755249, -0.405807363631879, + -0.408625639847802, -0.410820601875285, -0.405004612174052, + -0.398708249574006, -0.391932094639211, -0.384425438052823, + -0.386073068326003, -0.392368396853228, -0.384655101440435, + -0.357162100858666, -0.339535085118544, -0.335534239560823, + -0.332109547121549, -0.330704754280878, -0.317684117654184, + -0.30159415915089, + -0.152327105402946, -0.152327105402946, -0.284342062285229, + -0.235783129930157, -0.227805551266802, -0.202523472900855, + -0.177467639331672, -0.158777446315139, -0.160922952042444, + -0.160725479559363, -0.146551401297108, -0.11168151434433, + -0.0697039636726996, -0.0363746283901299, -0.0104737632411648, + 0.0154735533665082, 0.0444860702147845, 0.0750645332249289, + 0.102949331505058, 0.122045138871681, 0.132393275918403, + 0.136603039199095, 0.137181242439576, 0.135592952330424, + 0.132694105756646, 0.128950283256279, 0.123450342753668, + 0.115439356134656, 0.104070497017788, 0.0888404338881331, + 0.0710129575290716, 0.0530388889619469, 0.0371751231473999, + 0.0248602579734919, 0.0155136358379216, 0.0086034358230631, + 0.00350973277422509, -0.000626314317206706, -0.00420040349554283, + -0.00699679158628073, -0.00993817475257388, -0.0116135363316986, + -0.01167667730673, -0.0108485439057842, -0.00940130917937433, + -0.00795641552069581, -0.00701799965713753, -0.00672298826400986, + -0.00707524496324775, -0.00876072019924469, -0.0128788338811193, + -0.0189133071585019, -0.0249364641774633, -0.0297392431288491, + -0.034480280449694, -0.040946072323468, -0.0496541799070432, + -0.0600229347909467, -0.0705613853416482, -0.0797465847879965, + -0.0867357665641733, -0.0916462146226811, -0.0959217745175465, + -0.0997635932144465, -0.101677251498092, -0.101678218171372, + -0.100526581111844, -0.0987900471227854, -0.0964348244389754, + -0.0940863579921188, -0.0937792436081596, -0.0986230383370602, + -0.105832359765123, -0.115110842843384, -0.126517330468762, + -0.139515734055941, -0.151538173789868, -0.161053083821768, + -0.168315687897662, -0.173900381991083, -0.177682363881881, + -0.17977617768168, -0.18077895162065, -0.181484536913091, + -0.182408286353716, -0.184129997578607, -0.187294823679757, + -0.192313240300949, -0.19934768895875, -0.20910241295973, + -0.220828124007666, -0.233176352090928, -0.245030788599173, + -0.256056850289889, -0.267091101625117, -0.274866139683275, + -0.28366330232481, -0.291944653591927, -0.29858529270463, + -0.30387325149982, -0.309181875413107, -0.315210765360354, + -0.321661525986968, -0.328453612495286, -0.331603547900129, + -0.330876106106905, -0.326482565606437, -0.320612652498153, + -0.315878244236119, -0.313698830266483, -0.314138463104476, + -0.315736665292126, -0.317692308295803, -0.320675246867224, + -0.3255874135382, -0.333702525364453, -0.345959244140113, + -0.36154811274448, -0.376441688100832, -0.386551383864044, + -0.393514340888442, -0.399569431772411, -0.404475233192467, + -0.407422372023273, -0.408901369529374, -0.409943111950428, + -0.411150711991141, -0.411501942771662, -0.407505708493794, + -0.401309892555692, -0.399989105038042, -0.398616177078686, + -0.399915503592951, -0.400338471129239, -0.400279981910773, + -0.403117010962711, -0.403555719125826, -0.40463292065863, + -0.406230855319849, -0.408495138452726, -0.405812050290322, + -0.402945846684936, -0.396432710698052, -0.390769925223782, + -0.398437759615595, -0.410084978923146, -0.401412807525282, + -0.362940437330193, -0.328589448346599, -0.32895072737198, + -0.326103617919016, -0.321185635014321, -0.311026618771334, + -0.296434779311318, + -0.152327105402946, -0.152327105402946, -0.290972989607757, + -0.243123409503392, -0.232914148003982, -0.207632409250967, + -0.182618104990794, -0.163108671468576, -0.16240146084259, + -0.165353863723035, -0.158492470335557, -0.131511019510523, + -0.0892522261859929, -0.0494175788785754, -0.0197365994257261, + 0.00718676288554935, 0.0370754895935033, 0.0683659578527119, + 0.0971303097304691, 0.117121354342865, 0.12828759394225, + 0.132902190024543, 0.133537635922756, 0.132349504971904, + 0.129656754556361, 0.125923066694214, 0.120611627194813, + 0.112576565077726, 0.101065295780641, 0.0858426356138121, + 0.0683119912133604, 0.0504953794362923, 0.0344826037141917, + 0.021433158748788, 0.0109145816272717, 0.00278377253258661, + -0.00300474875555, -0.00697636146826908, -0.00964407642694818, + -0.0112704421373196, -0.0134005802575362, -0.0151262192974061, + -0.0160183185104483, -0.0160590835153941, -0.0149552548312226, + -0.0132344576366619, -0.011609701727868, -0.0104815826302734, + -0.0103244186515568, -0.0126120486259447, -0.0189086046844493, + -0.027646141875815, -0.0355254296376912, -0.0408467314432188, + -0.0452350114310752, -0.0508564396273441, -0.0583604570603437, + -0.0673473815100257, -0.0765938216183742, -0.0849181071456417, + -0.0913855813469185, -0.096100634653641, -0.100517909470716, + -0.105023941303251, -0.107955500676464, -0.108651762246344, + -0.10718343791587, -0.104386223334221, -0.101004956541312, + -0.0977586809852304, -0.0966224754096215, -0.100636324553522, + -0.10668914916262, -0.115929392002081, -0.128701706854893, + -0.143219876862019, -0.156292135615291, -0.166536597126726, + -0.174741822994085, -0.181567417027504, -0.186527072612148, + -0.189066937104822, -0.189607474635129, -0.189646510514892, + -0.190260508772542, -0.192113103746574, -0.195652417791187, + -0.201185625013745, -0.208768971963424, -0.218864752970358, + -0.230879465750266, -0.243097162173878, -0.254189888855165, + -0.264354767046436, -0.274739863500631, -0.282825808857303, + -0.291069680421239, -0.298333243460084, -0.304065988335252, + -0.308748842000268, -0.313288798523338, -0.318011828304875, + -0.32344900050748, -0.329181936610015, -0.331528499174091, + -0.32962123312674, -0.324615119873377, -0.319484479957727, + -0.315953460458592, -0.314659630389725, -0.315036843732624, + -0.315290674005189, -0.315763219260669, -0.317868627430262, + -0.322549222914066, -0.330357344570002, -0.34234662671533, + -0.359053853475406, -0.376322332281875, -0.388442173211776, + -0.3956187768444, -0.400996463913042, -0.404955033529963, + -0.406584364060658, -0.406474751626327, -0.406222377079382, + -0.406916931133932, -0.407470045815789, -0.404742609684598, + -0.400402933132506, -0.399566798329427, -0.396889414121817, + -0.397165118529392, -0.398306006108065, -0.399021903867156, + -0.400275367910095, -0.404978528721535, -0.407411340307974, + -0.40752210436267, -0.407416553782289, -0.406204478570303, + -0.40552316709852, -0.403733754679484, -0.402756757619105, + -0.410686873551927, -0.422280227282232, -0.421811779191618, + -0.389021654050277, -0.35001560896794, -0.345320679800173, + -0.335703706656075, -0.323694639667979, -0.308582572699817, + -0.289891927316723, + -0.152327105402946, -0.152327105402946, -0.302905610746989, + -0.240776184753552, -0.238023306506881, -0.21274136711765, + -0.187544365396191, -0.167440593651529, -0.164407957644641, + -0.167807831012148, -0.168370025400943, -0.147901944725315, + -0.107432475870546, -0.0640258058911485, -0.0293314054227175, + 0.000600403532166345, 0.0319418621381373, 0.063473947148294, + 0.0919255492184406, 0.111607263347563, 0.122750481210559, + 0.128161675071922, 0.129398374248363, 0.128957624066396, + 0.126763654683701, 0.123164601039345, 0.117867875987684, + 0.109774270569951, 0.0984400310544445, 0.0838787812647284, + 0.067175317906586, 0.0500121746917169, 0.0341979490165147, + 0.0206368991188389, 0.00920402874183315, 0.000182171199529233, + -0.00612185013685515, -0.0101119830782934, -0.0124374200721921, + -0.0136169532694119, -0.0155729101065342, -0.0178142604660989, + -0.0199347316395927, -0.0212921337348943, -0.0209282736023545, + -0.0192181865368629, -0.0171650042462237, -0.0156885175111392, + -0.0157682652505518, -0.0192345749516151, -0.0274984655796076, + -0.0381226572458707, -0.0471590309339505, -0.0528752148718872, + -0.0569389716434908, -0.0615581531255627, -0.0676749364455313, + -0.0751855182414957, -0.0830093511831496, -0.0903031720719031, + -0.096368561865957, -0.101046470625194, -0.105422827152479, + -0.109964242155926, -0.113384926783451, -0.114768640658446, + -0.11348568445101, -0.110178753050471, -0.106239545832631, + -0.102699666467118, -0.10114778169817, -0.104276390746203, + -0.109467657210313, -0.118973545112221, -0.132793014420198, + -0.148451560542002, -0.162288958696129, -0.173068273048232, + -0.181989092440006, -0.189489657235511, -0.195033816330305, + -0.198069399214696, -0.19876814935028, -0.198646264705836, + -0.199095886134889, -0.201111550692376, -0.205292726479392, + -0.211709644677131, -0.219775368585195, -0.229641534680749, + -0.241089943683413, -0.252659371959045, -0.263066458902144, + -0.27273370196833, -0.282254762576459, -0.290486071549835, + -0.297521245199863, -0.303097172931778, -0.30755774234307, + -0.311503990217106, -0.315328582693325, -0.318870177563711, + -0.323576790998682, -0.328247466218711, -0.329865541727723, + -0.327236365639071, -0.3225231876025, -0.318543648275251, + -0.316182657288646, -0.31556264194962, -0.315565672398964, + -0.314784950465166, -0.314472320094345, -0.316548185106138, + -0.321617904957634, -0.329556751979812, -0.341094766974034, + -0.358104003720043, -0.37717605089081, -0.391493416812002, + -0.39936118157029, -0.40394627020827, -0.406478465622397, + -0.406590618832991, -0.405433954548826, -0.40500157828635, + -0.406095523258236, -0.407263591935286, -0.406154860115951, + -0.403023800717319, -0.399978351886946, -0.397037257031284, + -0.398898674494438, -0.398788593138764, -0.399159155951007, + -0.401540516728949, -0.407454155989614, -0.409852714810055, + -0.410281247461465, -0.410379451213696, -0.408689196770307, + -0.40789216575389, -0.409976381237729, -0.413811725291286, + -0.421845979976649, -0.431078588150423, -0.437372880153727, + -0.424764183597563, -0.395889497717356, -0.37316138260418, + -0.35430375102359, -0.337201521561657, -0.312693009807713, + -0.289078419912903, + -0.152327105402946, -0.154499632513743, -0.160375356899093, + -0.244012448493795, -0.243132892219492, -0.217850698925744, + -0.192568705315126, -0.1717733156874, -0.168544137937574, + -0.172118109759696, -0.175016640650337, -0.167232551797628, + -0.135680254750683, -0.0895938289231521, -0.0437740614162575, + -0.00545671838404701, 0.0283728380503604, 0.059649785691658, + 0.0861137401522059, 0.104626204932924, 0.115549945129864, + 0.122180421709384, 0.125033235035214, 0.125642389571932, + 0.123894467343979, 0.120556888596309, 0.115136717697672, + 0.107024200764377, 0.0964198955151172, 0.0831609735561502, + 0.06776621751908, 0.0517488297805305, 0.0364879951988991, + 0.0226714887600319, 0.0107532849961527, 0.00147882603493546, + -0.00476729423518135, -0.0089133729264626, -0.0118223828464947, + -0.0137782426762353, -0.0165548026583596, -0.0197733638208699, + -0.0231712161305836, -0.0259096272258284, -0.0264952140432415, + -0.0251610604920834, -0.0233766105641943, -0.0227916949980265, + -0.0244070635781267, -0.0293682963697973, -0.0383561629863667, + -0.0491302113930711, -0.0582451846845122, -0.0641174555864018, + -0.0678437165566062, -0.0714193337443705, -0.0760953963004917, + -0.0820893010329218, -0.0885880486550543, -0.095054435583895, + -0.10099721714007, -0.105928581211609, -0.11032522516015, + -0.114517838347667, -0.118006631621785, -0.120208884727007, + -0.119830207009485, -0.116680044213572, -0.11232777060249, + -0.108423224643926, -0.106504815135426, -0.109151619838192, + -0.11405314481708, -0.123942234784789, -0.138041945884975, + -0.154100773890701, -0.168477931054384, -0.179702138810042, + -0.189090545091352, -0.196768252575802, -0.202332290618208, + -0.205797297133891, -0.207309199599596, -0.207799066270738, + -0.208473326690129, -0.210725056578566, -0.215665708282454, + -0.223053898745688, -0.231442177080902, -0.24075099312174, + -0.251131463665621, -0.261778071697098, -0.27186037507645, + -0.281377795258042, -0.292316669301608, -0.297451395084848, + -0.302695506512653, -0.306395604888053, -0.309554512207509, + -0.31277676251659, -0.315966782487636, -0.318553640807364, + -0.322656510711797, -0.325926863441035, -0.326856423764376, + -0.324157008113857, -0.320184368724179, -0.317238655258501, + -0.316057926163534, -0.315830273646945, -0.315073576273508, + -0.313544850010518, -0.313160961544486, -0.315845320785046, + -0.321753363155093, -0.330510404811284, -0.342655519834976, + -0.359876691937908, -0.3800566680149, -0.395859322604133, + -0.404065670156309, -0.407800250691029, -0.408815789522955, + -0.407671649571121, -0.406588213561408, -0.407280099998927, + -0.409651213587999, -0.412094023460655, -0.412319150238394, + -0.409986292720272, -0.406156847512516, -0.401963440785842, + -0.401667499438061, -0.399539175890174, -0.398738446269285, + -0.402483035184457, -0.407407959216547, -0.409541454594343, + -0.410330593359426, -0.410096889823163, -0.409222546368218, + -0.410108306214161, -0.414113038795187, -0.420195663918335, + -0.428902395506166, -0.438071752985044, -0.44577956298883, + -0.442008239172954, -0.418220781100202, -0.385959618387766, + -0.36619416150578, -0.354338884316585, -0.328669630131535, + -0.301121322203106, + -0.157487564600444, -0.157935321331024, -0.165621628495762, + -0.256422760096726, -0.248242446429484, -0.222960190919337, + -0.19767801195681, -0.176107416286937, -0.172680323561114, + -0.170361561656006, -0.176346680823448, -0.18068381304137, + -0.164325699771386, -0.121444518457937, -0.0655194162816451, + -0.0159604939615295, 0.0209923968059746, 0.0511411123381874, + 0.07623331922455, 0.0949156205629624, 0.107261923980763, + 0.115827440711694, 0.121155741290489, 0.122620286728534, + 0.120986758447255, 0.117562421264959, 0.112020095701982, + 0.104401348788402, 0.0952502216847109, 0.0839488243738787, + 0.0705438175711621, 0.0562517288352846, 0.0419537642716373, + 0.0284184659176395, 0.0168923682637373, 0.00849034862184247, + 0.00301626497893793, -0.00165237380352159, -0.00654613657998027, + -0.0111052352742815, -0.0161354598588675, -0.0209625925772395, + -0.025554509659679, -0.0294128031678715, -0.0310953390515363, + -0.0308445152312903, -0.0304246883746936, -0.0318642855334714, + -0.0357181614999753, -0.0416965636472188, -0.0500066992215934, + -0.0594290896362109, -0.0677281816569258, -0.07345909398565, + -0.0769508158011689, -0.0797894470833006, -0.0832631155988955, + -0.087836313233017, -0.0932764166871923, -0.0993450283370186, + -0.105285361863251, -0.110384868926819, -0.114791181345094, + -0.118695865157231, -0.122078862840384, -0.124691362255428, + -0.125117418606365, -0.122504516135289, -0.118162233122017, + -0.114083594780881, -0.112114610420165, -0.114846569977732, + -0.119543433443309, -0.128953300955713, -0.142486021992482, + -0.158328673984441, -0.172798235803322, -0.184449281844531, + -0.194241556089691, -0.202100001899089, -0.207680637098227, + -0.211678116985519, -0.214291051607494, -0.215799489773257, + -0.217066716575149, -0.219777948435075, -0.22542785089245, + -0.233753879526695, -0.242659119638133, -0.25157402661846, + -0.260717761847275, -0.27035638297587, -0.280183197569412, + -0.289548491817338, -0.298969374710126, -0.303347577443615, + -0.306660015233001, -0.308687532982433, -0.311026529253784, + -0.31388473436464, -0.316546201501582, -0.318373752401136, + -0.321723718841685, -0.323264534569425, -0.323072650917426, + -0.320672866030712, -0.317758720697138, -0.316107404583637, + -0.315490012700346, -0.314876344723103, -0.313567417985559, + -0.311894517423026, -0.311902066007281, -0.315253195200199, + -0.322186792557979, -0.332221488700669, -0.345410092968561, + -0.363035198293515, -0.383804357614196, -0.399869008454996, + -0.407867322651105, -0.410927617532023, -0.411282483478415, + -0.41014601711054, -0.40962417187983, -0.410852900663296, + -0.414042751937715, -0.41761517741545, -0.419341888434073, + -0.418647561069747, -0.415341602802673, -0.41035509701794, + -0.405397042147257, -0.401141228646318, -0.400847180669104, + -0.40443791646282, -0.407584670875909, -0.409211715968963, + -0.409782760576677, -0.408662764736089, -0.408429264819574, + -0.412240332261306, -0.418747015009185, -0.425494720206473, + -0.433563401659198, -0.44039844319146, -0.440741463341825, + -0.429433802004421, -0.401889833991764, -0.368022494656644, + -0.354474891487644, -0.344806714597901, -0.308947717408179, + -0.282763725420549, + -0.170035388277457, -0.172293782234192, -0.172293782234192, + -0.268834505153175, -0.2533336274361, -0.228069393064024, + -0.202787705640495, -0.180442004064454, -0.176816537263419, + -0.174497681912375, -0.174806605755975, -0.18264847133404, + -0.183142197237587, -0.155517714218266, -0.0984734330988028, + -0.0377318155895472, 0.00644875631283044, 0.0371035009733476, + 0.0624829629484968, 0.0837060362498478, 0.0990001107210645, + 0.109899507175013, 0.117482840051051, 0.119641272692263, + 0.117712410417635, 0.113871594852544, 0.108444042698063, + 0.10207339154414, 0.0949434139127097, 0.0863079956007924, + 0.0755936962954802, 0.0635039042000389, 0.0506164621887416, + 0.0379292387760281, 0.0273717492515903, 0.0203714591788498, + 0.015957689914362, 0.0106331846146216, 0.00282616244159028, + -0.00565763615138842, -0.0139841916992559, -0.0209227663302601, + -0.0266508454796599, -0.0313682406805683, -0.0342740677452433, + -0.0356942167682033, -0.0371673419867264, -0.040324990720935, + -0.0448886965061978, -0.0507677163142057, -0.0583989724287875, + -0.0667333829150823, -0.0743341647714744, -0.080052313949434, + -0.0838747046729669, -0.0868337796128955, -0.0899526678172747, + -0.0936651640401758, -0.0982349422227465, -0.103803638781595, + -0.109498960898259, -0.114501267210787, -0.118955220980298, + -0.122766236418091, -0.125987650997534, -0.128523528671936, + -0.129114059953029, -0.126989832104923, -0.123159334483772, + -0.119465742700177, -0.117651118685049, -0.120373381477532, + -0.124435904757475, -0.132718225294713, -0.145390946315201, + -0.160580930333816, -0.174734582644603, -0.186804440992197, + -0.196998842497397, -0.205093609231287, -0.211073516857243, + -0.215787981761796, -0.219514100879519, -0.222240020114135, + -0.224419206285122, -0.227643188623467, -0.233755154565725, + -0.242906213827041, -0.252708355187337, -0.261420986024329, + -0.269443944281795, -0.278131695347342, -0.287539385030017, + -0.296511434843138, -0.304678831714323, -0.308297748570182, + -0.30999678239679, -0.310851271037122, -0.312991816478546, + -0.316083022611124, -0.318523092022925, -0.31971951060907, + -0.322068274024545, -0.321843043599348, -0.320559381014147, + -0.318235363617824, -0.316191324339779, -0.315617228852897, + -0.315148828613478, -0.314026120488483, -0.312528073398293, + -0.311001252896925, -0.311172657211093, -0.314988127117776, + -0.322887403842988, -0.333972156583841, -0.347685659823764, + -0.36499335530012, -0.384879605018792, -0.400238709697559, + -0.408223414820181, -0.411498904674005, -0.412806325338614, + -0.412957079792101, -0.411665164130437, -0.409422168937571, + -0.410980306909732, -0.415632168432399, -0.419818876663362, + -0.421779994394527, -0.42161017939836, -0.419150830229734, + -0.414139224469825, -0.409216175380946, -0.409216733948471, + -0.411279728458681, -0.411892174468285, -0.41141241148895, + -0.410283181260818, -0.408188805192211, -0.408232866303531, + -0.413925337327018, -0.422120488255597, -0.428814719136986, + -0.434271974362014, -0.43401958998452, -0.421742830663342, + -0.398287755076238, -0.369384271172102, -0.349160795298475, + -0.338901976115697, -0.317991049520581, -0.280509252040909, + -0.271827322932538, + -0.172293782234192, -0.172293782234192, -0.172802658064983, + -0.281246697940025, -0.257087384128945, -0.233179651107025, + -0.207897445596406, -0.184778168442853, -0.180952715679951, + -0.178633976961093, -0.176219560189984, -0.179292354736359, + -0.184309878849665, -0.172912605033252, -0.12926772547472, + -0.0675447506345888, -0.015882312379851, 0.0195509321443916, + 0.0477706259266486, 0.0727335263931025, 0.091386742169104, + 0.104353129674402, 0.113656965353358, 0.116889373388532, + 0.114589756906152, 0.110532524998624, 0.105570469965707, + 0.10071297715737, 0.095913436766432, 0.0902479312606707, + 0.0826871175260045, 0.0731527698335701, 0.0620878087619985, + 0.050693549069741, 0.0412096052317056, 0.0351458642999572, + 0.0312758801743146, 0.0249224610395615, 0.0142412604687614, + 0.0020152848117862, -0.00958255330079779, -0.018579562264326, + -0.0252754266086836, -0.0305355733626739, -0.03443778872875, + -0.0373753885970723, -0.0403064968249813, -0.0441015605579556, + -0.0483210562803374, -0.0535568579629682, -0.0609380470142669, + -0.0691082400682209, -0.0767324494312373, -0.0831557849244963, + -0.0881915955560249, -0.0922578515410312, -0.0959805823173321, + -0.0997084590247982, -0.103733906250229, -0.10843662845867, + -0.113427727803457, -0.118205806620074, -0.12272149740995, + -0.1265644575778, -0.129605175371574, -0.131900723457949, + -0.132575376126785, -0.131202390153903, -0.128534420443499, + -0.125727989009075, -0.124167497391673, -0.126414615063945, + -0.129385267428483, -0.136450650882007, -0.147866669335418, + -0.161858415084422, -0.175411156504095, -0.187765805404649, + -0.19838268104995, -0.206772051291175, -0.213388486564029, + -0.21904759924409, -0.223964906132328, -0.227857096562559, + -0.23094824450929, -0.234525229919065, -0.240653919506426, + -0.250087320883089, -0.260478124750581, -0.269242520960499, + -0.276902168333288, -0.285104144458927, -0.294007703203614, + -0.302432358079937, -0.309509468209743, -0.312650580020149, + -0.31330277987456, -0.313476311279564, -0.315543409284912, + -0.318979697180938, -0.32171196526538, -0.322827495254298, + -0.324620890029783, -0.322991055240755, -0.320923088936048, + -0.318586115172022, -0.316955931181503, -0.316545988676443, + -0.315820015000944, -0.314405788898307, -0.312969970712796, + -0.311577537498202, -0.31168973331564, -0.315727889190912, + -0.324328899684249, -0.335942800437225, -0.349368222776814, + -0.364893636588563, -0.381942727840671, -0.395707052202362, + -0.403960087415597, -0.408750345444584, -0.412452326158416, + -0.414251419410224, -0.409139214747895, -0.399381528666467, + -0.398046950869848, -0.402395515639554, -0.407254126524883, + -0.41285283564776, -0.418604582630806, -0.422653239096846, + -0.422552420223541, -0.419501245553125, -0.418831024267481, + -0.419164467145883, -0.417396634994479, -0.41501007453592, + -0.4122142615366, -0.409666255821001, -0.410828935669693, + -0.416736845523495, -0.42358944605708, -0.427527367836182, + -0.429429131538794, -0.422797443221556, -0.398305916365788, + -0.367942164351769, -0.351576368762639, -0.34739493814575, + -0.340580017907408, -0.310898919304259, -0.277503676629229, + -0.270772769465557, + -0.17305263876915, -0.17305263876915, -0.17305263876915, + -0.29365887426734, -0.26034662758215, -0.238289894359278, + -0.213008177010699, -0.189908598783589, -0.185089058202707, + -0.182770191126694, -0.180211689178287, -0.177027883803291, + -0.181357656015761, -0.184354998113877, -0.159925366443384, + -0.10700990293397, -0.0495067142486204, -0.00397053223157864, + 0.0309198657443212, 0.0606980201689803, 0.0827453015293091, + 0.0977077760632211, 0.10876930281317, 0.113217786065218, + 0.110673250689669, 0.106161148974083, 0.101680497525242, + 0.0983247950014432, 0.0956280869013018, 0.0924709871287196, + 0.0878019092378328, 0.0808618039110248, 0.0720235316902887, + 0.0621802249008959, 0.0536147493285, 0.0475042534568923, + 0.0423475554108575, 0.0343353475230331, 0.0220380624806088, + 0.00822599600574219, -0.00476673454555402, -0.0148096763242549, + -0.0220968866872064, -0.0276999855411292, -0.0320856872295431, + -0.0357180516993339, -0.0392379042747552, -0.043011084136093, + -0.0471303632976468, -0.0524025238602879, -0.0595532629213514, + -0.0677331731156127, -0.0760094962830035, -0.0838545879975056, + -0.0905558151097459, -0.0959972960632458, -0.100594755898422, + -0.104692162397691, -0.108439108805985, -0.112225043088806, + -0.116351851070903, -0.120813872434943, -0.125393471176, + -0.129325360031813, -0.13235430885502, -0.134622143649609, + -0.135877506750862, -0.136072229357726, -0.135477699299245, + -0.134376298419805, -0.133592503766328, -0.135366614957018, + -0.136866054752979, -0.142225133003599, -0.151548927640649, + -0.163979479862993, -0.176905832440837, -0.189146740369815, + -0.199873032833957, -0.208587638725423, -0.21599822744927, + -0.222798518485828, -0.228963734959456, -0.234005150503678, + -0.237935185041179, -0.241731046147751, -0.247478289144467, + -0.256282539689479, -0.266514920292194, -0.275629847619781, + -0.283576741227784, -0.291624368979505, -0.300005981746116, + -0.307706837938803, -0.313808735951265, -0.316698506811352, + -0.316962074477262, -0.316793420321615, -0.318447404190722, + -0.321698011228375, -0.324562195053504, -0.326062184674578, + -0.327999147190202, -0.326043574579295, -0.323891183650788, + -0.321612247622741, -0.319873863158998, -0.318659606863619, + -0.317238149272506, -0.315613816338186, -0.314371701092453, + -0.313287345597517, -0.313485010317622, -0.317653015213812, + -0.326497451717217, -0.338462905649846, -0.351553794755152, + -0.364696396192993, -0.377937073121678, -0.389841279835656, + -0.398894216302565, -0.405685534149697, -0.410980050415613, + -0.411468610942882, -0.397346664198007, -0.382892566823668, + -0.380366210892404, -0.38042385601352, -0.382885484678024, + -0.391772814924742, -0.40509434769713, -0.41720584833126, + -0.425577173206333, -0.427851373058278, -0.427678998547074, + -0.426579470011328, -0.423540798124462, -0.42008230017054, + -0.416527884987604, -0.41459815726209, -0.416918823718822, + -0.42178081554885, -0.425682791056191, -0.426618936335062, + -0.427454871282059, -0.419046606382467, -0.387875921133481, + -0.361442774307167, -0.351775442173099, -0.341296349881172, + -0.328997437896109, -0.301573700479106, -0.274678439159916, + -0.275695758449339, + -0.17375783473199, -0.173979424764756, -0.174082070589066, + -0.248410607666287, -0.25389363210366, -0.243400734826589, + -0.218118929983927, -0.195458540276641, -0.189225391282776, + -0.186906543158301, -0.18431582501362, -0.178370176627444, + -0.178750139152205, -0.186997355263653, -0.182546046013116, + -0.1494959119344, -0.0937584437646449, -0.0350423662276685, + 0.0112375492684256, 0.0468966119115479, 0.072574765775922, + 0.0899674594281525, 0.102681866922908, 0.1083103493537, + 0.105652614252065, 0.100714314546637, 0.0967527944832017, + 0.0948388719172517, 0.0939475077687063, 0.0925220986783128, + 0.0896435369335621, 0.084804414741153, 0.0779616301254804, + 0.0697496862737783, 0.0618119808733797, 0.0549078724698771, + 0.0477110713486853, 0.0379518208358153, 0.0251343106875064, + 0.01203087689278, 0.00026487793171552, -0.00910734380417336, + -0.0163487379117974, -0.0223946012777091, -0.0273412726110652, + -0.0314276425045357, -0.0352433738479378, -0.0391753785159529, + -0.0435615313142564, -0.0490920758374197, -0.0559994274303191, + -0.0640157786666151, -0.0731833075350331, -0.0827299386084401, + -0.0911018186749005, -0.0977567313388263, -0.103064340862471, + -0.107458407857858, -0.111152581788939, -0.114415580212168, + -0.117903925718272, -0.1220846349117, -0.126696611931498, + -0.130975448356387, -0.134550596362919, -0.137369378466173, + -0.13979910779063, -0.142193689053905, -0.144304411931539, + -0.145673491170847, -0.146648039691724, -0.148597456407084, + -0.148514779258847, -0.151050244064565, -0.157361890614015, + -0.167912282967021, -0.179631420552341, -0.190877454983559, + -0.201011526003985, -0.209836542762951, -0.217955740177614, + -0.225890615330658, -0.233218332669603, -0.239368112197947, + -0.244169940285213, -0.248321876942613, -0.253767201908576, + -0.261768315484736, -0.271457828780498, -0.28087320725386, + -0.289224324153152, -0.297184817628825, -0.305063518455316, + -0.312319275930362, -0.318008165963963, -0.321022895337461, + -0.321479068167436, -0.321333677685064, -0.322385133122676, + -0.324731973088731, -0.326908342517641, -0.328515907201052, + -0.330879152864234, -0.329567487200891, -0.327693392471928, + -0.325465131524966, -0.323250475892947, -0.320835936267589, + -0.31867892800768, -0.317057779222837, -0.316254789713032, + -0.315690736636337, -0.316283235986073, -0.320326856734315, + -0.328915859761984, -0.341070597045828, -0.3542286308215, + -0.366119414463194, -0.376778237579107, -0.387051398090857, + -0.396310795891688, -0.403302597977627, -0.406298889010793, + -0.400284239247743, -0.382773398304637, -0.369899043947972, + -0.366354363002935, -0.361401062950571, -0.357960485780978, + -0.363801686780707, -0.378611250833113, -0.394828164825359, + -0.412545322724037, -0.425626183656, -0.432683368784525, + -0.433463539161015, -0.430978479368441, -0.427539551555895, + -0.423811654081907, -0.422419477303211, -0.425113403832695, + -0.428683672689538, -0.430824071296806, -0.432202029409623, + -0.43245537864873, -0.418735759955679, -0.385161430051642, + -0.365262636392758, -0.355680312519517, -0.321410379686552, + -0.293412725032161, -0.277315551049971, -0.278652023828262, + -0.280410617133821, + -0.174082070589066, -0.174082070589066, -0.174082070589066, + -0.243999384171831, -0.246315977904064, -0.248511447435905, + -0.223229598682675, -0.200060217075759, -0.193361789907271, + -0.191042864019401, -0.188420052973418, -0.182097896621978, + -0.175507443598255, -0.182932071962602, -0.19007007265797, + -0.175021502691157, -0.130526910029266, -0.0660904525624917, + -0.00897875933140454, 0.0326854172559204, 0.06170753189079, + 0.0815377580343028, 0.0950853251613056, 0.100577176073708, + 0.0981448836977661, 0.0938463286637095, 0.0911275789968133, + 0.0905316642036261, 0.0909930675902345, 0.0906933014255824, + 0.0887221430442865, 0.0848291352515542, 0.0791293098200695, + 0.0719363178496081, 0.0642594641881552, 0.0563803510073072, + 0.047630352148372, 0.0370131535527062, 0.0250221105375963, + 0.0141447740172138, 0.00489652912505085, -0.00292068364605575, + -0.0096971075911463, -0.0161260480902374, -0.021796141634137, + -0.0265741858009781, -0.0308323263590591, -0.0350370983243008, + -0.03974243095972, -0.0453904983432472, -0.0518706948902108, + -0.0594400644468963, -0.0690311669264134, -0.0799311621673569, + -0.0899220932593085, -0.0977511757262692, -0.103642879898235, + -0.108159509518435, -0.111636857449944, -0.114495901808932, + -0.117559208130762, -0.121396724894368, -0.126009452970753, + -0.130973853088639, -0.135679007802922, -0.139592207394818, + -0.143220181002574, -0.1471358169373, -0.15128807041124, + -0.15519055689239, -0.158678288923652, -0.162035340183371, + -0.161799844509371, -0.162293704479596, -0.165756563181009, + -0.173942541665168, -0.183928294318232, -0.193938221427471, + -0.203698928862895, -0.213159546974878, -0.222464528365093, + -0.231430396582765, -0.2394347145809, -0.246159146371302, + -0.251302177492944, -0.255450864606284, -0.260477832934002, + -0.267601580049712, -0.276131385213365, -0.284767667719481, + -0.2926541348826, -0.30006103060589, -0.307399662329727, + -0.314345635576148, -0.320136276537154, -0.32376330362954, + -0.325206589325299, -0.325855160911104, -0.326759122738847, + -0.328285147256717, -0.329514199552675, -0.330656844099289, + -0.333201422709499, -0.332819811680728, -0.3309868959079, + -0.328662607299242, -0.325915260925486, -0.3228092897655, + -0.320348133882963, -0.319019957446364, -0.318764721390175, + -0.318884533365835, -0.31979070642962, -0.323216843184692, + -0.330939520956924, -0.342877593275971, -0.356500297405756, + -0.368600719877581, -0.378358467022809, -0.387405664577975, + -0.395082698917156, -0.399311365279829, -0.397845831800311, + -0.38853659425434, -0.373791310061371, -0.363615072334211, + -0.358981609211049, -0.353692278191065, -0.348417328014059, + -0.347006617054967, -0.353571057908741, -0.363537515020206, + -0.37875524686207, -0.401959622798038, -0.421656168810975, + -0.432034567875696, -0.435306208902663, -0.435318995544434, + -0.433677976364684, -0.432987112587319, -0.434605881376456, + -0.434610789172333, -0.433727489963899, -0.435021617179856, + -0.436863226268731, -0.421004823401518, -0.387448613901341, + -0.372349889546661, -0.34419764228466, -0.293985716118437, + -0.270778444164781, -0.274702191634355, -0.281856754756756, + -0.284092386951164, + -0.174082070589066, -0.174082070589066, -0.174082070589066, + -0.25057113353563, -0.257693411996073, -0.253623466264877, + -0.228339924877679, -0.205306038310875, -0.197498136427313, + -0.195179232122553, -0.192524172393646, -0.185868877684729, + -0.177383386757821, -0.175713097113972, -0.185759265984712, + -0.179542120300825, -0.146620363208569, -0.0861680160730038, + -0.0239209321117264, 0.021186177961183, 0.0524531632030047, + 0.0736001058032205, 0.0864386578513517, 0.0905959571355312, + 0.088676338496729, 0.0857801451941251, 0.0850896024682129, + 0.0862037615384251, 0.0878502842501842, 0.0883937297838623, + 0.0869987807186364, 0.0832676279969566, 0.0776280528230826, + 0.0705612709817836, 0.0626554118372963, 0.0541641800727134, + 0.045033455779608, 0.0351532813414433, 0.0251708712278699, + 0.0170923669492648, 0.0104601898502842, 0.00402174208808585, + -0.00247362469154248, -0.00934054427589863, -0.0157117866414366, + -0.021146010069499, -0.0257963714164463, -0.0302965119179853, + -0.0353396442733142, -0.0410600795532688, -0.0471806772654126, + -0.0540491019151098, -0.0632305116653942, -0.074733318554159, + -0.0860572136093442, -0.0952665658251969, -0.101950767926518, + -0.10669404259785, -0.110093506294615, -0.11286157364752, + -0.115849799696482, -0.119416418441884, -0.123779914674997, + -0.128972777833956, -0.134351461427578, -0.139175971562141, + -0.143636386067775, -0.148343460989566, -0.153750426761946, + -0.159572933845988, -0.165449863417772, -0.1710688851751, + -0.172652908484446, -0.173258445689715, -0.175077301629267, + -0.180374341791537, -0.188097006243186, -0.197064535816122, + -0.206998304847137, -0.217412812919475, -0.227788138957914, + -0.237395569334968, -0.245778856179637, -0.252867210014821, + -0.258132826232086, -0.262218042266023, -0.267004387524344, + -0.273381015406528, -0.280621599912995, -0.2881470603155, + -0.295437549764808, -0.302686493800791, -0.309908165444771, + -0.316712005962736, -0.322685151002981, -0.327118149539216, + -0.329622981777334, -0.331016805729757, -0.33206039159561, + -0.332952475339545, -0.33314991039951, -0.333134163692428, + -0.334649873856508, -0.334430743361679, -0.332913776678935, + -0.330725680442525, -0.327820018125348, -0.324824231538538, + -0.322677997452265, -0.321838061655493, -0.322289319056391, + -0.323055947932043, -0.324064618635672, -0.32660639791517, + -0.333088615644421, -0.344248948006397, -0.358004501843839, + -0.37068849901907, -0.380532840983301, -0.388344628755016, + -0.393468885310075, -0.393547106098376, -0.388472626834234, + -0.379848446896825, -0.370267110018509, -0.362093894794843, + -0.355611073345252, -0.350027651332171, -0.345333908862185, + -0.342217076460649, -0.341204188889045, -0.343244108304935, + -0.348345806422563, -0.365077590326127, -0.388574984962511, + -0.409378185832454, -0.4250669303485, -0.434704991633427, + -0.439528908333071, -0.442170262819495, -0.441688742886629, + -0.434835786068914, -0.425845020548073, -0.423170913598856, + -0.428841577482491, -0.424274872178633, -0.399230439244871, + -0.342943885039426, -0.296020232535442, -0.282501708284864, + -0.275851052633058, -0.282024016429028, -0.285312218364987, + -0.290017305079586, + -0.174082070589066, -0.174082070589066, -0.174082070589066, + -0.175897731133306, -0.268290501775894, -0.258734765340634, + -0.233451611765416, -0.210551112936217, -0.201634688596874, + -0.19931562068363, -0.196628504756683, -0.18963969289997, + -0.181154390310015, -0.173544791494485, -0.180291983812639, + -0.186914196017207, -0.166476663202044, -0.112222788110742, + -0.0494390072950532, 0.0026404310601672, 0.0399584785032991, + 0.0623565917184784, 0.0718238292178604, 0.0743880128326707, + 0.0740343720006734, 0.0742072319863758, 0.0769577219329927, + 0.0809870990623408, 0.0842878650751227, 0.085934857120389, + 0.0852465074973959, 0.0815404935075815, 0.0755682212583955, + 0.0681118226010143, 0.0600605086673823, 0.0518320859575193, + 0.0436266105992921, 0.0354739909492972, 0.0279560728249094, + 0.0223951537082035, 0.0175176845161191, 0.01173672200051, + 0.00512946154648302, -0.00226636317733376, -0.00916015587388962, + -0.0149259967898521, -0.0198578480400669, -0.0247991669696922, + -0.0301816154835596, -0.0359845949003104, -0.0420447005194709, + -0.0485789659566542, -0.0571536800688797, -0.0682654160648866, + -0.0800411078986276, -0.0901178929494098, -0.0975269437531706, + -0.102717657635948, -0.106501012664605, -0.109687980633187, + -0.113000089494239, -0.116589179073542, -0.120645967412567, + -0.125381154079373, -0.130508177311801, -0.135599860620399, + -0.140929966838642, -0.146980478262093, -0.154029774962517, + -0.161356011845528, -0.168876226208931, -0.176578919508399, + -0.181038565576987, -0.183451917523378, -0.184705931709797, + -0.187592056188892, -0.193173800510794, -0.201569119635943, + -0.2120852115667, -0.223294783287929, -0.234040811721271, + -0.243711710003267, -0.252142386557151, -0.259260812251914, + -0.264456951031561, -0.268250030430305, -0.272263149848605, + -0.277397762238535, -0.28317561429229, -0.289439223084805, + -0.296222253139212, -0.303451951037367, -0.310576049502533, + -0.317069552481543, -0.323732810732829, -0.32900973040314, + -0.332645119155229, -0.335016133324492, -0.33660937764774, + -0.337528749471682, -0.337216951218256, -0.336704053563017, + -0.336744634697903, -0.336006057798083, -0.334581631242539, + -0.332234253712188, -0.329392950279667, -0.326951071643167, + -0.325428720111585, -0.32521186934236, -0.326383064697778, + -0.327608379905529, -0.328724989033358, -0.330610241630535, + -0.33552897646289, -0.345389089771683, -0.358827960924457, + -0.371935442981103, -0.382170364553605, -0.38910186526365, + -0.391138002237927, -0.385400632034585, -0.374593059938707, + -0.367099487618154, -0.364263220863704, -0.360397093836241, + -0.354241838358391, -0.347871834123776, -0.344546333863797, + -0.340062401830676, -0.336738637095628, -0.335623505371725, + -0.336826715857387, -0.338662763219194, -0.346137010840369, + -0.369376602995294, -0.397840609055086, -0.419218631417392, + -0.431657861862946, -0.439697681580702, -0.440092127732658, + -0.426846419905622, -0.408469742187, -0.397107797615169, + -0.401663108379629, -0.416253180354639, -0.402720030069664, + -0.33177189680715, -0.303256742909324, -0.291393994979087, + -0.286834393995293, -0.286004331396213, -0.292697283066065, + -0.291040130302884, + -0.174082070589066, -0.175143663290412, -0.176383063197136, + -0.176383063197136, -0.278178811679754, -0.263466867608409, + -0.238563017852721, -0.215796346585312, -0.205771227382592, + -0.203452135334085, -0.200732836372511, -0.193411046172226, + -0.184925598762874, -0.176487109550666, -0.173828394038536, + -0.181658700800284, -0.180763174339021, -0.149182203072777, + -0.0943599711241024, -0.0341896715881028, 0.013410936121324, + 0.0405194697055606, 0.048957001391022, 0.0507125344624673, + 0.0531599206168062, 0.0580968395664621, 0.0657125656173246, + 0.0740027164956572, 0.0797972217595866, 0.0831881587384254, + 0.0837327444104185, 0.0803436506383847, 0.0741723530404883, + 0.0664770131463398, 0.0587783340144393, 0.0516914572184137, + 0.0450709121987954, 0.0388068643220037, 0.0334542715399071, + 0.0297371691141905, 0.0258437951473754, 0.0201593430964279, + 0.0130700612199324, 0.00517754357830758, -0.00200585697225933, + -0.00798783395854293, -0.0132978282330609, -0.0188058422400499, + -0.0246467815914614, -0.0306498385673401, -0.0368355594574858, + -0.0436893664491565, -0.0525352969425307, -0.0633693943974688, + -0.0746894616984667, -0.084567672657253, -0.0920780639694209, + -0.0976149160497026, -0.101886022858973, -0.105566258397101, + -0.109243055244059, -0.113064993886099, -0.117102769877622, + -0.121418592492568, -0.125986451759923, -0.131119858902586, + -0.137691534585273, -0.146083274569331, -0.155655457993566, + -0.164766254852508, -0.173499168809045, -0.182194017495234, + -0.188467651422832, -0.192448102042664, -0.193744869606539, + -0.195085520672297, -0.199195385569496, -0.207436222729982, + -0.218414133755121, -0.230009437335984, -0.240621635829301, + -0.249924696683092, -0.258014887924898, -0.264850338552476, + -0.269847271183735, -0.273190987550346, -0.27617971769507, + -0.279893828485637, -0.284398801574646, -0.28994470658735, + -0.296674971141339, -0.30378925458989, -0.310609193318339, + -0.319435668191928, -0.323765636248037, -0.329704120082937, + -0.334358675448442, -0.337771383989783, -0.340152100398534, + -0.341392591827371, -0.340889923116025, -0.340338387594356, + -0.33920034925533, -0.337535473423165, -0.335679271323072, + -0.333025061628806, -0.330294798053812, -0.328529939358149, + -0.327840504352299, -0.328375200574152, -0.330242851874832, + -0.332253596251448, -0.334030238376534, -0.335897472604417, + -0.339527530390455, -0.347935144863286, -0.360876820094724, + -0.373856283999402, -0.3841714463325, -0.389622678638109, + -0.385607895805179, -0.371489852389556, -0.355029953508083, + -0.34807446121655, -0.351984201918354, -0.354856706949698, + -0.352869804874596, -0.349313493869243, -0.347529721427981, + -0.340462588441817, -0.335849121997672, -0.333894563028279, + -0.333583864363109, -0.327934333070604, -0.323217641506127, + -0.334638416145847, -0.366640317909726, -0.392391361880902, + -0.410725362185442, -0.425526876077974, -0.4300036182488, + -0.414018925444245, -0.389020559179864, -0.369537590653116, + -0.366637586378796, -0.386227139344386, -0.385487160530074, + -0.335285348878402, -0.310871761277697, -0.30098206784068, + -0.294280359463642, -0.29142701822693, -0.293653035350514, + -0.286030114163811, + -0.176251472649461, -0.176383063197136, -0.176383063197136, + -0.176383063197136, -0.290594874248656, -0.267910616664357, + -0.243674787748263, -0.221041627908491, -0.209907847758473, + -0.207588674731659, -0.204775317785907, -0.197182346142118, + -0.188696765671676, -0.180366913803529, -0.173995022851189, + -0.173214356033369, -0.178142254794346, -0.170688526438099, + -0.137744327020089, -0.0910398930192345, -0.043530894828432, + -0.00603611011504649, 0.0124747579063363, 0.021192302836915, + 0.0303007270212898, 0.0417449161736755, 0.0544531724062295, + 0.0665974137389139, 0.0751452173380183, 0.0805773932800139, + 0.082645173541371, 0.0800454945234155, 0.0740671798013454, + 0.066676062813097, 0.0599130953024013, 0.0544226730768486, + 0.0496130646110897, 0.0450682033329104, 0.0414836043297631, + 0.0389651295466076, 0.0353841323444812, 0.0293649930055143, + 0.0215985030276302, 0.0133470681081836, 0.00606306368713256, + -0.000248112385043137, -0.00630376437338363, -0.0126954275949859, + -0.0193044204037969, -0.0257728422252623, -0.0323722606058428, + -0.0400628309439609, -0.0497294220586032, -0.0605312700698136, + -0.0711573692365405, -0.0802545525508054, -0.0873436232250081, + -0.0929118001762333, -0.0974260477381636, -0.101381844559922, + -0.105244488348329, -0.109278701099594, -0.113404210675871, + -0.117418734040896, -0.12152779683343, -0.127014225779122, + -0.135488573045606, -0.146810149616196, -0.15889746876451, + -0.16966046201645, -0.179469818510094, -0.188473778062604, + -0.195285736050985, -0.199906258120434, -0.201397263248579, + -0.202117297920517, -0.205654117001774, -0.213807285017922, + -0.224849017935664, -0.23642980809271, -0.246663024731534, + -0.25538651460257, -0.262795433964572, -0.268933107002099, + -0.273283452843542, -0.27606786769394, -0.278287768179243, + -0.281084958938222, -0.284909799690944, -0.290443291334836, + -0.297216328545678, -0.303878609908742, -0.310039698664918, + -0.317768685045147, -0.322664883925789, -0.329287848469528, + -0.33508082200507, -0.339578749758599, -0.342855204845327, + -0.344677937052448, -0.344380461391222, -0.344225995307895, + -0.342291831848205, -0.339836088383815, -0.337778210967574, + -0.335541250695002, -0.333430594991322, -0.33172136249612, + -0.330678490261235, -0.330975355025201, -0.333018415974538, + -0.335806224692196, -0.338769831435434, -0.341317166063582, + -0.344458413285692, -0.352270371839872, -0.365235814110475, + -0.377856321163571, -0.386540342923598, -0.384791397852951, + -0.363107326588734, -0.338920177590086, -0.328121002526259, + -0.327036506307322, -0.337300179488277, -0.346086344563239, + -0.350446764375095, -0.351672105791828, -0.348622937482127, + -0.342248973683038, -0.335826581150242, -0.331290451585825, + -0.33025973480936, -0.32567821948889, -0.318709373931961, + -0.318158887657473, -0.336842558043142, -0.357973284992758, + -0.377430311863946, -0.397828126750954, -0.410217324061857, + -0.399226410746321, -0.372248265866713, -0.351037162664143, + -0.345823665485023, -0.355109380639102, -0.361031665819457, + -0.334064423653689, -0.312123956576988, -0.300653556343267, + -0.29613883966386, -0.297131158783878, -0.291766904673195, + -0.279707856276493, + -0.176383063197136, -0.176383063197136, -0.176383063197136, + -0.173750828681768, -0.303014581968175, -0.271123525739507, + -0.248787029647923, -0.228074446708919, -0.214044488160865, + -0.211725293516589, -0.208699643147624, -0.200953496775272, + -0.192468072001188, -0.184338637290247, -0.178190591808149, + -0.175736678022186, -0.175538812838754, -0.175136329633414, + -0.167919728024213, -0.154032970189111, -0.117313956154483, + -0.0686612879101052, -0.0309313957505222, -0.00545223609706661, + 0.0146890217738956, 0.0317004824094631, 0.0478186562364705, + 0.0616146045536854, 0.0716833135449524, 0.0788006033676832, + 0.0824034275294582, 0.0807920695734434, 0.0756391060428192, + 0.0693496192770148, 0.0640901212980847, 0.0603693211706811, + 0.0573889764434067, 0.0545643671288529, 0.0521416710465708, + 0.0499882359811151, 0.0460292405043142, 0.03950874386826, + 0.0314094238503645, 0.0229276528257263, 0.0152276011514347, + 0.00797657201533798, 0.00054319640260559, -0.00729420583685345, + -0.0150858846498974, -0.0222425499082279, -0.0293324683954351, + -0.0376033929683566, -0.0476722679143227, -0.0584399539280244, + -0.0686763630737152, -0.0771499120723155, -0.0837172416237548, + -0.0891003057919025, -0.0936374258963913, -0.0975712476723247, + -0.101365498641071, -0.105268718786176, -0.109131858767327, + -0.112742847090343, -0.11686347221059, -0.123633358565746, + -0.134759274407601, -0.1486714497663, -0.162309991407221, + -0.174042093022495, -0.184729293420806, -0.19399989472602, + -0.200995626334056, -0.205860152345419, -0.207691636132712, + -0.208525146538097, -0.212073238475551, -0.219915841207433, + -0.230479577515692, -0.241612253620937, -0.25142714609627, + -0.259595394340684, -0.266198165600265, -0.271333383806987, + -0.274766406314554, -0.276934277559841, -0.278801808530558, + -0.281317909225567, -0.284933637023544, -0.290382048801781, + -0.296930411883708, -0.303269988255428, -0.30888782053168, + -0.315525499210369, -0.320849036000271, -0.328139123713732, + -0.335079421625217, -0.340592169377993, -0.344617934503285, + -0.347190244870389, -0.347630464628189, -0.348302851318833, + -0.346261429748987, -0.343720118233483, -0.341889771674639, + -0.340660406321388, -0.339478747756682, -0.33761524288167, + -0.335291620299326, -0.333870056543364, -0.334903016947729, + -0.337913328927795, -0.342024696722654, -0.345821208676876, + -0.349429192573795, -0.357163376746876, -0.36987783165584, + -0.380744512572833, -0.382758861866879, -0.366509847565028, + -0.324658669494576, -0.293226728610483, -0.291502010847779, + -0.301931246600004, -0.320659851868387, -0.33522795327897, + -0.343563473905889, -0.347688976402349, -0.347314867430032, + -0.343070286898869, -0.33375943197641, -0.326708253265394, + -0.324082496374727, -0.32171740935299, -0.316170746798405, + -0.30938254200112, -0.315950423895572, -0.329199221477224, + -0.344236143111024, -0.364604099608216, -0.382452632231541, + -0.381058222711889, -0.358961195563533, -0.339210730404161, + -0.333683578782503, -0.336146286225884, -0.332541479681325, + -0.312915827093229, -0.287491090136369, -0.278622299598894, + -0.284701367455718, -0.291557638771137, -0.283469350038373, + -0.267807539920152, + -0.176383063197136, -0.173043234333684, -0.172355756163597, + -0.172355756163597, -0.315433366701259, -0.269833305116189, + -0.253900184103528, -0.230373519770252, -0.218181170866103, + -0.215861946730177, -0.212624288674681, -0.204724853958275, + -0.196239360733222, -0.188534123875658, -0.182941055960934, + -0.184734311580899, -0.17627706284467, -0.180251851762693, + -0.185254395731872, -0.182835693112798, -0.153401612128202, + -0.103741174811185, -0.053147664853618, -0.0152121722049437, + 0.0108309531084291, 0.0296946154209278, 0.0452683212349547, + 0.057932770151152, 0.0690559334442881, 0.0778771442372393, + 0.0829315467383603, 0.082473710143282, 0.0786564391632159, + 0.0738927990259825, 0.0705189552004114, 0.0687042832811706, + 0.0674486232912736, 0.0660541278377077, 0.0642943431591499, + 0.0620403613427713, 0.0576273513278939, 0.0508278492571782, + 0.0427214815825345, 0.0339557615443445, 0.0251958943112066, + 0.0161513596752541, 0.00658447813099136, -0.00306633657654041, + -0.0120155956474468, -0.0197040288541813, -0.0270467810630427, + -0.0353722495714713, -0.0452950176560614, -0.0559676007153735, + -0.0661405557390683, -0.074229775780628, -0.080279335831997, + -0.0852809926381871, -0.0895580347943484, -0.0931598860278905, + -0.0965183953298459, -0.0999425609853504, -0.103365442868797, + -0.106967542867881, -0.112229999948434, -0.121386714991542, + -0.135361079955617, -0.150944791430803, -0.165003287920508, + -0.176829554177301, -0.188196349298609, -0.197991182604998, + -0.205443194135518, -0.21047504300798, -0.212853265670012, + -0.214414651980536, -0.218232779706287, -0.225451748486291, + -0.234967887651391, -0.245057759333214, -0.254223490341542, + -0.261837412506549, -0.267685314514918, -0.271963890752559, + -0.274670257414561, -0.276513496914902, -0.278364117206582, + -0.280879139359703, -0.284332859896473, -0.2893638229947, + -0.295724871053465, -0.30207430323849, -0.307574457654136, + -0.313620136906603, -0.319338652857094, -0.326923697245068, + -0.334589149063642, -0.340825426764867, -0.34544404477864, + -0.348741439232879, -0.350165243651993, -0.35204773985902, + -0.350643017323882, -0.348661695452254, -0.34745785764412, + -0.347114718323205, -0.346796078968797, -0.344935689293374, + -0.341409081962187, -0.33792353552307, -0.33676780643073, + -0.338785189357294, -0.343600491741473, -0.349110081499038, + -0.353816211749244, -0.361299268371393, -0.372499609839589, + -0.377644214656552, -0.364974962018911, -0.336121967056148, + -0.293705443675302, -0.262643210210702, -0.259197196376891, + -0.272323900817782, -0.298873201255098, -0.321583872632146, + -0.334205732579123, -0.342270105497884, -0.345132541912301, + -0.340980369745874, -0.331142451106776, -0.324273956002605, + -0.31880022220877, -0.313010637385168, -0.306077395804951, + -0.299931878078191, -0.302039010700573, -0.309785112644325, + -0.319352081336169, -0.335012840673836, -0.350795720840088, + -0.357094827221337, -0.342874578583143, -0.324224949336348, + -0.318023784821163, -0.317985192534279, -0.314965490104775, + -0.300615221650687, -0.284367282743642, -0.278387023426801, + -0.279599005137611, -0.277057967578835, -0.262419089142529, + -0.247561788479806, + -0.172355756163597, -0.172355756163597, -0.172355756163597, + -0.172355756163597, -0.185804484326345, -0.275671800178711, + -0.259012047402218, -0.233728892312486, -0.222317885552953, + -0.219998638819944, -0.216549488585285, -0.208496428885174, + -0.20001077144364, -0.192729732679231, -0.189119438596221, + -0.192853878539176, -0.185270883229706, -0.178951185217826, + -0.182834678440307, -0.180665136090004, -0.146856308629698, + -0.0967020964253211, -0.0548671802044419, -0.0189481143548108, + 0.00700251987542909, 0.0255462361175364, 0.0387784950683698, + 0.0504895990046289, 0.0641041199457499, 0.0758689714693431, + 0.0828787229515659, 0.083878451891185, 0.0816645009622892, + 0.0787086132958458, 0.0769626055043457, 0.0765875755635042, + 0.0765454304304169, 0.0763455642652567, 0.0753008499346241, + 0.0732643564954286, 0.0691098454188382, 0.0624097565672933, + 0.0540567901262441, 0.0445685358561123, 0.0344554508116926, + 0.0236049682115597, 0.0121731928484295, 0.00118699584246741, + -0.00844100313446516, -0.0167235452350711, -0.0243985262385282, + -0.0325324169507305, -0.0419164327062621, -0.0523449863722707, + -0.0624775362740568, -0.0701982410983883, -0.0756690906556744, + -0.080045601145923, -0.0836980963766497, -0.086696580163828, + -0.0895135909963452, -0.0926121103605952, -0.0961222589059839, + -0.100798897088255, -0.108441318575264, -0.120319882801557, + -0.136155690517937, -0.152294308000283, -0.166276743704547, + -0.178146238746842, -0.190639089592078, -0.201320643979282, + -0.209202114211398, -0.214248471246118, -0.217174506893809, + -0.219550617780484, -0.223550437935194, -0.229861539261292, + -0.237880767649057, -0.246482784502854, -0.254672978909787, + -0.261626580905953, -0.266899821570943, -0.270667514006265, + -0.273120945814222, -0.27497147663544, -0.276911766095489, + -0.279423663337111, -0.282837110716791, -0.287688739325662, + -0.293909900413426, -0.300410681360307, -0.306319011569071, + -0.312734911786298, -0.318615205678888, -0.326165061772664, + -0.333930769100145, -0.340403157308463, -0.345433096447784, + -0.349341389954051, -0.351874857412045, -0.354796727810986, + -0.354230202320069, -0.353249213957573, -0.352920283393992, + -0.353161861235113, -0.353265941592106, -0.351800525456811, + -0.347964523507785, -0.343019231866911, -0.33966639155619, + -0.340024828729038, -0.344991800625801, -0.352000387129209, + -0.357731964352108, -0.364420873887142, -0.372107296980102, + -0.369890916933217, -0.343931174403402, -0.303620090564383, + -0.271705879108102, -0.251030702583849, -0.24799850311494, + -0.254072140879657, -0.277368273460977, -0.306069602248448, + -0.320162808869016, -0.331430517866729, -0.339250531489562, + -0.337373822918189, -0.329436988121111, -0.322622406502539, + -0.316452808683074, -0.309062695752902, -0.299093041025613, + -0.289489295070594, -0.287926698406671, -0.292551959583419, + -0.300154336224358, -0.311407575205515, -0.322344876182881, + -0.327768649438324, -0.317336577681537, -0.29986182458422, + -0.291769922771131, -0.287442092785126, -0.284431363683544, + -0.285533003282516, -0.27574562205896, -0.267361809735269, + -0.263754732191842, -0.251715452922016, -0.23496815618039, + -0.221325749948537, + -0.172355756163597, -0.172355756163597, -0.172355756163597, + -0.172355756163597, -0.187006399422684, -0.281354098011049, + -0.264124732665103, -0.238842399827684, -0.226454654782268, + -0.224135426991907, -0.220475003514254, -0.212268058193399, + -0.203782140828507, -0.196925345010955, -0.195593337941933, + -0.199471339087637, -0.196581835284256, -0.18487431257988, + -0.18153691771685, -0.17963948285618, -0.145492246407601, + -0.0972810716053997, -0.0712386156318144, -0.0386205568440128, + -0.0113536999758067, 0.0064023408563774, 0.0185094145209769, + 0.0320187413565766, 0.0497968756982838, 0.0666346755182509, + 0.0773095382065302, 0.0812752920266716, 0.0816648523459785, + 0.080681515432371, 0.0799812220039931, 0.0804184528777907, + 0.0815751363588148, 0.0829260963025975, 0.0830503446044418, + 0.0819107936021392, 0.0782817602852542, 0.0717350439023063, + 0.0630777984991506, 0.0531370955542983, 0.0424507623218585, + 0.0309793842444416, 0.018903001578342, 0.00742575441470788, + -0.00275263865909196, -0.011796187158776, -0.0201736853327136, + -0.0284164159808037, -0.0371835720182299, -0.0471002354934136, + -0.0569315973466635, -0.0642049607577485, -0.0691415632113029, + -0.0728815242920941, -0.0758581295652828, -0.0783581653079726, + -0.0810760837930135, -0.0845147729977734, -0.0888736134492346, + -0.0954256794383054, -0.10555583219839, -0.11917987763316, + -0.135263774430141, -0.151158225804159, -0.165493135012186, + -0.178563032262207, -0.193101512305115, -0.204918643093213, + -0.212933122980268, -0.217718066725613, -0.220895218796799, + -0.223739576816199, -0.227554196266275, -0.232802689251933, + -0.239178414841317, -0.246118523320955, -0.253115901237056, + -0.259297862817212, -0.264154257024978, -0.267697662604342, + -0.270049210965445, -0.271878515847837, -0.273746099550579, + -0.27636717451994, -0.280228471583409, -0.285506349699246, + -0.291897879383138, -0.298630391440598, -0.305219867566968, + -0.312169956278894, -0.318599060101625, -0.326013771413207, + -0.333460146616853, -0.339761967679551, -0.34494394778177, + -0.349239767935984, -0.35266247959531, -0.356325236487403, + -0.356559635768594, -0.356781567475377, -0.357394591946464, + -0.358080400507322, -0.358443674130042, -0.357399322043854, + -0.353850251659159, -0.348317767571711, -0.343538648486563, + -0.342790135110443, -0.34794840188254, -0.355347702842739, + -0.361214988977326, -0.366532040242699, -0.369829632792257, + -0.361133401264196, -0.330202888625489, -0.281659509405652, + -0.251903219070833, -0.245830046747165, -0.256755427585866, + -0.249846663429174, -0.263430860954366, -0.287532732199861, + -0.302620860718204, -0.316441486515141, -0.329266339450134, + -0.332473990192725, -0.325955196288659, -0.318686165282682, + -0.312292962884505, -0.304656379479934, -0.292868979005476, + -0.281818051696017, -0.275852138517399, -0.276261112312002, + -0.282387794393513, -0.290539911563576, -0.298803731563797, + -0.299120421005163, -0.286354193009489, -0.273129598049733, + -0.267943036726762, -0.259121444661957, -0.24966088292148, + -0.253522745594445, -0.251210930951125, -0.246883415969916, + -0.239766532481813, -0.224760586448308, -0.211525568479463, + -0.200925268350779, + -0.172355756163597, -0.172355756163597, -0.172355756163597, + -0.172355756163597, -0.179532606423707, -0.275833070599367, + -0.269238182468611, -0.243955677166431, -0.23059142825924, + -0.228272212310863, -0.224401309069249, -0.216039665763289, + -0.207583874746141, -0.201197319512517, -0.202211118330387, + -0.20608907567347, -0.207764857970218, -0.194803031058744, + -0.187665078849814, -0.18196756930164, -0.150979242260489, + -0.108871956339316, -0.0929655583835436, -0.0715702241475146, + -0.0532930393087705, -0.0377027265707014, -0.0218668799177721, + -0.00525099792352227, 0.0172330547051472, 0.0405600234925163, + 0.0577302762635755, 0.0678250077905303, 0.0730362618099604, + 0.0751504443483889, 0.0757149164032818, 0.0767468525150355, + 0.0796171697065704, 0.0831465314111405, 0.0853479733156618, + 0.0852632996883731, 0.0817717155435024, 0.0758207967726866, + 0.0682480332592136, 0.0594555789786646, 0.049750556899323, + 0.0389655367447856, 0.0273261558276048, 0.0158817533080092, + 0.00522177345329111, -0.00464743466008342, -0.0139251080136924, + -0.0225143540260297, -0.0310501373937531, -0.040440840087375, + -0.0496275758401452, -0.0564242884302871, -0.060967938538913, + -0.0642320585388381, -0.0667934186128644, -0.0693012081723225, + -0.0725592289738496, -0.0768886527653346, -0.0825840150321995, + -0.091155388957308, -0.103093577465414, -0.117280042490357, + -0.132765437061883, -0.148435905334941, -0.163886978498158, + -0.179145108780143, -0.19599628812681, -0.208840575895803, + -0.216944706981086, -0.221351997280101, -0.22433581302902, + -0.227106035873361, -0.230387703276742, -0.234532355144186, + -0.239388274791729, -0.244755481657729, -0.250442126172118, + -0.255756069165321, -0.260127378616471, -0.263407140197834, + -0.265562125449191, -0.267152858548361, -0.268854102375505, + -0.271853121174416, -0.276567264866397, -0.282777383104197, + -0.28972090750679, -0.296890485171363, -0.304212460748413, + -0.312126290428851, -0.319235646758322, -0.326681624020124, + -0.333558529272717, -0.339372869801942, -0.344419263505607, + -0.348830871585899, -0.352783667116838, -0.356889096440459, + -0.357956261859775, -0.359187595585314, -0.360456306996715, + -0.361518952773261, -0.362120250467317, -0.36151589383413, + -0.358473095155619, -0.353204658599457, -0.348336184527155, + -0.347694871720349, -0.352633460370171, -0.359187183442839, + -0.363983650280142, -0.367065880921352, -0.365702700285987, + -0.347753614411153, -0.301820971419698, -0.253792489407489, + -0.243270113069667, -0.245866009731289, -0.243427742228778, + -0.242330795837673, -0.2505731918809, -0.267141415429287, + -0.282957578100271, -0.298178141027823, -0.31338367370656, + -0.320443612005449, -0.316277072296796, -0.308265921284795, + -0.30189663938087, -0.296154843467417, -0.288878760136919, + -0.280250011138915, -0.268039026798973, -0.261839324466634, + -0.264292637399134, -0.269546937747943, -0.277957006514238, + -0.277887846227021, -0.264244904864915, -0.252769038545456, + -0.251786584210437, -0.242969479198687, -0.229119505064799, + -0.227135552698187, -0.227564606533507, -0.22365280961072, + -0.216945034767453, -0.205117098261724, -0.194209646291792, + -0.18501033422987, + -0.172355756163597, -0.172355756163597, -0.172355756163597, + -0.172355756163597, -0.172355756163597, -0.287559122088481, + -0.274351585993117, -0.249068450924632, -0.234728440566437, + -0.232409011645431, -0.228297772851537, -0.219811642032273, + -0.211618600998214, -0.205959674979738, -0.20882877988395, + -0.212706752230268, -0.216584641778946, -0.20676484420102, + -0.198179927177224, -0.192288297615697, -0.154947880775235, + -0.117248001164162, -0.107929609871702, -0.102506017844649, + -0.102601171943125, -0.0980357016225635, -0.0775898898444061, + -0.0532638298985415, -0.0282149928142591, -0.00161044072108885, + 0.0209318828712421, 0.0376212227166603, 0.0493875918864429, + 0.0563048244106443, 0.0602489719035381, 0.0634365592608524, + 0.0678536623360008, 0.0743966471941885, 0.0793794300925925, + 0.0803256403267214, 0.0770952138950805, 0.072520516142481, + 0.0679616644393256, 0.0624655352030344, 0.0551470615529124, + 0.0459936193013064, 0.0357650330842106, 0.024958995864881, + 0.0139444246379137, 0.00312039457277536, -0.00705102218200488, + -0.0160442988142774, -0.0242782143048099, -0.0327873047164651, + -0.041059120293027, -0.0474905304547191, -0.0517715057234969, + -0.0545781045868866, -0.0569398725715712, -0.059935971703361, + -0.0642180195920743, -0.0698134370418797, -0.0770090919276744, + -0.0874067157427934, -0.100894201552606, -0.115817968332242, + -0.131192696788839, -0.146963920270207, -0.163512511021048, + -0.180509508502335, -0.198800858758967, -0.212161510259576, + -0.220672749247209, -0.225151610265959, -0.227889959933964, + -0.230204863179782, -0.232695918325859, -0.235669264869492, + -0.239158509847821, -0.243115290772613, -0.247535344030694, + -0.251870410505511, -0.255545016676335, -0.258313293200382, + -0.260155775986558, -0.261496240361548, -0.263246110604662, + -0.266875493117729, -0.272440910691652, -0.27928878184971, + -0.286641304540852, -0.294463406307272, -0.303002483496383, + -0.312245321102405, -0.320380585250932, -0.327968896193448, + -0.334395300218252, -0.339592175101842, -0.344140301092436, + -0.348301587503772, -0.352482235406772, -0.35661614281107, + -0.358394495153002, -0.360319895391788, -0.361984759942776, + -0.363241514511883, -0.364166068204803, -0.364289409684331, + -0.362298035720245, -0.358151969408455, -0.354215528920732, + -0.35404919565786, -0.357970063231077, -0.36270388918717, + -0.36551191931966, -0.365988436659722, -0.360019549545438, + -0.337557077610348, -0.290479047795766, -0.253635615305092, + -0.250835209972157, -0.247013090345963, -0.243408232691886, + -0.236934736093736, -0.240136232188964, -0.248273679708435, + -0.262637487945454, -0.277586848433687, -0.292136071612787, + -0.299747748282166, -0.298102248296779, -0.292774892824916, + -0.288545342188585, -0.287376422143683, -0.288806753854791, + -0.271805039081838, -0.260856874156018, -0.251190932986927, + -0.249119120442304, -0.250377647959461, -0.256781614085832, + -0.26101767454231, -0.250045352269991, -0.239350969934993, + -0.23833053555619, -0.2323160748328, -0.218824967533545, + -0.211841907517594, -0.209179239805708, -0.200969983503872, + -0.194492491921938, -0.185018685527753, -0.175689506491461, + -0.167213415834546, + -0.172355756163597, -0.172355756163597, -0.172355756163597, + -0.172355756163597, -0.17189748727527, -0.299981374386162, + -0.279465398191147, -0.254182666592414, -0.238865377874673, + -0.236545860644371, -0.232069770128553, -0.223583431172756, + -0.215678579277659, -0.211568572688394, -0.215446578428606, + -0.219324586596291, -0.223202383119091, -0.218230171146687, + -0.205582004742969, -0.197803224256405, -0.153354204100924, + -0.123518780414431, -0.120435224868523, -0.123109596167578, + -0.129146736901963, -0.133507750478935, -0.122755644427982, + -0.10308997152848, -0.0792546816304189, -0.0529646693498838, + -0.0278581128367987, -0.00723863404422471, 0.00838892098585115, + 0.0186634012157292, 0.0263052148780468, 0.0361193655905203, + 0.0464346543000639, 0.0558005178034898, 0.0630310431482885, + 0.0655397235037303, 0.0632296370508841, 0.0603018482513442, + 0.0601522095114655, 0.059523415513337, 0.0560565238426829, + 0.0494388934895561, 0.0409517412435213, 0.0310977924760358, + 0.0201649721995567, 0.00878490235934015, -0.00169359121405229, + -0.0103434676486603, -0.0174910748105595, -0.0245591252323192, + -0.0317545122607387, -0.037775571415295, -0.0418130881543842, + -0.0444163213811987, -0.0470551369690895, -0.051035029353918, + -0.0568006352059479, -0.064111588736396, -0.0731482416738108, + -0.0853289811927495, -0.100478579460725, -0.116855159588137, + -0.132685026413776, -0.148285406005347, -0.164834387792223, + -0.182003702695796, -0.200414431366085, -0.213876952276322, + -0.223218188750998, -0.228528228213727, -0.231447493194159, + -0.233365057447516, -0.235051551758451, -0.236896561622677, + -0.239111687455046, -0.241742567064111, -0.2448609524236, + -0.248151491476374, -0.251074646622146, -0.253286459468118, + -0.254844980435636, -0.256156111839094, -0.258255434528227, + -0.262337833622358, -0.26823976085825, -0.275052842160655, + -0.282512756780257, -0.291346006472207, -0.301595656403588, + -0.312563725606146, -0.321683139485766, -0.329537505176376, + -0.335914893674206, -0.340689486770586, -0.344469886904612, + -0.34789592338825, -0.351902334234346, -0.355626982220772, + -0.357638291141016, -0.359751772750625, -0.361626450450415, + -0.363215976403238, -0.364793591005035, -0.366001511567082, + -0.365595713746043, -0.363132867264222, -0.360262379324204, + -0.359926763001508, -0.362104211981896, -0.36447253132448, + -0.365161477118479, -0.363335373001203, -0.352585793739531, + -0.327153539661331, -0.286918744770776, -0.256006460149369, + -0.251780523096292, -0.248225865702477, -0.244726714974532, + -0.240903873334954, -0.238747860794388, -0.238844568130078, + -0.242685620032283, -0.254038140062507, -0.267558666101859, + -0.275281287156405, -0.277274382258585, -0.277428878747645, + -0.276806401623601, -0.277539749871957, -0.278501999854215, + -0.27127392113027, -0.255853373191349, -0.245355938367862, + -0.238601774513441, -0.23313964376849, -0.235300188290035, + -0.240152085687783, -0.232568873128243, -0.224167926679734, + -0.222495264358847, -0.218144182737612, -0.20655584319685, + -0.197345392590812, -0.192018641936967, -0.182496882899397, + -0.17464343803096, -0.164621872277928, -0.155530516529468, + -0.14830278407389, + -0.172355756163597, -0.172355756163597, -0.172200795009414, + -0.171712592244148, -0.171712592244148, -0.259846958913846, + -0.284096457819347, -0.259296625599925, -0.243002416921042, + -0.240682869831958, -0.235841846521261, -0.227355361074162, + -0.219857423354902, -0.218186387165961, -0.222064419770758, + -0.22594232364613, -0.229820225305931, -0.229474074721932, + -0.212815221270972, -0.198138319906801, -0.152410144627553, + -0.128013702931899, -0.129071674946512, -0.134593838281081, + -0.139599303025169, -0.143037732844199, -0.14141940985761, + -0.134899850562576, -0.121120830085954, -0.0992655840044852, + -0.0750770866378404, -0.053674804796675, -0.0368683116821765, + -0.024644739931588, -0.0154748291388456, -0.000698311521121054, + 0.0181803382475004, 0.0336197715992645, 0.0426537778064352, + 0.0458033144580366, 0.044152726161314, 0.0431917466882027, + 0.0469082060561642, 0.0512115365024989, 0.0519613841943438, + 0.0480377731502456, 0.0409173079121437, 0.0320191259938477, + 0.0219777503366502, 0.0113241382806542, 0.00156950787938746, + -0.00596335135084083, -0.0116425362035675, -0.0171823910726668, + -0.0231443084441288, -0.0284682411168006, -0.0323489987644687, + -0.0353648133493597, -0.0392208948662588, -0.0452073541929602, + -0.0533503110643787, -0.0631228542365431, -0.0745274132908807, + -0.0884037997217606, -0.104621644136578, -0.121671676886573, + -0.137285579798725, -0.151942665028022, -0.167291636278548, + -0.183270731790629, -0.200852531931687, -0.214020367565232, + -0.224133281541891, -0.230633008002381, -0.234309937278584, + -0.236290660586136, -0.237458378284813, -0.238362518087014, + -0.239432630688781, -0.24086345481381, -0.242830668044136, + -0.245140383559448, -0.247361716756586, -0.249110281780114, + -0.250445482754801, -0.251901915511168, -0.254332789161309, + -0.258503302251707, -0.264176635326122, -0.270584072764595, + -0.278261479415451, -0.288693347435967, -0.30262591964179, + -0.313344482937233, -0.323241637250625, -0.331477102112863, + -0.338047087175868, -0.342486009925753, -0.3454685495473, + -0.347891350422464, -0.351298337708566, -0.354197813434555, + -0.356060918927757, -0.358331687753058, -0.360474145235017, + -0.362636028219501, -0.365061451056815, -0.367390605937825, + -0.368414222026416, -0.367237125476062, -0.364817727617841, + -0.363732130834567, -0.363992804673778, -0.363926953954486, + -0.362598222566773, -0.358728710471689, -0.344535730723198, + -0.316030498856289, -0.278381364855423, -0.256153001770347, + -0.252962783340335, -0.249511096369108, -0.246081014855131, + -0.242953390104329, -0.238112521453779, -0.233446721390831, + -0.233395426489922, -0.235179932921796, -0.244433551065602, + -0.253775982966932, -0.259075155357042, -0.262618354547933, + -0.265183645943248, -0.268243067622718, -0.267016550651335, + -0.257896659272348, -0.248518331230667, -0.239914451598709, + -0.23038189835991, -0.220252916415629, -0.21831974616368, + -0.2203572489289, -0.215881419665113, -0.208031927268781, + -0.204539442051664, -0.199199142779162, -0.18980468789515, + -0.181679534702551, -0.17418855350803, -0.165780519193418, + -0.157596271899945, -0.148367920785981, -0.139049231352272, + -0.132466309561858, + -0.172355756163597, -0.172153117209765, -0.171712592244148, + -0.171712592244148, -0.171712592244148, -0.268088967467647, + -0.287640893579608, -0.264410703090459, -0.247359617159092, + -0.244819881347899, -0.239614275339516, -0.231127892805236, + -0.224053637556415, -0.224804303901676, -0.228682275506799, + -0.232560110324008, -0.236437909034907, -0.239042180404911, + -0.224350382244158, -0.206270891802998, -0.155951260883626, + -0.131829826961724, -0.134396270448293, -0.14073110686908, + -0.145302408600611, -0.146597598677837, -0.14578576155083, + -0.143540659063244, -0.13617188468524, -0.120766674650094, + -0.101712471858574, -0.0870549682986277, -0.0741173573569614, + -0.0603904545470174, -0.0479876775621052, -0.0302677299483331, + -0.00793485758413753, 0.0108770871642893, 0.0220933005406441, + 0.0263226589040053, 0.0260725286509179, 0.0275634957315621, + 0.0336942262729555, 0.040714714996996, 0.0441097262498489, + 0.0420550807284884, 0.036085371956438, 0.0281759767092205, + 0.0195023105702174, 0.0106125250689201, 0.00244111103166492, + -0.00370402407633189, -0.00799298218914669, -0.0119749870485512, + -0.0165228914674733, -0.0210867433972625, -0.0251362596805477, + -0.0292588846729336, -0.0351415434361617, -0.0439746381873017, + -0.0552959289938634, -0.0681852420812192, -0.0821847378687002, + -0.0974011719793604, -0.113610385835317, -0.129727028949163, + -0.144070049253592, -0.157233064885266, -0.170920380297876, + -0.184979963137858, -0.200966003958346, -0.213294650953501, + -0.223663559711372, -0.231086421776992, -0.235749525870748, + -0.238246168312807, -0.239377282335212, -0.23979397716764, + -0.240089501587949, -0.24064063569645, -0.241656209710385, + -0.243046109110804, -0.244609853836985, -0.245995762822125, + -0.247175441096668, -0.248682414007605, -0.251253547506144, + -0.255204553267917, -0.260329749674217, -0.266504648960912, + -0.274846805584673, -0.287298371767519, -0.302955581487375, + -0.314924647605715, -0.325237917211388, -0.333835223693844, + -0.340443780382804, -0.344544582718889, -0.346868164439617, + -0.348383495867426, -0.351120748769526, -0.353154025116676, + -0.354843978674882, -0.357574756607311, -0.360388330032083, + -0.363261871396584, -0.366416330328439, -0.369398540280451, + -0.371043897368198, -0.37035939747325, -0.367798677406003, + -0.365525208186556, -0.364218280589511, -0.362307900141674, + -0.358897491526146, -0.352616348006712, -0.337690036897883, + -0.310951121598504, -0.281493497375777, -0.261297567656815, + -0.254186991764257, -0.251094596472839, -0.246942998450217, + -0.242093190573364, -0.2372432996654, -0.232393406780293, + -0.2298353005721, -0.231618279598505, -0.230146253980554, + -0.237508512220565, -0.244226170902713, -0.249421753021736, + -0.253845949748788, -0.257309950557142, -0.255598618947273, + -0.251513698378821, -0.242388273757077, -0.236359612853185, + -0.23299764130416, -0.218700083104891, -0.211797462877203, + -0.207971861967016, -0.20241685942466, -0.194913622202701, + -0.19014180896397, -0.184112890344073, -0.175564312082797, + -0.16737042417504, -0.156362603872063, -0.147262205795871, + -0.140894190642783, -0.134943705522443, -0.126553526080865, + -0.120720808536573, + -0.308739215135574, -0.308739215135574, -0.229398423078714, + -0.216471740651407, -0.265116810798645, -0.289825592725235, + -0.291182986656216, -0.269524772329356, -0.252190456740655, + -0.248957196339598, -0.243386465843399, -0.234933086104709, + -0.228624020637971, -0.231422231954878, -0.23530014287971, + -0.239177973485074, -0.243055701874916, -0.246933314820656, + -0.236837356291714, -0.21490070481598, -0.15917745637417, + -0.136166867030486, -0.137227956817586, -0.142165332362668, + -0.14610924304427, -0.146784109678503, -0.144764692588239, + -0.142057594416024, -0.134264121796813, -0.120741822531548, + -0.109991746493441, -0.105813568203837, -0.0977435384137158, + -0.0841024853243938, -0.0688457593560029, -0.0501305267373559, + -0.0292044402554773, -0.011388641233327, 0.00090554689708962, + 0.00767734122414198, 0.0111060991599686, 0.0160419929574206, + 0.0237157659002108, 0.030927561086434, 0.034700903606563, + 0.0334405061789895, 0.0284150774568216, 0.0215825764133199, + 0.0144113092875752, 0.00758481479041516, 0.00133452067106994, + -0.00341411745015457, -0.00651822505370622, -0.00930043290818296, + -0.0126679895975932, -0.0166554743388409, -0.0212901391161312, + -0.0270352622268164, -0.0350510295009741, -0.04638699954892, + -0.0603965874186243, -0.0757784171533427, -0.0915061135151085, + -0.107111552751886, -0.122441690705958, -0.136907241785711, + -0.149749166530133, -0.161634035218682, -0.17392545591992, + -0.18617261399853, -0.200423141120503, -0.211737892008421, + -0.221991249911515, -0.230073250482193, -0.235695184503991, + -0.238900823181206, -0.240321871077045, -0.240783031558541, + -0.240925754962104, -0.241099350649467, -0.24141025549448, + -0.241934807045652, -0.242758109009312, -0.243690543028231, + -0.244633196186968, -0.246075797082637, -0.248530988387082, + -0.252076009502335, -0.256763899827839, -0.26332634772475, + -0.273212186059038, -0.287348202410671, -0.303604959327394, + -0.316164493142791, -0.326876803716109, -0.335917355343429, + -0.34253889384385, -0.346422767412712, -0.348370566541369, + -0.349377226366859, -0.351753540718749, -0.35326138504166, + -0.354961317736331, -0.358054315371183, -0.361694557760322, + -0.365353868804608, -0.36898918801523, -0.372156547337201, + -0.373664776664706, -0.372818135156006, -0.369813246711765, + -0.366339324205111, -0.363873909982487, -0.361371110142345, + -0.356275785040728, -0.348167009921472, -0.333513980768639, + -0.30957947582486, -0.283337079150985, -0.263378585786734, + -0.255524885534218, -0.251808117342337, -0.247153860966744, + -0.242498878506703, -0.237843494146797, -0.233187314114583, + -0.228131696567476, -0.223771586852157, -0.220700022121647, + -0.224871652464999, -0.230507610550804, -0.235407714126695, + -0.239206318357274, -0.24053831674901, -0.240288359110057, + -0.238821940980756, -0.234197877186302, -0.227914363999101, + -0.220076648112722, -0.21368423388772, -0.206343887094776, + -0.199368116888116, -0.191229888828809, -0.182126448851566, + -0.176413977077178, -0.172081291646762, -0.164491752897319, + -0.156137314497148, -0.147206085413835, -0.140351876422901, + -0.1288639585849, -0.122190387990934, -0.114825164264586, + -0.110001860098051, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.302950273548257, -0.265116810798645, + -0.282877302141342, -0.274639806210471, -0.257022983596695, + -0.253094306208481, -0.247158967764471, -0.238749501178093, + -0.234460444124272, -0.238040237112069, -0.241918071900762, + -0.24579583310708, -0.249673508608544, -0.25355118170509, + -0.249395174560423, -0.224770762062061, -0.166018286757914, + -0.142300842648976, -0.140510501052786, -0.143063450986211, + -0.145235820819452, -0.144845960366248, -0.143034666512917, + -0.141314289377017, -0.134893664033064, -0.12334753077185, + -0.117423614479504, -0.118186325378944, -0.113423548919713, + -0.101927891049496, -0.0865817056761598, -0.0678985567967312, + -0.0487525460437628, -0.0321871089729135, -0.0188109280976919, + -0.00877792022747959, -0.00151986082118274, 0.00604329009366347, + 0.0145026926455013, 0.0211195652434787, 0.0244222772270001, + 0.0234611586379292, 0.0193186124026272, 0.013823020945924, + 0.00847663050756354, 0.00379804465339746, -0.000559750814412053, + -0.00403170790260005, -0.00639673751059209, -0.00853228407721831, + -0.0112107894313228, -0.0148183945572469, -0.0199739550456993, + -0.0273066632731237, -0.0371453636053037, -0.0500549664933633, + -0.0653384417479086, -0.0816664040963597, -0.0977166848095229, + -0.112847860489415, -0.12701150898475, -0.14019953902272, + -0.152086637074439, -0.162977872771361, -0.174052595947406, + -0.185027574420507, -0.19813335494357, -0.208997076650998, + -0.219233568610901, -0.227824033334589, -0.234338081856664, + -0.238348534625821, -0.240321212450716, -0.241221849966934, + -0.241649460869953, -0.241767044986942, -0.241673479271222, + -0.241577550403853, -0.241654453910431, -0.241946912047666, + -0.24255770238197, -0.243770361829726, -0.24581974695024, + -0.248933397959169, -0.253625934940828, -0.261145465258451, + -0.272694388469358, -0.28751487018703, -0.302867070469764, + -0.315900557761246, -0.327353495078859, -0.337127580501894, + -0.344164006543304, -0.348240411143717, -0.350067373695743, + -0.350904130394131, -0.353254975211674, -0.354437489636158, + -0.356085970915078, -0.358972764537481, -0.362980960862531, + -0.367220519814173, -0.371180842569757, -0.374252612881803, + -0.37552780262171, -0.374373002094168, -0.370654476907578, + -0.36616039495876, -0.362917677633526, -0.360322324460095, + -0.354882882856929, -0.345930478865831, -0.330473763235243, + -0.307103490880286, -0.278809032136564, -0.263877999556467, + -0.258566649910719, -0.254810274499648, -0.248214755406192, + -0.241619321230885, -0.234757549265299, -0.227821677032324, + -0.22220534303981, -0.217513282706398, -0.214274099076803, + -0.215598856050265, -0.218344941702983, -0.22142014996254, + -0.220444382260083, -0.220266052244668, -0.223256590313384, + -0.222987360884229, -0.220842748644947, -0.215700607152747, + -0.206743730541752, -0.199745695908663, -0.195496975870023, + -0.190154240428388, -0.182374227137697, -0.173175950627196, + -0.164321991312096, -0.15956437912553, -0.153906492941463, + -0.146084784463559, -0.139942324614542, -0.133854763923796, + -0.119321965363824, -0.108708477257865, -0.103210755400317, + -0.0996283823099703, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.308739215135574, -0.314248320770758, + -0.292643745652558, -0.279754433549436, -0.2618574052322, + -0.257231516015435, -0.250931509691695, -0.242791538533908, + -0.240780314608667, -0.244658232004937, -0.248535925117235, + -0.252413720440094, -0.25629137641085, -0.260168957562043, + -0.261951806957819, -0.231198425444507, -0.179561526488507, + -0.153492362552563, -0.146635808908949, -0.145048128805531, + -0.144470508885457, -0.142908677844471, -0.142191686740663, + -0.142068967699582, -0.139385919182983, -0.131920237260367, + -0.125735017789421, -0.124903606770702, -0.123279772401369, + -0.115619944217184, -0.101052138129987, -0.0818244628598339, + -0.0630402721292489, -0.0469241899593634, -0.0331851407818859, + -0.0224758898699535, -0.0140237578411764, -0.00507433219400951, + 0.00372006744361801, 0.0100100680097624, 0.0133883383339991, + 0.0131907019129499, 0.0101135031800115, 0.00627105148556323, + 0.00301575111226859, 0.000358398565500972, -0.00240437926775981, + -0.00503977965992281, -0.0072881464891492, -0.00938608671042651, + -0.0117597303190151, -0.0151271736272905, -0.020606301169149, + -0.0289611241247021, -0.0397955269194225, -0.0531415473346033, + -0.0683460992090237, -0.084301813479043, -0.0997275934992791, + -0.113936834298086, -0.126965523187048, -0.139167714108762, + -0.150416633965486, -0.160695962547613, -0.17106067780807, + -0.181403048662396, -0.193923228272435, -0.204803685514556, + -0.215196818605859, -0.22420665563062, -0.231519044706957, + -0.236418194078082, -0.239206073067835, -0.240825117774221, + -0.241738065174697, -0.241979681650934, -0.241745189362769, + -0.241211331122461, -0.240586711671279, -0.240271931595661, + -0.240630603155136, -0.241556804904474, -0.243147066817879, + -0.246143202728138, -0.251353320557249, -0.259841857295381, + -0.271841388544331, -0.28606385504557, -0.304539342699397, + -0.314147970582805, -0.32662148167991, -0.3371436376189, + -0.344991933453399, -0.349831392885691, -0.351811142167694, + -0.35263699926338, -0.355181585203755, -0.356310611552175, + -0.357871510943661, -0.360311034050812, -0.363934961932619, + -0.368169654751983, -0.37193106814065, -0.374896713881915, + -0.376138105868184, -0.374642530229536, -0.370265925956006, + -0.365118732287759, -0.361335792104588, -0.358132060547835, + -0.352815795755298, -0.343902074475196, -0.327625414153276, + -0.302752596101166, -0.277163542235782, -0.266121758492081, + -0.259241984302842, -0.254076394931561, -0.247477976446457, + -0.240879704560894, -0.23436817300738, -0.227939285101141, + -0.222177214634208, -0.213430929119092, -0.20907234766613, + -0.20629231164185, -0.204430251242974, -0.204635082956734, + -0.202973746518069, -0.201464031610842, -0.204297440970589, + -0.206427273767941, -0.206420027198084, -0.203828703870696, + -0.195602969131756, -0.186734197543103, -0.185976488814342, + -0.182893599845157, -0.175043002030314, -0.168688932193252, + -0.16150802873832, -0.155513616414774, -0.148667335797101, + -0.14124948215955, -0.134258830921412, -0.130011699941905, + -0.11502267861239, -0.0978329384569318, -0.0928494060621601, + -0.0919678339931357, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.30277478857773, -0.28486983505331, -0.266118755671853, + -0.261368762301872, -0.25470425812145, -0.246997071283729, + -0.247398381394602, -0.251276182996112, -0.255153975718017, + -0.259031712523376, -0.262909353361104, -0.266814883949241, + -0.268565303914443, -0.234894538585828, -0.195239401096001, + -0.168978199247515, -0.156519795043919, -0.149572219196993, + -0.14530442374304, -0.142727875225638, -0.142260303923573, + -0.142986150623832, -0.142168416598507, -0.137312924553725, + -0.130926180570182, -0.1278901250193, -0.127287701771252, + -0.123023716167688, -0.109303408766312, -0.0895215360078225, + -0.0716833978477411, -0.0571810981085128, -0.045626831430716, + -0.0362857324909931, -0.0272188236558578, -0.0166879765163935, + -0.00663475507104721, -0.000220770436014073, 0.00328949473670163, + 0.0034987866654969, 0.00138396585005343, -0.000764549851798888, + -0.00194380767007009, -0.00284971564528253, -0.00436771603236288, + -0.00658053647830004, -0.0091006933785124, -0.011456148340916, + -0.0137684419599502, -0.0170029900962664, -0.0225654746629636, + -0.0311227680837624, -0.0419580618280762, -0.0548609950934552, + -0.0693229222509854, -0.0846065362982611, -0.0994761414474124, + -0.113056158086526, -0.12527065354384, -0.1366131245783, + -0.147217530691678, -0.157199159368898, -0.167188687582013, + -0.177005674161443, -0.1886665444376, -0.199080429935086, + -0.209122251667809, -0.218162450644369, -0.226134358910434, + -0.232063364593235, -0.235872844447029, -0.238279073486693, + -0.239787485080049, -0.240558320534679, -0.240587158594107, + -0.239839976654755, -0.238643538766174, -0.237848475840129, + -0.23812327267694, -0.239133406304648, -0.240837738037403, + -0.244226338339758, -0.250256313830307, -0.259462691707003, + -0.270928870537215, -0.283792407478953, -0.300239366084561, + -0.310891820926933, -0.323942570956197, -0.335203751285327, + -0.344260050354491, -0.350265516982251, -0.352799706157252, + -0.353864103143549, -0.356870694378199, -0.35833691306557, + -0.360037387287223, -0.362323085034139, -0.365566493215014, + -0.3691044532337, -0.371947134012739, -0.374302117569945, + -0.375302089358545, -0.373493619617424, -0.369079598588258, + -0.363973037900593, -0.359820796199177, -0.35570398146529, + -0.350012400270348, -0.340428462866237, -0.32275127471139, + -0.297541514796417, -0.277322067527314, -0.266017112801771, + -0.257391234316333, -0.253462877151787, -0.247085121681658, + -0.240702431361792, -0.234319573375875, -0.227936577857176, + -0.224311778692329, -0.214310160231959, -0.205094267961814, + -0.199203514031278, -0.193621952619705, -0.187110238180457, + -0.185475183360742, -0.184214142697391, -0.183650383699929, + -0.186074202206301, -0.184357152720117, -0.183220565800983, + -0.181273895177824, -0.174852368591614, -0.174000201443719, + -0.170280033505093, -0.167352816458776, -0.163855581892672, + -0.161327675477033, -0.157154069543901, -0.150559927414497, + -0.142168691678298, -0.129937277157718, -0.116534071589772, + -0.106895647431929, -0.0986697186863586, -0.0900195202340346, + -0.0898993646845143, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.310225928813125, -0.289916925805838, -0.27494374768732, + -0.265494026524711, -0.258476794778795, -0.251435681247259, + -0.254016481055945, -0.257894306096436, -0.261772021797159, + -0.265649686296507, -0.269527327202709, -0.275403862736474, + -0.277209543319935, -0.251415058359962, -0.216424197594996, + -0.187632277203644, -0.167873974229722, -0.155411980603495, + -0.148267575900096, -0.145183172055265, -0.14434160685581, + -0.144978095785251, -0.144340873351628, -0.140471332723099, + -0.134756480715378, -0.13084051691597, -0.129788406985496, + -0.127299363827665, -0.116186327763253, -0.0979235335030497, + -0.0817724469776361, -0.0696881044743555, -0.0602959005722338, + -0.0508287150925039, -0.0389183330442326, -0.0250247023932416, + -0.0136731257101582, -0.0077353944439496, -0.0052442050299127, + -0.00564219241831422, -0.00730817066742986, -0.00810023540343278, + -0.00758988821115081, -0.00705221379035795, -0.00762702615081305, + -0.00956551584697378, -0.0123470666533792, -0.0150436056344493, + -0.0173914017178476, -0.0203870116947212, -0.0255004859067071, + -0.0333838816490606, -0.0433921518457966, -0.0553720930990599, + -0.0690075191165885, -0.0840162304609715, -0.0990633199296549, + -0.112727805796423, -0.12452156737148, -0.135131446173248, + -0.145152543259603, -0.154988973992239, -0.164751749689813, + -0.173888856326836, -0.183982844003629, -0.192879759477144, + -0.201310169831209, -0.209429535784446, -0.21748384974831, + -0.224358187916688, -0.229160139687169, -0.232202174364777, + -0.234271769488838, -0.235830733032689, -0.236649174675853, + -0.236233356311749, -0.23491883138216, -0.233979802440685, + -0.234501488922256, -0.2362802652526, -0.238994596147961, + -0.243296645408763, -0.250148594196326, -0.259778323203823, + -0.270529968245009, -0.281685415768326, -0.295264289894946, + -0.305699066108555, -0.318247331264418, -0.33058919588091, + -0.342148124935907, -0.349776342601283, -0.353063156346754, + -0.354533256101867, -0.357922147098448, -0.359909170707443, + -0.362155100004432, -0.364982260523769, -0.368003225964711, + -0.370333165800751, -0.371636806031263, -0.372701826715603, + -0.372702547088035, -0.370679732857196, -0.366876470336504, + -0.362323486381373, -0.357970693298447, -0.353171364761768, + -0.346470561373175, -0.335451186855931, -0.317236306149083, + -0.296324798416537, -0.279920179602956, -0.260498554956149, + -0.24882178817367, -0.251280135734417, -0.247919200837267, + -0.240466448514403, -0.232692245179854, -0.224762884832553, + -0.219927644457345, -0.211771421388278, -0.199305143462113, + -0.192184962804696, -0.188269565485052, -0.174048482171401, + -0.166193510167606, -0.162828761804127, -0.168817474879778, + -0.164898887892791, -0.163003765454915, -0.161115311956703, + -0.162262895040746, -0.161049130850264, -0.156817750696642, + -0.154143870923345, -0.157794417594898, -0.156612490400066, + -0.154631357761897, -0.153682272037085, -0.145442970133731, + -0.139240457701959, -0.128956230619167, -0.110860568930607, + -0.11287119206127, -0.0973713451603598, -0.0927199390522787, + -0.0923192362425969, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.317398749959095, -0.294658476447536, -0.275555536307622, + -0.269600588836155, -0.26224981408505, -0.25675687192896, + -0.260634652543004, -0.264512444486327, -0.268390147571909, + -0.272267711968433, -0.277157869115389, -0.284803608816089, + -0.286358236408642, -0.26951570829501, -0.231788267293275, + -0.200323243210281, -0.176043873802242, -0.16030367479124, + -0.151913252269279, -0.14843255301967, -0.147392375060373, + -0.147282978394945, -0.14621731763166, -0.142959203761661, + -0.138242852128572, -0.134386203212048, -0.132394654628049, + -0.129949030838474, -0.122190992341782, -0.108909523585697, + -0.0961276616553722, -0.0852007388430895, -0.0750078588737284, + -0.0628170499469027, -0.0466516413784053, -0.0301094674617638, + -0.019072865270931, -0.0143193457665822, -0.0133993927316917, + -0.0151478009213942, -0.0170988832562265, -0.0172568202122126, + -0.0156328323443478, -0.0138557091168358, -0.013452040628464, + -0.0148735691803545, -0.0175086794095582, -0.0203446715637303, + -0.0228794725970022, -0.0256803871819449, -0.0299676495525867, + -0.0366001874930895, -0.0453037898881663, -0.0561665996619442, + -0.0691431238020726, -0.0842343061844344, -0.0999196877830285, + -0.11419340484639, -0.126095572913771, -0.13634373813959, + -0.14582672357777, -0.155219730402544, -0.164610688850901, + -0.173052871412523, -0.181441977535514, -0.188485907644918, + -0.1949513196042, -0.201699801705686, -0.209150227254785, + -0.215982900283907, -0.220868514009456, -0.223754271524803, + -0.225585209630264, -0.227474808362684, -0.22932848017365, + -0.22992965268649, -0.229217711451047, -0.228714123413567, + -0.229866747564435, -0.232786385757727, -0.236973242396514, + -0.242527214351738, -0.250038497149187, -0.259277336617238, + -0.268918115457684, -0.278527310240491, -0.289540144549589, + -0.2993112265343, -0.311544193992247, -0.326025205720485, + -0.340921276436771, -0.350267152760011, -0.35393728171009, + -0.355815986294255, -0.359126964378073, -0.361147271280792, + -0.363960742832786, -0.367545161903439, -0.370242838756535, + -0.371031862466749, -0.370440917191312, -0.369453197094948, + -0.367831346069415, -0.365376035876642, -0.362064865239731, + -0.358157836843638, -0.354144554747106, -0.349400574318405, + -0.342263086348815, -0.330560847934465, -0.313420202671978, + -0.294491594983278, -0.274191430825482, -0.255693475102952, + -0.244994295916829, -0.239548741883779, -0.242293063858635, + -0.235270271007316, -0.228561711572292, -0.223574701332076, + -0.21478096667663, -0.206032039961904, -0.195652047141161, + -0.18736624961563, -0.177917662912225, -0.166829121757992, + -0.1609494359372, -0.155683747888609, -0.157702365104498, + -0.1605408363986, -0.158044423318561, -0.149794035018863, + -0.150321000075541, -0.142049054339811, -0.138860236049519, + -0.141299814452433, -0.143667797327546, -0.144675271512216, + -0.146565573089126, -0.145161444218633, -0.141337246044833, + -0.134687022586786, -0.127243042157244, -0.116072307437846, + -0.108584223583626, -0.105271306231761, -0.0936834160094633, + -0.0874313951679203, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.309359048363512, -0.299381214238205, -0.277589553983417, + -0.273707225917589, -0.266093675633866, -0.263375151443654, + -0.267252898418684, -0.271130610985449, -0.275008179874663, + -0.279291652863292, -0.287222037141416, -0.296044089797851, + -0.299770546193291, -0.27170862435966, -0.232622177014964, + -0.204302215151638, -0.180395520718196, -0.164126071357499, + -0.155578665487177, -0.151336306614127, -0.149724422223142, + -0.148943009307063, -0.14778198116019, -0.145180557824692, + -0.141363468455896, -0.137725916392164, -0.134930643948242, + -0.132482904528897, -0.127381820826113, -0.118667750329537, + -0.108870869677475, -0.0978921422136526, -0.0851630269407314, + -0.0696948546524728, -0.0512486009072031, -0.0348590300837123, + -0.0253195057136844, -0.0218723712341059, -0.0224218427298927, + -0.0255587772866698, -0.0284861718992688, -0.0289946065626127, + -0.0268340894286812, -0.0238041122009161, -0.0219366592858872, + -0.0222756150314068, -0.0242427861504073, -0.0269052119185661, + -0.0297393491474937, -0.0326750640812336, -0.0363676822494089, + -0.0418160407979542, -0.0493207365782131, -0.0592751177475311, + -0.071765226848944, -0.0868628934908718, -0.102858540119546, + -0.117567891517829, -0.129719586269562, -0.139765798534171, + -0.148532568971329, -0.15701912402117, -0.165683941079941, + -0.173548696841085, -0.180997778446361, -0.187063496895364, + -0.19226842550631, -0.197581284115244, -0.203499313635239, + -0.208773941243994, -0.212368018683429, -0.214126354589952, + -0.215007727721412, -0.216390927828691, -0.218805000900227, + -0.220619219790348, -0.221172685280997, -0.221893823211107, + -0.22412925913967, -0.228090285809559, -0.233414252118661, + -0.239943897793142, -0.247621505382956, -0.255853595780513, + -0.264328847849979, -0.273544930720793, -0.283876381638518, + -0.29396917988818, -0.307009986107836, -0.324450423924464, + -0.342072880583749, -0.352686815948974, -0.356277816641348, + -0.358188764800475, -0.361001562860501, -0.36284911849431, + -0.366101261888062, -0.369789705557039, -0.371565904746401, + -0.370662565286673, -0.367846598233568, -0.363972894499944, + -0.359983041972636, -0.356570231271483, -0.353623188414422, + -0.35083425348438, -0.348280583430633, -0.344786317450037, + -0.338152520013308, -0.326006546210998, -0.308146430514358, + -0.287325338609378, -0.268307293295277, -0.255242548789822, + -0.246098905442067, -0.237204613824396, -0.230386305928173, + -0.225851749546205, -0.226834024123995, -0.222044967849348, + -0.21216737626109, -0.204723173666817, -0.189557655619262, + -0.177607060073575, -0.169500789575974, -0.164298944392653, + -0.159726682191415, -0.157058953643772, -0.153435855328, + -0.150943522107061, -0.147923205519368, -0.144009786004785, + -0.139856824184296, -0.134677830569558, -0.132240953282068, + -0.132991086358511, -0.134334553377894, -0.135419560653966, + -0.140717877391975, -0.14146717377558, -0.135301251599464, + -0.131957985634122, -0.12967183568048, -0.121287104159074, + -0.110150384076075, -0.100517767520952, -0.0898565920709584, + -0.0786895350008479, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.31231110186435, -0.302450520961457, -0.282465298728988, + -0.277813929633309, -0.27009072772788, -0.269993336243276, + -0.273871112985025, -0.27774880286538, -0.281661098889819, + -0.288945846686291, -0.297316734844832, -0.3091413250928, + -0.302324841380831, -0.26231091808785, -0.227639929514582, + -0.20268525578357, -0.181910434096378, -0.167471804415987, + -0.15887890034867, -0.153731415539145, -0.151410996471063, + -0.150152872857927, -0.149092737620292, -0.147060243503444, + -0.144048537283387, -0.140648061149942, -0.137333922595663, + -0.134608927263316, -0.131477073106255, -0.12649924558728, + -0.1182523736838, -0.105890090860644, -0.0904742020098562, + -0.0732811419602282, -0.0554096268562011, -0.0412175392172935, + -0.0332003346735556, -0.0306917810371033, -0.0323380232282645, + -0.036755988616768, -0.0410565012837037, -0.0426957118160106, + -0.0406925675476859, -0.0365428557114683, -0.0329127586950299, + -0.0316366263263696, -0.032574023556666, -0.0348206516911487, + -0.0375232759826311, -0.0402158672300902, -0.0434057932874673, + -0.0481397099727423, -0.0550833971832761, -0.0647573014810983, + -0.0770834357131318, -0.091855096814804, -0.107268907788432, + -0.121389211097349, -0.133196882749476, -0.14294979695593, + -0.150966228582677, -0.158473023096278, -0.16625799965236, + -0.173433662449794, -0.180272060555586, -0.186005433506672, + -0.190471728076011, -0.19433247796336, -0.19801515012495, + -0.200826041730104, -0.20212624759393, -0.202169911201164, + -0.20209573902671, -0.203045540958365, -0.20568654321604, + -0.208441215831235, -0.210508667310929, -0.21299129446921, + -0.21674522428648, -0.221856934144292, -0.227942162478055, + -0.234682804167635, -0.241757822057089, -0.249307070367507, + -0.25800265536434, -0.268290565958249, -0.279115818541143, + -0.290546985470345, -0.30611346067668, -0.326737590208266, + -0.345427771975351, -0.356281889804914, -0.35942098604965, + -0.360935398700728, -0.36280322751747, -0.364601317859089, + -0.368028211159883, -0.370994573859234, -0.371394579512385, + -0.368818048282376, -0.363701371439866, -0.357080382311113, + -0.350881918144992, -0.346402046167743, -0.343905034219362, + -0.342726620765797, -0.342187766843469, -0.340140745983135, + -0.334195422112128, -0.321711680437542, -0.302818960368178, + -0.281740745573172, -0.264826048511366, -0.251246308167049, + -0.241726569897399, -0.235985642626888, -0.229917061497979, + -0.222460589155743, -0.218832852033669, -0.215074350138672, + -0.208317604490934, -0.201186239689101, -0.188095653961783, + -0.17594434018851, -0.169158208560309, -0.162168245919817, + -0.158573155398145, -0.156189882516432, -0.152709766251927, + -0.150935859354506, -0.139885777919954, -0.131478939862788, + -0.132219786179271, -0.129689825073907, -0.124410712384578, + -0.127303453581653, -0.133914377051568, -0.1326966288638, + -0.135258151938366, -0.140612541954925, -0.135820621389686, + -0.125583194099369, -0.121550023360224, -0.120151362243877, + -0.114727761722829, -0.107008954120613, -0.0928685358887283, + -0.0672423752628646, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308978676435704, -0.30632187883829, -0.28763857020181, + -0.281920888321557, -0.274376311935901, -0.276611715980133, + -0.28048943065224, -0.284367083963493, -0.290672209657367, + -0.29904063408996, -0.307169480306509, -0.315044372724779, + -0.291116143285705, -0.255300217885692, -0.223079308705035, + -0.19986729606481, -0.182934533205793, -0.17047972830468, + -0.16204235975191, -0.156285037806534, -0.152758981359338, + -0.150982166313311, -0.149772592604902, -0.148223025739381, + -0.146130759067084, -0.143019316980169, -0.139366372222734, + -0.137409323939428, -0.136327935579003, -0.134828498358275, + -0.127602781266956, -0.112840222626341, -0.0945505266652564, + -0.0770705101103384, -0.0614967549596406, -0.0498459380658602, + -0.0429770968795974, -0.0406923503980825, -0.0429883083986832, + -0.0486094761943765, -0.0542594818838685, -0.057011667073378, + -0.0555573087568887, -0.0512234660111483, -0.0465454484196806, + -0.0438092790213362, -0.0434015152056897, -0.044485451264854, + -0.0459457468501738, -0.0474764641406312, -0.0500698153375324, + -0.0546278330897614, -0.0617057304094428, -0.071573410715504, + -0.0837337096438203, -0.0975173472963935, -0.111302874150385, + -0.123706116271698, -0.134307922146878, -0.14327408786429, + -0.150559139550805, -0.157295315171662, -0.164413473630886, + -0.170944790546374, -0.177186775358363, -0.182521487233436, + -0.186260789105083, -0.188748458915955, -0.190711531046135, + -0.191575867845446, -0.190689077355752, -0.188903179937103, + -0.187893525374506, -0.18867343165201, -0.191146204714068, + -0.194682584212473, -0.198735228182977, -0.203175967202066, + -0.20829304507413, -0.214138318323189, -0.220741788686769, + -0.22764903112242, -0.234699207968804, -0.243011675838746, + -0.253077734468468, -0.264158558300918, -0.275218305650092, + -0.288546873765327, -0.307823019238464, -0.330732812103336, + -0.34928622970356, -0.359730396935522, -0.362231825161121, + -0.362842321425648, -0.363252693876716, -0.364513463776181, + -0.367211449195711, -0.368997672131798, -0.36847065005892, + -0.364808005536159, -0.358051674969822, -0.34980250361495, + -0.342290543426957, -0.337315397715561, -0.335423528911089, + -0.335686864441682, -0.336437357471405, -0.334977880765021, + -0.329445504606762, -0.317647514158753, -0.298744002677916, + -0.277929354228302, -0.261415481365924, -0.24811658784352, + -0.241608853865362, -0.236555217209951, -0.23056058723745, + -0.223304799372605, -0.21887027324822, -0.215825295911965, + -0.208479329033835, -0.20088841441429, -0.18972682583596, + -0.176450628817768, -0.171540882628014, -0.165471126514844, + -0.158391702885301, -0.155228358565293, -0.149761095307907, + -0.147905374198099, -0.138292765055219, -0.13323940416596, + -0.129591317762175, -0.126320805447022, -0.119197704633474, + -0.129122018589618, -0.134694891611281, -0.1341700830981, + -0.132654841209703, -0.136118886402787, -0.129672342088902, + -0.117407719890573, -0.112861663400244, -0.115884579775649, + -0.111620778244383, -0.107567258940802, -0.0964799971891803, + -0.0671879019760109, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.311143031773051, -0.291962516923144, + -0.285739904112668, -0.279834538304764, -0.28323013468974, + -0.287107796154654, -0.29239309527322, -0.300764359042908, + -0.309135435198173, -0.314444838290397, -0.301613410231948, + -0.277333643254233, -0.245703640181285, -0.218362623287018, + -0.198232475144196, -0.184143271731875, -0.173239990532951, + -0.164275704213916, -0.157532949236823, -0.153081236902895, + -0.150869376519193, -0.149771175053403, -0.14872073442751, + -0.147592197078214, -0.145385459675989, -0.142820319154598, + -0.143087451075697, -0.143737894529552, -0.143616094264322, + -0.137331995036712, -0.121681895177189, -0.10148610560238, + -0.0842577873239605, -0.0707238829422089, -0.0603590315710941, + -0.0543148395598969, -0.0527535123486859, -0.0554526625438424, + -0.0615244221852403, -0.0678482551919315, -0.0711977706516988, + -0.0703761492147446, -0.0668735473321103, -0.0624175918654253, + -0.0586167978672137, -0.0563356039623496, -0.0551684113557314, + -0.0543191797882602, -0.0542730821880057, -0.0563841822043895, + -0.0611509058924003, -0.0686965118977748, -0.0787781911485052, + -0.090512911313335, -0.102677276330919, -0.114099227345618, + -0.124047266566861, -0.132679484874275, -0.140263761757463, + -0.146677299720941, -0.152788532254031, -0.159420288911592, + -0.165621977477061, -0.171225754485317, -0.175698487066665, + -0.178777448841592, -0.180929396664553, -0.182419572114832, + -0.182533474120845, -0.180577476387142, -0.177666826430799, + -0.175709629335308, -0.175760016038021, -0.17773687530003, + -0.181629010452618, -0.18739638935568, -0.19409430575473, + -0.200201592466098, -0.205385271008092, -0.211216765152225, + -0.21823816538575, -0.226523101308229, -0.236675032590022, + -0.248013933503623, -0.259163078945845, -0.270681939214466, + -0.287219833120232, -0.31039445021935, -0.334066184893105, + -0.352023685329235, -0.361635231539127, -0.363525455175514, + -0.362855063579781, -0.361659480605607, -0.361422996290964, + -0.362155560551048, -0.362508244754888, -0.361872809067385, + -0.358282427196134, -0.351164683196897, -0.342378577821246, + -0.334543685632072, -0.329789348893075, -0.328846294932435, + -0.330157416306098, -0.33100329498862, -0.328794441437492, + -0.322787420385085, -0.310957124844044, -0.291966636082925, + -0.27149311392634, -0.25675656905512, -0.247038860819212, + -0.241475767460786, -0.236442778200801, -0.231173550761813, + -0.224801535077668, -0.219085163896016, -0.214901217668315, + -0.206935487404344, -0.195967832554978, -0.18477988162534, + -0.166057754212873, -0.153675654931244, -0.151870051796764, + -0.151183221623519, -0.151093049917632, -0.145824628594564, + -0.139229333562224, -0.134783308733908, -0.129391043729146, + -0.126569060067818, -0.123878701985511, -0.125834237310604, + -0.12827242168219, -0.129915773834432, -0.129199522302771, + -0.125527207068198, -0.12623204499359, -0.11818020157708, + -0.103535889347819, -0.100088916169593, -0.106995795132694, + -0.110860118959138, -0.107099296951946, -0.0900274878170891, + -0.0568762267524329, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.311355950876812, -0.300926110249831, + -0.28952905153177, -0.285970946932875, -0.28984853805546, + -0.294388246643212, -0.302488208088952, -0.310859418565193, + -0.316746854796678, -0.308843997105501, -0.289789285521465, + -0.266301866106015, -0.238196159850568, -0.214597942659803, + -0.198031289727995, -0.185704157640792, -0.175369477725035, + -0.16566858398417, -0.157935677722858, -0.153038077216536, + -0.150474660604289, -0.149533737797321, -0.149189443997306, + -0.149079675586139, -0.148236358238033, -0.147221445868283, + -0.147603255871185, -0.148193886567042, -0.147112736150263, + -0.141335697736786, -0.129811399217244, -0.114367170231359, + -0.0979263434942026, -0.0833306402025448, -0.0724143373730367, + -0.0673291631128662, -0.0671401080003326, -0.0701995546665106, + -0.0759923149484939, -0.0819485311583727, -0.0849897542875938, + -0.0843847645245977, -0.0819753567973053, -0.0783663597933704, + -0.0736471246441988, -0.0689362797441162, -0.0649148900801823, + -0.0617511510213489, -0.060585365704016, -0.0625963125200516, + -0.0677195498094701, -0.0756540167083909, -0.0856471704844008, + -0.0965601671071414, -0.106964071599521, -0.116029560988429, + -0.123379113044897, -0.129645354515244, -0.135380641310459, + -0.140661192402835, -0.146123025902147, -0.152676444711863, + -0.158987674065131, -0.164231071197918, -0.16803023073704, + -0.170782311719857, -0.172843368935808, -0.17418344633209, + -0.174235446557496, -0.172325645657764, -0.169279821678654, + -0.166763231472023, -0.166114549790949, -0.167327088651584, + -0.170687801563772, -0.177168396903542, -0.185729587870526, + -0.192656105055197, -0.196103972803715, -0.199640297738564, + -0.205912229729387, -0.214901882117124, -0.226220573145842, + -0.238549399688828, -0.250513350660597, -0.265115861049052, + -0.285937982522236, -0.311527718007766, -0.335082551171963, + -0.352327343779107, -0.361297593983806, -0.362681487332198, + -0.360752027876234, -0.357765749449112, -0.355450729582395, + -0.353840664822696, -0.352928184915221, -0.352399067560481, + -0.349553091631614, -0.343318806130295, -0.33495255079168, + -0.327486174922509, -0.323454483704438, -0.323801891479292, + -0.325907351630825, -0.3263358864637, -0.322068308195371, + -0.313119477397896, -0.298082266628278, -0.279110697290453, + -0.263489361528953, -0.251030462753197, -0.240500324127234, + -0.237385710012819, -0.233470791824059, -0.225321458822574, + -0.213157812052636, -0.199930440270202, -0.194400538303725, + -0.18924757430307, -0.18446100122865, -0.176700425559476, + -0.160947941509221, -0.154043884805327, -0.154762832396739, + -0.156359705181347, -0.147596807513432, -0.145745278220774, + -0.13826588817967, -0.136325698587445, -0.131202277763432, + -0.126822344295388, -0.126818874419369, -0.141744442290938, + -0.141019618487695, -0.132022258738186, -0.121582019981874, + -0.112462121651056, -0.107539962768873, -0.102869770590736, + -0.0950910409902944, -0.0875854440416877, -0.0982025725100229, + -0.0980814270879662, -0.100416164152823, -0.0756955878972055, + -0.0896510765421701, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.312209907121816, -0.304022930519321, + -0.293319022761876, -0.29258948288989, -0.296558481272142, + -0.304212031009739, -0.312377841179641, -0.315498621263143, + -0.315917927393758, -0.308759383469547, -0.287422318382698, + -0.260220183083845, -0.234381849631158, -0.213245510758917, + -0.198749732902313, -0.18720823611158, -0.17636126806829, + -0.166007728000671, -0.157877104261148, -0.153461979771409, + -0.15090562188078, -0.149769731515344, -0.149901477040843, + -0.150608367450417, -0.15055635727782, -0.150219938905284, + -0.150053631418704, -0.149246843791524, -0.14729434698375, + -0.144169219091157, -0.139278956000013, -0.127688911920809, + -0.110705440125254, -0.0954371028189986, -0.0861948944311545, + -0.083261504684811, -0.0835898981482717, -0.0862569523604309, + -0.0912952838262713, -0.0960325163321153, -0.0980391215062653, + -0.0966235729965669, -0.0941853518677671, -0.090827639105132, + -0.085354878861695, -0.0788063720086859, -0.0726714675531553, + -0.0681766534178436, -0.066664886992549, -0.0687619352302835, + -0.0740317471979648, -0.0818947899910992, -0.091356722698144, + -0.101202483310146, -0.110109395493553, -0.117317769850519, + -0.122442428135684, -0.126478770412185, -0.130327037304004, + -0.134396190424875, -0.139248418284535, -0.145806256227402, + -0.152381564514395, -0.157875868928238, -0.161716081665335, + -0.164109817456363, -0.165384636362312, -0.166107121094133, + -0.165941456642302, -0.164228943708198, -0.161537628613666, + -0.159157371082451, -0.158419376625981, -0.159533273648106, + -0.162664630001962, -0.169235731725999, -0.17814806914061, + -0.184715323364057, -0.186433957866253, -0.187654334088119, + -0.192537423068719, -0.201266855864527, -0.21235617238781, + -0.224937284693337, -0.24382394419539, -0.257750152707003, + -0.282193877118903, -0.309050267712704, -0.332362472126524, + -0.348460968924885, -0.356957434883107, -0.358627605914832, + -0.356336674751998, -0.352154517239789, -0.348035538969679, + -0.344720836209923, -0.342702570473882, -0.34190724519457, + -0.340017248661114, -0.335487162893847, -0.328468128077349, + -0.321601559763834, -0.318239471532067, -0.319533413903998, + -0.322281084426986, -0.321897803014351, -0.314775752365853, + -0.301645543305345, -0.283226171606949, -0.265968527865638, + -0.254198284719225, -0.242737562315412, -0.235406276784491, + -0.237734363083534, -0.217197577604082, -0.192541970451087, + -0.179460139672437, -0.172424150860062, -0.168653501147398, + -0.16753462041413, -0.168732300001084, -0.167639640975974, + -0.163892133202389, -0.157028070797913, -0.158934716232044, + -0.168098470857233, -0.147641247043496, -0.144500944147472, + -0.141116412391827, -0.137904590976351, -0.135419208392781, + -0.139264973687825, -0.141801177158432, -0.137605934888889, + -0.131760977775872, -0.125915818538696, -0.119845626202232, + -0.112319928326945, -0.104799736157135, -0.0962357238155664, + -0.0863828703757792, -0.0784169400609367, -0.0795693169720469, + -0.0916768395478962, -0.0899197774085163, -0.0869618018945732, + -0.0840036867926318, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.322198334027194, -0.306751288084794, + -0.297128192848614, -0.299235824719853, -0.305935721521963, + -0.312801351601701, -0.31438278725396, -0.315247687863179, + -0.314084572347779, -0.308709438904784, -0.285824954384017, + -0.258387443586474, -0.232797849065804, -0.212219740684419, + -0.198155103254996, -0.187098143715106, -0.17610041883667, + -0.165459614975439, -0.157541286601056, -0.153813579173776, + -0.151710883112649, -0.150594486190582, -0.15100207604456, + -0.151966472762461, -0.152260731705745, -0.151817898999114, + -0.150613134428969, -0.14917695814529, -0.148385647762592, + -0.147892183494106, -0.144480100724744, -0.132091590681774, + -0.115776040090782, -0.105591650970956, -0.102012811923418, + -0.101574395903181, -0.101497411352221, -0.102748126673335, + -0.105930727488032, -0.108785531739564, -0.109106323770203, + -0.105624160214571, -0.101279421786477, -0.0971893791336217, + -0.0920859146058142, -0.0857909384371774, -0.0792460762872945, + -0.0745515111812443, -0.0730355656075797, -0.0749273704883102, + -0.0798544707718718, -0.0872644117636937, -0.0960227295772741, + -0.104831003788528, -0.112546786743813, -0.118422095813871, + -0.122037994044848, -0.124436513225531, -0.12669503041133, + -0.129409288186441, -0.133269813771534, -0.139277059758622, + -0.145733465389754, -0.151497179624719, -0.155450531024773, + -0.157336112408218, -0.157650217077054, -0.157479540179663, + -0.156860924458239, -0.155343291527783, -0.153440761431867, + -0.152255473190311, -0.152523952763748, -0.15469383310311, + -0.158400507692074, -0.164547010375832, -0.172255745582015, + -0.1771930541518, -0.177418841846463, -0.177277843586156, + -0.181100563037132, -0.188973898592419, -0.197969015767631, + -0.209441646479013, -0.229666906112545, -0.246893037349935, + -0.272966169703693, -0.300385570023472, -0.323573027396986, + -0.338931469665011, -0.348022485828114, -0.351221670980029, + -0.349904119859177, -0.345756055521645, -0.341027338983824, + -0.337050707158555, -0.334525662545704, -0.333402111247851, + -0.332097269972253, -0.329140354130725, -0.323565701366288, + -0.317368948792453, -0.314628965137495, -0.316278689063418, + -0.318895458549458, -0.316533452885645, -0.306939575499689, + -0.292543669556923, -0.276207790556688, -0.261281462831427, + -0.248795431731653, -0.237988691196971, -0.231402920068511, + -0.222515143868186, -0.195251776201008, -0.177260508930254, + -0.173114253376435, -0.164251867950808, -0.157445022277997, + -0.158216187141661, -0.167109615579186, -0.160472638757204, + -0.161258978649361, -0.15687246505168, -0.152536685143218, + -0.148663703020023, -0.148827488891867, -0.138954669471901, + -0.140260656397807, -0.140005545268808, -0.134036707604146, + -0.128317538282531, -0.122607106031243, -0.116896313640065, + -0.111185728788276, -0.105474804059991, -0.0997636688453166, + -0.0940524767242398, -0.0883408911108795, -0.0826293699081779, + -0.0769179977419166, -0.0741719226068181, -0.0851038115773556, + -0.0824838932458052, -0.0795257972276308, -0.076567628344671, + -0.0736092935268037, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.312609495533065, -0.310753273849809, + -0.302105474223365, -0.307675357664469, -0.312415080789672, + -0.313383432183162, -0.31458313974914, -0.313772161939664, + -0.314243737557938, -0.311356378960202, -0.287236728010867, + -0.257916244203487, -0.232073964752527, -0.210863891170218, + -0.196921377901664, -0.18596890106524, -0.17564028200206, + -0.165960625369825, -0.158585930568399, -0.154826583283073, + -0.15304869287349, -0.152636681725118, -0.153411279542397, + -0.154314811589974, -0.154179938658254, -0.153000475746268, + -0.151012710600728, -0.150053333206156, -0.149840751854531, + -0.147951196564179, -0.143237708192546, -0.132590849653984, + -0.121491502657219, -0.117548049502232, -0.117871883728096, + -0.118655478552467, -0.118169459941521, -0.117721908688041, + -0.11793722213726, -0.118051122933765, -0.116306779551502, + -0.11057248569231, -0.103454293683167, -0.0980683082599619, + -0.0945834427347303, -0.0905179222724559, -0.0853141482184438, + -0.0814728224089202, -0.080170082416534, -0.0813316538099759, + -0.0854368589237301, -0.0923227460265882, -0.100519183661533, + -0.108475607562408, -0.11514324921159, -0.11997400125394, + -0.122760390914037, -0.124322742089248, -0.125526859938146, + -0.126948429465933, -0.12943238804334, -0.134173528371312, + -0.139736998986479, -0.144849257242472, -0.148186945531507, + -0.149489663178233, -0.149493061562432, -0.148844735699542, + -0.147850055135395, -0.146625930551366, -0.145960902616273, + -0.146724839772479, -0.148962774496489, -0.152369115822663, + -0.156386071603458, -0.161924896300994, -0.168194748108734, + -0.171850373377815, -0.171429725341563, -0.17010300611174, + -0.172028209787534, -0.17768443081998, -0.184097309721847, + -0.194009348260354, -0.213932606076658, -0.233430227426157, + -0.259821812349109, -0.286677448751651, -0.308524477836594, + -0.323702004803766, -0.33430007449003, -0.339880937639374, + -0.340421212699579, -0.337609821454256, -0.334072861024904, + -0.330970655061817, -0.328637115329627, -0.327496922642559, + -0.326811043419583, -0.324873665285333, -0.32029265014715, + -0.315006620003417, -0.313100032619991, -0.314931669052374, + -0.316180437031708, -0.310891781513086, -0.299498869596307, + -0.287427654656749, -0.275434152239026, -0.260004520363561, + -0.242500932022065, -0.228964583760956, -0.224657668629421, + -0.207083623360171, -0.178833023492093, -0.171119878318386, + -0.16636532535526, -0.162013694923415, -0.155934161723471, + -0.150811767076449, -0.15450683198792, -0.150824517884355, + -0.150480930047563, -0.150837417705435, -0.151128601565359, + -0.14856442778553, -0.14635290498262, -0.141229183844943, + -0.134586302165189, -0.127986450880816, -0.122105769064378, + -0.116395136363474, -0.110684728659709, -0.104973864109607, + -0.0992631336440334, -0.0935519832450278, -0.0878407297660419, + -0.0821293582243173, -0.0764179055266005, -0.0707065959723513, + -0.0714477226779971, -0.0780054341796548, -0.0750476471977539, + -0.0720895624553569, -0.0691314990175006, -0.0661731851573579, + -0.0632150188940772, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.308739215135574, -0.308739215135574, + -0.308739215135574, -0.308739215135574, -0.314736682728453, + -0.308664198802635, -0.311132390317414, -0.312456355765244, + -0.313929603648199, -0.314119212776193, -0.314763299440218, + -0.314951262993442, -0.314014521405637, -0.289062600683517, + -0.259717731903349, -0.231393203340145, -0.209338709951297, + -0.196301222076803, -0.185815523519999, -0.175373201284234, + -0.166424982286816, -0.159866304112323, -0.156540155092444, + -0.155381832883557, -0.155731352575551, -0.156632188287026, + -0.157434729372084, -0.157529241587201, -0.155977638440008, + -0.153389433461333, -0.152012153074331, -0.150675219400779, + -0.146891962114784, -0.141668972389007, -0.13351755990778, + -0.127462354245, -0.127062061597887, -0.128476905199022, + -0.12988632713829, -0.12972482972947, -0.128162449908785, + -0.125537757347687, -0.122981799010617, -0.119937941667052, + -0.113657320567978, -0.105281068466367, -0.0993544410810084, + -0.0967096762867576, -0.0941850471772977, -0.0907353395801963, + -0.0881928171316121, -0.0872341425201368, -0.0879308212263598, + -0.0913912739306201, -0.0977020630169784, -0.105279647679799, + -0.112421531741074, -0.118153854703796, -0.122132519177296, + -0.124593972318467, -0.126181924184883, -0.127151960438717, + -0.127743897984134, -0.12893999943346, -0.13208744043943, + -0.136109485785583, -0.139832553760812, -0.141928708487704, + -0.141999101690962, -0.141505245417874, -0.141008213414244, + -0.140364638969762, -0.139745047859025, -0.140367443788497, + -0.142631341696286, -0.146326997774827, -0.150912900583376, + -0.155815917791064, -0.161067157757759, -0.166116189949947, + -0.169227381616853, -0.169007238683928, -0.167115198490848, + -0.16686063192441, -0.168985508362749, -0.172825220591682, + -0.181300692973794, -0.199967960583333, -0.220796079793353, + -0.246207348507431, -0.271376770174653, -0.290918696038536, + -0.305315563436223, -0.316397359851895, -0.323721215750581, + -0.326590958946886, -0.326832256686025, -0.326475358127895, + -0.325717618458683, -0.324380131959633, -0.323564610768023, + -0.323439591472923, -0.322323136424916, -0.31883626962681, + -0.314950285184333, -0.313798688609925, -0.31520170345005, + -0.314274212224849, -0.305132421798857, -0.289836644133579, + -0.27729414808208, -0.26737884090057, -0.253863895530721, + -0.232617619923275, -0.213951158639065, -0.206157019257813, + -0.187168975550247, -0.174536919995733, -0.17011957737541, + -0.165878742870491, -0.159798776828571, -0.153004029521843, + -0.146209236288129, -0.139693885967182, -0.137185501849699, + -0.141164462737963, -0.143559535543141, -0.145286440419056, + -0.142023832657671, -0.135381489339985, -0.128738795258694, + -0.122096130121198, -0.115893491235763, -0.110183223317552, + -0.10447253490616, -0.098761855857713, -0.0930513048417222, + -0.0873402801828759, -0.0816289977859546, -0.0759177830355155, + -0.070206325943122, -0.0642785751566064, -0.0680526955713435, + -0.0705689273397801, -0.0676112244741047, -0.0646530552535075, + -0.06169498481506, -0.0587368285500663, -0.0557785606014628, + -0.0528203033826046, + -0.308810896179525, -0.308807349668983, -0.308803779790775, + -0.308800314135667, -0.308796874437885, -0.308793383900116, + -0.308790041314301, -0.308786650283348, -0.318553942034258, + -0.31120667373561, -0.31674993155712, -0.314579645251037, + -0.314654405932265, -0.314946137124334, -0.315062077445103, + -0.313935211220277, -0.305119623185957, -0.282749100291481, + -0.257049738915759, -0.230163716508294, -0.208903110420462, + -0.196284004910188, -0.187311048993416, -0.177664725005065, + -0.169197420421779, -0.162337570514344, -0.159319242778128, + -0.158473433528311, -0.159211772796359, -0.160247289566092, + -0.161125499413404, -0.161967304224036, -0.161596632462656, + -0.159485101859458, -0.157184373917854, -0.153441116919695, + -0.148905598472323, -0.142278276082603, -0.133142215988023, + -0.129464649702763, -0.13017119465595, -0.131652272843166, + -0.133673123235828, -0.133909880750253, -0.131810188421963, + -0.127976343644939, -0.12491739042685, -0.122749918970299, + -0.118467740878062, -0.111802669309715, -0.105658696942295, + -0.101937315159098, -0.0990829072520351, -0.096098493436882, + -0.0939910718178207, -0.0933532275034959, -0.0943338608401809, + -0.0976985836556051, -0.103249878422309, -0.109674020703387, + -0.11570136698151, -0.120710472483142, -0.124370327997887, + -0.127317842510596, -0.12979325699475, -0.131222995214517, + -0.131530621337165, -0.131661613731332, -0.132759499545039, + -0.134448244656634, -0.136516541588323, -0.137627128875811, + -0.136778513617607, -0.135581017679109, -0.13511769420624, + -0.134823004705973, -0.134472666743658, -0.135863627307274, + -0.139302208631351, -0.144470964797647, -0.150476326476942, + -0.156469509667157, -0.161845013161157, -0.166344761439868, + -0.169346977142457, -0.170325883453487, -0.16857453243248, + -0.166450136109305, -0.166234083455409, -0.167804845640525, + -0.173652829827293, -0.190240992224388, -0.208359156908533, + -0.231164392938494, -0.254654419703961, -0.272674504654007, + -0.285613488759279, -0.29587318447327, -0.304053136346344, + -0.309759069253861, -0.314420698765636, -0.318302422438878, + -0.320558257871404, -0.320736786132077, -0.320605114363858, + -0.320886177944028, -0.320386450182791, -0.317876317855689, + -0.315328283375596, -0.31516605874803, -0.315841665050398, + -0.312336189038774, -0.297704447171677, -0.275544098490689, + -0.257134402552651, -0.245094549816069, -0.232889978461862, + -0.215559336729118, -0.198053074693285, -0.188253017687967, + -0.178842181629051, -0.173591567880528, -0.169743714439904, + -0.163663535977943, -0.156868707104349, -0.150081513516123, + -0.142771936424014, -0.13392650329196, -0.13012351675068, + -0.132218193675078, -0.133935461763591, -0.135103696315323, + -0.129533696894447, -0.122891084920204, -0.116248807133451, + -0.10972947750911, -0.103970825886009, -0.0982603981294808, + -0.0925497466786248, -0.0868392955608062, -0.0811283195889438, + -0.0754173261221475, -0.0697058544942176, -0.0639945275684653, + -0.056656907452314, -0.0650380771726429, -0.0631323509023563, + -0.0601745839508848, -0.057216474307963, -0.0542586382833999, + -0.0513004427743878, -0.0483421713281447, -0.0453839027920492, + -0.0424254939654961, + -0.324754592734363, -0.324746073902957, -0.324737487468217, + -0.324728776521188, -0.324720283794195, -0.324711895933377, + -0.324703528086257, -0.324695218597358, -0.321433818129758, + -0.329665806544104, -0.339736448011745, -0.339402872016109, + -0.326676856460874, -0.318796176409544, -0.316003634929782, + -0.313078852670553, -0.301623307607052, -0.277913589227015, + -0.251577785052595, -0.227362146103703, -0.2074958261479, + -0.195463329696875, -0.189262813084561, -0.182075643784335, + -0.173707413724473, -0.166887209819591, -0.162684388578318, + -0.161635221731995, -0.162530780325484, -0.163739286984638, + -0.164697517540809, -0.165831510966031, -0.166950629739265, + -0.166875825169387, -0.164195221450694, -0.157790327986756, + -0.149980627750624, -0.140061070072435, -0.131517548808834, + -0.12924635908873, -0.12898033900874, -0.129581817575017, + -0.131406400016115, -0.131419341232164, -0.129122098068618, + -0.12623722320257, -0.125640158206779, -0.126222482644541, + -0.124379158160388, -0.120211735284858, -0.115111948204389, + -0.110788710568418, -0.106954488832348, -0.103191449353762, + -0.100205018828357, -0.0989226876837024, -0.0999224414306116, + -0.103146824485487, -0.107769613256709, -0.112763797932951, + -0.117730891072657, -0.122516160083729, -0.126922613044591, + -0.13125856559529, -0.134351715971361, -0.135615355706497, + -0.13554995312761, -0.134814287274115, -0.134328584648715, + -0.133951162141841, -0.13483254015192, -0.135947001850436, + -0.135022708525682, -0.133157272415536, -0.132362496004552, + -0.132105301724327, -0.131293943624677, -0.132288455449747, + -0.136508084050883, -0.143390015399213, -0.150998245403439, + -0.158166546008401, -0.164163700377197, -0.168689807527966, + -0.172298047991414, -0.175200482662944, -0.175103641660651, + -0.171904177126745, -0.169624269476366, -0.16907857233687, + -0.171298241394558, -0.179950006127756, -0.19398665593504, + -0.214156342775468, -0.236279146565171, -0.253996241751586, + -0.265953012430519, -0.274962306662412, -0.283008333754444, + -0.291801919744599, -0.301010262569178, -0.308860611668855, + -0.314125678635762, -0.316445093640194, -0.317343184514861, + -0.31782301692985, -0.317218158943496, -0.314994252466735, + -0.313385396080268, -0.314018277516805, -0.313925288167216, + -0.306407755111574, -0.284027292930048, -0.255387043461435, + -0.23158245040015, -0.21673466797267, -0.205729924496779, + -0.195169702692798, -0.184219560175759, -0.177387196512853, + -0.172960277266271, -0.173234196417989, -0.167651589582397, + -0.160516686222744, -0.152493902876961, -0.143612183565674, + -0.134504666906165, -0.125546580233272, -0.121317477000069, + -0.122584163126586, -0.124301526716342, -0.123686098287184, + -0.117043521718887, -0.110400679154213, -0.103769432952492, + -0.0977586711613389, -0.0920483250247395, -0.086337569991682, + -0.0806268180732056, -0.0749161032645792, -0.0692052233221284, + -0.0634938740871188, -0.0577825439378976, -0.0519926257751273, + -0.0584424749192382, -0.0556955922360954, -0.0527379390014105, + -0.0497798410290047, -0.0468218221022081, -0.0438639096394442, + -0.0409056294713435, -0.0379473842961596, -0.0349889773617095, + -0.0320305920543758, + -0.329656528595268, -0.32965792239895, -0.329659275559544, + -0.329660647491369, -0.329662006643586, -0.329663345140702, + -0.329664662743174, -0.329665961864518, -0.325767844097634, + -0.333286751657851, -0.341401415044914, -0.348761811726476, + -0.347507709376705, -0.338686113057432, -0.330547766137763, + -0.31940058413856, -0.3034806729875, -0.278177274578163, + -0.249249564594421, -0.224534644279491, -0.205919613239612, + -0.19414369167603, -0.188933083307442, -0.184512094349091, + -0.177019116813609, -0.170264029275445, -0.166342107477711, + -0.165106805411298, -0.16563325321156, -0.166999876305956, + -0.16804611875251, -0.168971019758576, -0.171016446144248, + -0.173304113875099, -0.170757195051556, -0.162888871424216, + -0.151224971316002, -0.140098212030311, -0.13593097279397, + -0.13308204633746, -0.128532673540806, -0.126656347202054, + -0.127151711364892, -0.126664027150709, -0.124833955518558, + -0.12396805474566, -0.125575603730734, -0.128161597361619, + -0.12853227683225, -0.126420326058452, -0.123498184651631, + -0.12072005430171, -0.117681326627064, -0.114001709282818, + -0.109223980469896, -0.105607285500028, -0.105358374852222, + -0.108072635964924, -0.112000076856419, -0.116058955538969, + -0.120169094831941, -0.125087852930223, -0.131042215168786, + -0.136298702817214, -0.138222182790023, -0.138290549330038, + -0.137631642599577, -0.136139149640329, -0.134886509070749, + -0.133973770319793, -0.134778696344221, -0.135447621933232, + -0.134100087033529, -0.133485383451396, -0.134237861090614, + -0.134531350404285, -0.131893247108859, -0.130464437845423, + -0.133810587779356, -0.14177486439218, -0.150658806828236, + -0.157916181876445, -0.164051151124284, -0.169640947453958, + -0.174631167278307, -0.179348564715532, -0.18273313598658, + -0.181746440984364, -0.179292440598263, -0.177344430705862, + -0.175485405700034, -0.175774530278926, -0.183484192192026, + -0.199931453372892, -0.219475367853481, -0.235470667194954, + -0.246473755976205, -0.254761227737333, -0.262889459800505, + -0.274117224761793, -0.286178364549216, -0.297169201782154, + -0.305442244661589, -0.309926004557947, -0.311986281266183, + -0.312609269650642, -0.311202257766854, -0.308177784692184, + -0.305836971621801, -0.306003954762426, -0.304471572887253, + -0.290279289862002, -0.262760494337872, -0.232689219527344, + -0.208720946784003, -0.193428399448318, -0.184475087001092, + -0.180053988932338, -0.174718310648525, -0.171772578752309, + -0.172450620146407, -0.170622925527741, -0.162349991538891, + -0.153297449425359, -0.144190131664094, -0.135082446053185, + -0.125974387825243, -0.117886100237597, -0.111272656131697, + -0.112950163641455, -0.114667226832227, -0.111195667869244, + -0.104552842210048, -0.0979101598607829, -0.09154640789511, + -0.0858356929068971, -0.0801250822144949, -0.0744143620635612, + -0.068703827533447, -0.0629930963647471, -0.0572818201145797, + -0.0515179534483578, -0.0459028793136787, -0.0512165726256653, + -0.0482588158777666, -0.0453011378867391, -0.0423431355734923, + -0.0393850355801939, -0.0364270835727643, -0.0334688959968912, + -0.030510807279517, -0.0275522421190096, -0.0249878943040254, + -0.0317016170324822, + -0.327304769236452, -0.327305349010186, -0.327305913633328, + -0.327306468026401, -0.327307032505873, -0.327307587315194, + -0.327308136705081, -0.327308675151781, -0.32884320307344, + -0.329841836576187, -0.338448791274786, -0.346289033601828, + -0.350088571548973, -0.346463690134876, -0.340389017448206, + -0.32798515134979, -0.307280875957765, -0.278357002651596, + -0.249107425549676, -0.224500542388985, -0.206396692741614, + -0.194581724765657, -0.188930165257434, -0.185138018585696, + -0.179422525449309, -0.173497892998602, -0.170040508373814, + -0.16855283407122, -0.168703461221631, -0.169957115545003, + -0.171196322333743, -0.172318150539079, -0.175802285846679, + -0.18048438681712, -0.179484368109836, -0.175319938241186, + -0.167269585409536, -0.156836966603549, -0.148802304333439, + -0.14036622935605, -0.131394420099377, -0.127133478118104, + -0.126037788164478, -0.124386222812129, -0.122607005678002, + -0.122912010327142, -0.124930993723896, -0.128087748261671, + -0.130278985621305, -0.130640837472425, -0.130833555949616, + -0.131341322098785, -0.131473343342334, -0.128960973998248, + -0.122289915953489, -0.116049744473808, -0.114179165987067, + -0.11578531710357, -0.118837665912193, -0.121859471278651, + -0.124243168618921, -0.128329719793672, -0.134903201499971, + -0.13957820514914, -0.140419081451175, -0.139887379482127, + -0.138473854981715, -0.136177569581806, -0.13418068146155, + -0.133053706549036, -0.133613139519846, -0.132826152054029, + -0.131033621158862, -0.131790827542414, -0.131895048409187, + -0.131159469849149, -0.133401243109801, -0.131665884635486, + -0.13285659135096, -0.139181965788122, -0.14742325354977, + -0.154405820577927, -0.160735494311753, -0.167859696416408, + -0.174821467333775, -0.181483644902648, -0.187713328504674, + -0.190715994301232, -0.190463903785957, -0.188277270298957, + -0.184840438293189, -0.181080435459033, -0.182729546344951, + -0.193014184230515, -0.207003486535108, -0.219572018296045, + -0.228864663241709, -0.236433332283653, -0.244628687776878, + -0.256540391571896, -0.268719684414474, -0.281506237050545, + -0.29298120364346, -0.299425758648056, -0.302746847910038, + -0.303136385328523, -0.300199662704284, -0.295419243343304, + -0.291007056886969, -0.288084083625769, -0.281445970744005, + -0.263597658200741, -0.237551581262347, -0.212660135725245, + -0.194660524820916, -0.182496952420316, -0.17638041483471, + -0.174715767850393, -0.173158477424254, -0.172011691096284, + -0.17035159203673, -0.162982092990641, -0.15387511694965, + -0.144767736844858, -0.135660130909048, -0.126552205749736, + -0.117444399080854, -0.110375432495837, -0.101501709600294, + -0.103315847325815, -0.104849255487442, -0.0987046854680302, + -0.0920623078726542, -0.0854701953644093, -0.0796233852342605, + -0.0739123797566663, -0.0682016862842043, -0.0624911471420138, + -0.0567804272148876, -0.0510695729870743, -0.0450277770847254, + -0.0433173528158672, -0.0437794703731276, -0.0408218407778586, + -0.0378641490985829, -0.0349061006808408, -0.0319481213730313, + -0.0289904305747307, -0.0260321336675429, -0.0230739019015557, + -0.0209796917748636, -0.0279168280737629, -0.0397092594114887, + -0.0515670007347444, + -0.326935160208835, -0.32693510102147, -0.326935041986032, + -0.326934984897772, -0.326934928099938, -0.326934870936364, + -0.326934815017054, -0.326934759219621, -0.327712124070507, + -0.328819449756061, -0.336394869541395, -0.339814958725347, + -0.340540769464232, -0.339888110748845, -0.335339688569277, + -0.323854305410078, -0.303849228421927, -0.27623718005936, + -0.248941969592766, -0.225425784522011, -0.208539712762713, + -0.197706736976188, -0.192018154996141, -0.187992364402417, + -0.183431550883003, -0.178544151582123, -0.175892246484847, + -0.174694029278358, -0.174429844317403, -0.175093706906969, + -0.176191996226011, -0.177309226609498, -0.18123973035037, + -0.184434577164649, -0.184492764820276, -0.183802022593525, + -0.180183835674446, -0.172893404510318, -0.161488824511212, + -0.149364651335019, -0.13885862570922, -0.133367334453794, + -0.130952442833088, -0.127605385690029, -0.12528531132416, + -0.125618651786102, -0.126880102248829, -0.129653474178951, + -0.132680122000585, -0.134951072583191, -0.13735021698244, + -0.140343691429713, -0.14258608240512, -0.140861539843418, + -0.134063892248264, -0.127667658575716, -0.125296660588099, + -0.124840334600381, -0.125906403883439, -0.127305552094026, + -0.127590795377704, -0.129383921473172, -0.134041858603233, + -0.137391922387088, -0.13841616574297, -0.138377314588402, + -0.13726985128103, -0.135242005674102, -0.132741759877203, + -0.130039726012842, -0.128295557858341, -0.126396136423993, + -0.125988073365778, -0.122998437428149, -0.121685968507697, + -0.123903625195194, -0.132399464191015, -0.135553072032783, + -0.137020690057433, -0.1415139648575, -0.148576358355761, + -0.154115422086378, -0.159198431959353, -0.16685224349798, + -0.175372395365943, -0.183193291589926, -0.19044002120983, + -0.196070108094168, -0.198975375378405, -0.198249848681261, + -0.194559121229828, -0.189131009924882, -0.186999800671717, + -0.191621295116462, -0.19968966600536, -0.207856106476129, + -0.215022108695867, -0.221704365460185, -0.228800674056628, + -0.239366603168886, -0.250674914016889, -0.263695209453066, + -0.275908447722674, -0.283466717480619, -0.288466685562882, + -0.288959559994738, -0.284796443673395, -0.278085181319403, + -0.2708362424477, -0.264094045460446, -0.253882086790586, + -0.237060030153376, -0.21682404913621, -0.199309734922286, + -0.186628828186681, -0.179063730661671, -0.175063584168934, + -0.173493472937666, -0.172747813750378, -0.168959970876007, + -0.165530162675806, -0.154476683813367, -0.145345055404605, + -0.136237631109739, -0.12712990000548, -0.118022186847305, + -0.108914204311993, -0.101303520630952, -0.0919410411765438, + -0.0936814021357086, -0.0928198927906196, -0.0862141589306616, + -0.0795723087435645, -0.0734101469643874, -0.0676999794483504, + -0.061989203207837, -0.0562785155762043, -0.0505677506747362, + -0.0448568275622829, -0.037728324764559, -0.0381800017041707, + -0.0363423489238949, -0.0333847546189773, -0.0304271700244474, + -0.0274690896207498, -0.024511158664476, -0.0215532442736487, + -0.018595148889405, -0.0168250134438395, -0.0240028634120892, + -0.0358597694767101, -0.0477173186426651, -0.0595748712592408, + -0.0715531441610417, + -0.326969772577286, -0.326969772577286, -0.326969772577286, + -0.326969772577286, -0.326969772577286, -0.326969772577286, + -0.326969772577286, -0.326969772577286, -0.329646743977309, + -0.329478049543362, -0.333756459792207, -0.332769754605626, + -0.330967751501484, -0.330167975285737, -0.325574539264521, + -0.313608680088517, -0.295219569101027, -0.271967407391544, + -0.248938254860172, -0.228582021098623, -0.213232508583865, + -0.203890490283328, -0.198662457753299, -0.194821649959281, + -0.190799269094252, -0.186585307379083, -0.184103602000406, + -0.182852218620951, -0.181966024568944, -0.181198881564381, + -0.180190623211391, -0.180743902479655, -0.18323184481563, + -0.183953382920842, -0.186996046917358, -0.190790656695916, + -0.189364877421308, -0.183989257144666, -0.173224055359285, + -0.16033451922454, -0.150030666864823, -0.14424057037301, + -0.140950387992153, -0.137509277008523, -0.134202231501162, + -0.132458971370028, -0.131855988877413, -0.133558175949061, + -0.136413668035861, -0.139384615990953, -0.142828548667839, + -0.146679463335409, -0.149105591464106, -0.147606551685866, + -0.142284180314727, -0.137193149896467, -0.134026408080233, + -0.13173883579365, -0.130843910017458, -0.130987119535705, + -0.130364017459563, -0.130176474709946, -0.132031764733244, + -0.133830373569801, -0.134691758554402, -0.134842577529268, + -0.134572457606712, -0.133673442219321, -0.131709303066817, + -0.128407279474869, -0.124689558948988, -0.121881740509674, + -0.121015731120892, -0.122005816197444, -0.124160764804711, + -0.129388261310792, -0.138341152478099, -0.143832361002451, + -0.147135375927287, -0.151179582931181, -0.156206560395033, + -0.158831546708751, -0.160841007111994, -0.167985656115791, + -0.176786363881124, -0.184377143692037, -0.191367375141323, + -0.198173686381475, -0.203012388917628, -0.203686143901884, + -0.20041745079293, -0.196163247657997, -0.191999538933045, + -0.192277897476015, -0.195279551916993, -0.199442121555175, + -0.204113433401872, -0.209245112000702, -0.214723242236913, + -0.223298764941813, -0.233701776121468, -0.245441083090055, + -0.255823522999714, -0.263840164381916, -0.27003407802964, + -0.27149859213148, -0.267823951181648, -0.260330995233602, + -0.250796473104879, -0.241830536368933, -0.231469883940977, + -0.217606312315264, -0.203677699797458, -0.191374353575566, + -0.182576912185215, -0.177375065898632, -0.173609488210762, + -0.172231105969863, -0.168123925754318, -0.164121498116514, + -0.160343689313848, -0.146231432625476, -0.136815083975286, + -0.127707302327647, -0.118599785396434, -0.109491899051817, + -0.100383833296175, -0.0885452406639357, -0.0823295359087458, + -0.0840468389509391, -0.080365600757648, -0.0737229724704688, + -0.0672143979057125, -0.0614866089348419, -0.0557761998736206, + -0.0500658295233946, -0.0443549519492248, -0.0386437831024669, + -0.0300555544312676, -0.0318624087524559, -0.0289049805911096, + -0.0259473804290863, -0.0229899276133604, -0.0200319516815001, + -0.0170741761405871, -0.014116217265746, -0.0114028818635144, + -0.0202180928329682, -0.0320114628665268, -0.0438682616818299, + -0.0557255923350348, -0.0675832135858844, -0.0745404561873918, + -0.0751177818347767, + -0.326969772577286, -0.326969772577286, -0.326969772577286, + -0.326969772577286, -0.327082939431784, -0.328425535659287, + -0.330450567297282, -0.330449883652266, -0.330449196474341, + -0.330548789375651, -0.330994932115938, -0.327583553367114, + -0.324914571820633, -0.322571569348522, -0.317060848668671, + -0.305062715860819, -0.287927975792817, -0.268476659049673, + -0.250189862953714, -0.23401007555418, -0.221575999564895, + -0.213565915216777, -0.20832267371802, -0.204574829872872, + -0.201147819461471, -0.197558062264739, -0.194442044026739, + -0.191869778887366, -0.189168891837898, -0.186037482503896, + -0.183089069633327, -0.182111233627589, -0.183300136828277, + -0.185138436926839, -0.191213841920424, -0.19396581781613, + -0.19185613052284, -0.189547397414478, -0.181800552553983, + -0.171273166736856, -0.16222025929581, -0.156165011025224, + -0.15267031456535, -0.150001770789705, -0.145907852996741, + -0.140907616091491, -0.137883264591328, -0.138605028827324, + -0.141140138360563, -0.144157841104774, -0.147661408644419, + -0.151415851285353, -0.15355189723723, -0.152478950117424, + -0.148795198902258, -0.144821141575196, -0.141077640352137, + -0.137600156947949, -0.135473390969353, -0.13490686087302, + -0.133808574763675, -0.13195177315087, -0.130831312974512, + -0.130216860755591, -0.130107612441457, -0.130513272127772, + -0.131602354387387, -0.132258736199874, -0.131657263439493, + -0.129916668803405, -0.127914449244432, -0.12628295910442, + -0.126387877849675, -0.129303487895449, -0.134659315061885, + -0.141747959488518, -0.150368904747494, -0.156443170086925, + -0.159906925408488, -0.162984776588617, -0.166583868698665, + -0.167393403973875, -0.166098724492359, -0.171352850118361, + -0.179802255548246, -0.186142630552789, -0.191489422458952, + -0.19820569381648, -0.204235467784828, -0.205401840066185, + -0.20231293283643, -0.198368908794478, -0.194758960455388, + -0.193318972418872, -0.193387124127473, -0.194090909721058, + -0.19585402257122, -0.19907775285602, -0.203005724244701, + -0.209426645479722, -0.216985163611476, -0.22574271949453, + -0.234119615873839, -0.241968297983427, -0.248579140466903, + -0.251439039799944, -0.24914615804235, -0.241545918676737, + -0.231220818317949, -0.222747077739929, -0.214870020245652, + -0.205809358271119, -0.195960443291156, -0.186901226341851, + -0.180147160066189, -0.174873405423217, -0.171135013073247, + -0.167300098085162, -0.163248620474803, -0.159311643766691, + -0.154564485530002, -0.138684559074528, -0.128284751759305, + -0.119177164808711, -0.110069208633338, -0.100961454059742, + -0.0927657251740854, -0.0763183278762672, -0.0726950135755909, + -0.0736946569192057, -0.0678739831401822, -0.0612448545664385, + -0.0552732328710569, -0.0495631634313453, -0.043852713497698, + -0.0381418931046485, -0.0324308894795056, -0.0220533887130863, + -0.0244247942261031, -0.0214677036927666, -0.0185099565843208, + -0.0155524803872565, -0.0125946869052371, -0.0096367077160461, + -0.0085613118718015, -0.0163071606012271, -0.0281633409039376, + -0.0400204413859902, -0.0518770086232647, -0.0637342734867922, + -0.0749766677618027, -0.0749766677618027, -0.0749766677618027, + -0.0749766677618027, + -0.331902404616355, -0.331895407461687, -0.332070476959168, + -0.332083122254514, -0.332082202943756, -0.332081287462377, + -0.332080361433412, -0.332079462182634, -0.33207856601962, + -0.332265496518756, -0.329129361818873, -0.324617506014986, + -0.321242124711223, -0.317718589293391, -0.311333254769353, + -0.300299724862311, -0.285329895079476, -0.270024030087649, + -0.25596140026439, -0.243158908477286, -0.232870291302056, + -0.225433268529585, -0.220705557637029, -0.217334335308663, + -0.21438362953402, -0.210416982336414, -0.206204671871038, + -0.20203035467423, -0.197076131075637, -0.191157294528993, + -0.185806843921602, -0.183080643210122, -0.182822754381916, + -0.185004944144951, -0.192771449522113, -0.192341480954459, + -0.189976227145653, -0.188555263075347, -0.186485783514308, + -0.179342559376325, -0.171942659952054, -0.166426649043336, + -0.163563326526283, -0.161356159284373, -0.156667455061486, + -0.149826365596376, -0.145050367906397, -0.145072985672538, + -0.147220078490321, -0.149945368556705, -0.153114737028182, + -0.156311231922203, -0.158184702204446, -0.157958367844978, + -0.155995387810402, -0.152733270904387, -0.148613958252268, + -0.143949759738894, -0.140682924058332, -0.139431095715843, + -0.137256098375042, -0.133859293766494, -0.130459169087753, + -0.127551120485782, -0.125910767553928, -0.126272590934985, + -0.128613196683245, -0.130895835959057, -0.132008453165775, + -0.131937995522667, -0.132553058366983, -0.133265382126765, + -0.134702033817328, -0.138477652014186, -0.144656639206694, + -0.153754851419544, -0.165068910511213, -0.171500522746368, + -0.173167927445312, -0.1730660741088, -0.172898818976237, + -0.173981195702427, -0.174022321675744, -0.177229368369908, + -0.18425702608753, -0.188797226744257, -0.191695020082881, + -0.19687499363547, -0.202829298674593, -0.204088640475153, + -0.201264038359949, -0.197922182866456, -0.194990901561999, + -0.193199759013431, -0.192633089897521, -0.192283458588651, + -0.192200025047624, -0.193270713809656, -0.195370121296954, + -0.198859558940539, -0.202397548972991, -0.206844901549749, + -0.212811624999376, -0.21998668984652, -0.226637047825112, + -0.231153833663694, -0.229881889773838, -0.222947402504008, + -0.21442982380693, -0.208381452529453, -0.203274125739665, + -0.197222732037142, -0.189387902457182, -0.181827514750448, + -0.177280278563477, -0.172729045824426, -0.168318378609989, + -0.163142365181879, -0.158438828379975, -0.154501875064144, + -0.147845698391901, -0.131343449884258, -0.11975403295543, + -0.110646477226076, -0.101538591877602, -0.0924303405867275, + -0.0839323630106868, -0.0643393204179675, -0.0630602565198644, + -0.0620253556870547, -0.0553824586301409, -0.0490631861526452, + -0.0433496423865956, -0.0376392094264487, -0.0319284819810553, + -0.026217861088761, -0.0180644902698769, -0.0169871992194749, + -0.0140298557238927, -0.0110724436201745, -0.00811458064360449, + -0.00515714925661703, -0.00273206632765083, -0.0124607851727704, + -0.0243167076978006, -0.0361729817531882, -0.0480298736386652, + -0.0598864954918198, -0.0741200569561785, -0.0749766677618027, + -0.0749766677618027, -0.0749766677618027, -0.0749766677618027, + -0.0749766677618027, + -0.335391360073487, -0.33538856196191, -0.33538574469046, + -0.335382945662533, -0.335380200290157, -0.335377569238699, + -0.335374877559303, -0.335372185218009, -0.335369620206369, + -0.335501310757418, -0.328592647097351, -0.324047244726667, + -0.321497434800289, -0.317288707201152, -0.310456001601584, + -0.301291211822146, -0.290269641895129, -0.278670750763877, + -0.267475229185233, -0.256650713844992, -0.247854315825018, + -0.241364477206235, -0.236865986786544, -0.233379691688452, + -0.229989141296428, -0.225289849858481, -0.219558014813261, + -0.213154891940812, -0.205161393059747, -0.196150356090918, + -0.188979753996628, -0.184730354732828, -0.18247322638905, + -0.183103100173538, -0.190444569763718, -0.189949095189487, + -0.188243502305473, -0.187196804541574, -0.186582844880306, + -0.183045510874811, -0.178533795154025, -0.174917543881779, + -0.173289635496327, -0.171422239713926, -0.166894917937592, + -0.159975130002199, -0.154806031618227, -0.153914692573004, + -0.155104378194082, -0.157014284943103, -0.159251953156702, + -0.161667093192684, -0.163659507827469, -0.164548851975769, + -0.16357129714375, -0.160479350057398, -0.155868002327791, + -0.150780820406641, -0.147018184863897, -0.14451312139484, + -0.141095286834741, -0.137169440737042, -0.13340097676454, + -0.129389874139494, -0.126171503239408, -0.125459273428556, + -0.127469081377979, -0.129883329013505, -0.13179115059979, + -0.133451301848608, -0.136574701997853, -0.14069229183459, + -0.145012708492097, -0.149921166090884, -0.155676944071239, + -0.164290765458494, -0.177246520692673, -0.185570776550214, + -0.185753857808839, -0.181868199078459, -0.176600799342431, + -0.175220010462461, -0.181765309287007, -0.185947198982503, + -0.188979976704334, -0.191036444135588, -0.192050726485778, + -0.195847611070904, -0.200379345280698, -0.200436785419145, + -0.197878934673964, -0.194542479949808, -0.192256268937747, + -0.191104317603537, -0.191117088714765, -0.190754590020522, + -0.190511567080843, -0.190526265900499, -0.189938182042586, + -0.189406402319433, -0.188716199485726, -0.190026418231866, + -0.194721042387016, -0.201074933526566, -0.206495796744427, + -0.211079218507413, -0.211749608812504, -0.206981598127657, + -0.201883637926989, -0.199722842466181, -0.196372952539697, + -0.19052654949414, -0.183261552447757, -0.176824638847877, + -0.17472061619008, -0.172003596562005, -0.166586336741942, + -0.161463873242096, -0.153629002929315, -0.149691850997292, + -0.141126172863321, -0.124611708613695, -0.111683355592139, + -0.102115521793753, -0.093007842023652, -0.0838997347322817, + -0.0732334142943478, -0.0522966667288743, -0.0534250871820007, + -0.0495336034717479, -0.0429328147442918, -0.0371361506490809, + -0.0314256458539924, -0.0257152139025853, -0.018254180323398, + -0.0117901953462721, -0.00954950851276156, -0.0065920694957677, + -0.00363448870881438, -0.000677098213620706, -0.000197791739157309, + -0.00861499955549351, -0.0204706988190237, -0.032326720728724, + -0.0441827333193796, -0.0560392783268924, -0.0694008453743415, + -0.0750215649604797, -0.0750215649604798, -0.0749766677618027, + -0.0749766677618027, -0.0749766677618027, -0.0749766677618027, + -0.0749766677618027, + -0.343609966667119, -0.343609765051091, -0.343609567665423, + -0.343609366666981, -0.343609168304166, -0.343608970397583, + -0.343608776501627, -0.343608581809729, -0.343608392148238, + -0.343608207067072, -0.329184930851702, -0.325493551452614, + -0.325047124194971, -0.321974169658853, -0.316274959828866, + -0.3096450928545, -0.301051893617276, -0.29119679610705, + -0.282134984256863, -0.273325728032241, -0.266818513715358, + -0.26085588929353, -0.255455200324395, -0.251848049934188, + -0.247721420049282, -0.241861460394605, -0.234233623921748, + -0.225162425744451, -0.213862504766647, -0.203013145834658, + -0.194741388345996, -0.188522958478853, -0.183849430595791, + -0.181916823980291, -0.186360216359685, -0.188037679237397, + -0.186794133899335, -0.185199217376757, -0.183515708207759, + -0.184181972473613, -0.183590828397038, -0.182582283900352, + -0.182489851691752, -0.181448452706623, -0.178477291562793, + -0.173392484129821, -0.168194415441811, -0.165504171377764, + -0.165022272640999, -0.165469392181754, -0.165916268111289, + -0.167212880343288, -0.169381002934614, -0.171003440840888, + -0.170461039102719, -0.167368522309895, -0.16239069679088, + -0.157345607855469, -0.153659111520181, -0.150771626513645, + -0.147040493398832, -0.143354086942009, -0.139945491120077, + -0.135836183414806, -0.131658382560465, -0.129460608755044, + -0.129884874904637, -0.131141842513538, -0.13318261929762, + -0.135909593240474, -0.140458616199827, -0.147283387544018, + -0.155747437055392, -0.16319153761352, -0.170044042906034, + -0.176054525507064, -0.182148905298159, -0.189856420601374, + -0.192752137697426, -0.189448962728545, -0.186146179640661, + -0.186281290277473, -0.192201500301021, -0.195626454524784, + -0.194060228069119, -0.192473707584984, -0.192279051714606, + -0.195823756541408, -0.19777177317601, -0.193857747541897, + -0.188616236042274, -0.188309258226387, -0.186751732878044, + -0.18607661782696, -0.185859695364566, -0.186257714433533, + -0.186291719305609, -0.184969001357102, -0.180938905332983, + -0.177241812198255, -0.174963098040979, -0.175197212641805, + -0.179376293693676, -0.185237661128147, -0.189695884962519, + -0.193084578996135, -0.193681256309867, -0.192096395445186, + -0.191054416757697, -0.191561182370749, -0.189469380709803, + -0.18392229704446, -0.175615920933121, -0.167491327630441, + -0.164655051962623, -0.164973672211614, -0.164845397117719, + -0.158730204230513, -0.148858617891215, -0.144881890366435, + -0.13440656030241, -0.117891882344773, -0.103925929955968, + -0.0935848903694801, -0.0844767936244813, -0.0754193659792382, + -0.0605906811108897, -0.041968710675413, -0.0431831804651626, + -0.0370423560109904, -0.0309226161999147, -0.0252119398603131, + -0.0195014487148542, -0.0083305199059763, -0.00506849763573178, + -0.00211155039629571, 0.000845932846675719, 0.0038032398277167, + 0.0052949713662222, -0.00477024347153548, -0.0166256470234562, + -0.0284813087416111, -0.0403366915367858, -0.0521928200634083, + -0.0642040181002698, -0.0750215649604797, -0.0750215649604797, + -0.0750215649604797, -0.0750215649604797, -0.0749766677618027, + -0.0749766677618027, -0.0749766677618027, -0.0749766677618027, + -0.0749766677618027, + -0.343383192149067, -0.343382817238684, -0.343382431815386, + -0.343382055023677, -0.343381684331969, -0.343381313107881, + -0.34338094836995, -0.343380587446038, -0.34338022053186, + -0.34337986417303, -0.333772477372529, -0.33192672696956, + -0.332614635411272, -0.331790214399415, -0.328267529002098, + -0.321833916829884, -0.313548687424671, -0.304979294993209, + -0.297706392612814, -0.290909633190063, -0.286050317470984, + -0.280982689315898, -0.27520497787478, -0.271688618892933, + -0.266780854290429, -0.259750793786659, -0.250470214628516, + -0.239051301756571, -0.226192139486394, -0.214617614917002, + -0.204891212454193, -0.196722017362394, -0.189975078525889, + -0.185885866258161, -0.184434989568799, -0.184260700437207, + -0.182972088552064, -0.181796847834868, -0.183062158667007, + -0.185655934859382, -0.187997577784204, -0.189817279653423, + -0.192156352882809, -0.192323164031967, -0.191054865896689, + -0.188060688314634, -0.183410227397559, -0.179021833030756, + -0.176687286962, -0.174743668871968, -0.17208347373366, + -0.172484592314329, -0.175119236317175, -0.177298936888331, + -0.177351365050489, -0.174454633165554, -0.169603037175344, + -0.164934154900652, -0.161763387580454, -0.159053826917177, + -0.155732385939453, -0.151794959177764, -0.147647492162674, + -0.143391427469588, -0.139296816127489, -0.137190654416711, + -0.137151540050876, -0.137495462992903, -0.139153700352953, + -0.141446558515872, -0.144833853470104, -0.152087693764003, + -0.163915172510063, -0.175198606526876, -0.183391681828846, + -0.188910743215884, -0.194544140614295, -0.198737608551879, + -0.198099205907595, -0.195978067537691, -0.194837269317592, + -0.195957596767755, -0.199087854575365, -0.199944031716871, + -0.196999209735124, -0.193016031926225, -0.190982398276093, + -0.193775691327493, -0.193453427296878, -0.187666417893139, + -0.178627521450913, -0.178403656408073, -0.178958335981025, + -0.179290792626083, -0.179527283026993, -0.17930145925177, + -0.178796537796827, -0.175496124014388, -0.168188401652472, + -0.164073039722511, -0.162571545004334, -0.162398838953469, + -0.165788851958647, -0.171087833937891, -0.175456997495139, + -0.17819523629814, -0.178390640274764, -0.17893879061934, + -0.180958755754076, -0.182560407471694, -0.180792173347456, + -0.174150755631997, -0.162765532186393, -0.154130554821913, + -0.15003180762818, -0.153947127888898, -0.158481163739313, + -0.153821826147735, -0.146898491506692, -0.140071711960767, + -0.127687280522349, -0.111172228169911, -0.0962340210907749, + -0.0850832173703722, -0.0759457976005246, -0.0667586942330242, + -0.0478298146772603, -0.0324374428572472, -0.0311676706034478, + -0.0247355738353911, -0.0189980140571685, -0.0132874895600063, + -0.00157313790280846, 0.00236958814390178, 0.00532689700656306, + 0.00828416076580389, 0.00826502843573982, -0.000926162149674963, + -0.0127814450768536, -0.0246365405945793, -0.036492088818624, + -0.0483474281155334, -0.0602034676160006, -0.0727195110624907, + -0.0750215649604797, -0.0750215649604797, -0.0750215649604797, + -0.0750215649604797, -0.0750215649604798, -0.0749766677618027, + -0.0749766677618027, -0.0749766677618027, -0.0749766677618027, + -0.0749766677618027, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.341779713277631, -0.341197534897598, + -0.341425332684992, -0.341214891563988, -0.339210512851752, + -0.3328394765743, -0.325370126771068, -0.318441382629478, + -0.312126701641269, -0.306852097256062, -0.303350900919349, + -0.300041465163733, -0.295465893511483, -0.291160686917224, + -0.285788660135607, -0.27801216092946, -0.267706983750538, + -0.255826352417468, -0.243307349412326, -0.231529754176179, + -0.220878095767296, -0.2117715501219, -0.20390569670584, + -0.199655102589651, -0.196126047706094, -0.189147879732116, + -0.182118973259458, -0.178695258217899, -0.183257131217521, + -0.188579345022272, -0.19230240634772, -0.196553399328412, + -0.202044921953684, -0.204050019973751, -0.20406247874815, + -0.202543786269578, -0.199034615652668, -0.193626179248605, + -0.188884504638854, -0.182431572662646, -0.177771610856511, + -0.178481929155262, -0.181276023899357, -0.183695977906749, + -0.184709240504128, -0.18300043869344, -0.178906425648062, + -0.174823479116437, -0.171362443120133, -0.168223557278384, + -0.165111823653017, -0.160762639696, -0.15624527514705, + -0.152547917296202, -0.148907504247646, -0.147357582946306, + -0.147644012321594, -0.148166732609797, -0.14939820374883, + -0.15003563818439, -0.15037812542204, -0.15544363997984, + -0.167756689242762, -0.181568255840204, -0.190118702397415, + -0.194465254220353, -0.197379813098107, -0.200045658823214, + -0.199757691152195, -0.198228165963978, -0.196815259802966, + -0.197296543037508, -0.198995272066417, -0.19859531141364, + -0.195902004490596, -0.192142178584135, -0.190806172291014, + -0.193144521299192, -0.190499774495264, -0.183366245343082, + -0.176224532424115, -0.169081332056294, -0.165458588684255, + -0.169012466490172, -0.170552491864966, -0.171610946573696, + -0.170654844219319, -0.16340747176092, -0.153561983903626, + -0.15126024883048, -0.151587878301547, -0.15181694519359, + -0.154674831244026, -0.159144081280966, -0.16285926037657, + -0.164943904171389, -0.165706065404781, -0.167676955421881, + -0.170696835515432, -0.171452657531772, -0.168506530881741, + -0.160570599143945, -0.149786917283537, -0.140806356491536, + -0.136543064429209, -0.140258331910433, -0.149328779780832, + -0.143332245884787, -0.138296737971277, -0.135550597647782, + -0.120967678575926, -0.104452212995718, -0.0886309043657615, + -0.0770839761487378, -0.0674142279323117, -0.0581525293563595, + -0.0350698000288444, -0.0227654492642131, -0.018706864587674, + -0.0127836892210932, -0.00688260769991675, 0.00762124180076603, + 0.00980805313195416, 0.0127652568731989, 0.013181409931659, + 0.00291615762006586, -0.0089384169279117, -0.0207925828940837, + -0.0326479675820008, -0.0445031475967108, -0.05635842386646, + -0.0697936391972079, -0.139428183436394, -0.0750215649604797, + -0.0750215649604797, -0.0750215649604797, -0.0750215649604797, + -0.0750215649604797, -0.0750215649604798, -0.0749766677618027, + -0.0749766677618027, -0.0749766677618027, -0.0749766677618027, + -0.0749766677618027, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.341712940599034, -0.341779417326761, -0.342354883379194, + -0.342786928594399, -0.34268273624323, -0.342788872434503, + -0.340706052987631, -0.334626870600401, -0.329696649735773, + -0.325282314696114, -0.321929052673147, -0.319299023684164, + -0.316680714571762, -0.313845763156366, -0.309374346230533, + -0.303575121219906, -0.296220803945553, -0.286823431059648, + -0.276161949380022, -0.264089041502876, -0.253366189839945, + -0.244480884105588, -0.236853993772288, -0.228069662066145, + -0.222161930100977, -0.221792855400444, -0.214919088226235, + -0.200473792228951, -0.189122316823291, -0.193095031839743, + -0.198204262659751, -0.200704500809226, -0.205611290135274, + -0.212881307090057, -0.216621469907632, -0.217753471601947, + -0.217297083225623, -0.214077658677823, -0.207715783731957, + -0.199734502915812, -0.190140955958797, -0.185286691769554, + -0.185784513457693, -0.188275541321379, -0.190997671581421, + -0.193106815339701, -0.192719175199258, -0.189455293007482, + -0.185523564825621, -0.181406442109431, -0.177491423181744, + -0.174241343821747, -0.170577827025038, -0.166779651504897, + -0.163599937992324, -0.160724458618273, -0.159452592519447, + -0.160316232392604, -0.161789780543404, -0.162795955567669, + -0.161091354170905, -0.157351120108928, -0.158128964225907, + -0.168340041298521, -0.180844581171111, -0.190072577569274, + -0.194491376202061, -0.1952164181496, -0.195409829745795, + -0.193767386103207, -0.19283134179491, -0.191344611713665, + -0.193533142496636, -0.19553240180974, -0.195138115300484, + -0.1943812578265, -0.191291438443684, -0.191191839367188, + -0.190283977131096, -0.183611982635388, -0.176765751145283, + -0.169919309132019, -0.163068793502705, -0.15629813807746, + -0.155966140804907, -0.161702633752041, -0.164705871799816, + -0.159915315849099, -0.146622722238295, -0.138841294692062, + -0.139472443713446, -0.141551934805818, -0.142752781843715, + -0.144840803868658, -0.148211097317592, -0.151075621662457, + -0.15304792472501, -0.154874008702243, -0.157229196641507, + -0.158356844637393, -0.156250131886009, -0.152177879939858, + -0.144831599726942, -0.135128345221692, -0.127361133850706, + -0.122934353675279, -0.12567609627833, -0.133646096760736, + -0.132489692401519, -0.126494723052961, -0.122699367709614, + -0.113721899829044, -0.0977321554888353, -0.0815409485276768, + -0.0693917192497625, -0.0588826553337872, -0.0453925708675221, + -0.0223090512573759, -0.0125164640060774, -0.0065743282390159, + 0.00115016019646629, 0.0144446235223605, 0.0172468145694829, + 0.0168260596213072, 0.00675829019358973, -0.00509538796737253, + -0.016949947295301, -0.0288043151758391, -0.0406594419419553, + -0.0525143574922316, -0.00512283602142248, 0.011743932031095, + 0.011743932031095, -0.0164496652658529, -0.0750215649604797, + -0.0750215649604797, -0.0750215649604797, -0.0750215649604797, + -0.0750215649604797, -0.0750215649604797, -0.0749766677618027, + -0.0749766677618027, -0.0749766677618027, -0.0749766677618027, + -0.0749766677618027, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.342407137155533, -0.342306559895653, + -0.341662645339966, -0.341779093215132, -0.342674165964127, + -0.342897479602328, -0.342610532883092, -0.342043338336144, + -0.343005880934856, -0.34226763396691, -0.338303738615846, + -0.336397914341873, -0.335133046785268, -0.332937896439205, + -0.331069105472951, -0.329535422908998, -0.325682536644784, + -0.321023568786623, -0.314718758760624, -0.307333304490225, + -0.298659533467702, -0.288202642843517, -0.281135360313208, + -0.276752210708177, -0.270554262242009, -0.259334059613187, + -0.246785733003493, -0.248343515861537, -0.245103634330508, + -0.232459811991973, -0.216118424283413, -0.212556124616248, + -0.213746144613851, -0.215070647956755, -0.220354796574458, + -0.227735993616127, -0.231631183977863, -0.23236332947198, + -0.231418145257182, -0.227109394828884, -0.219479666908807, + -0.209624554139933, -0.198782721554579, -0.193700918194658, + -0.194070367777473, -0.1967973648051, -0.200009623338329, + -0.202106364674148, -0.202250230425858, -0.199889961695829, + -0.19630011896131, -0.192068127630517, -0.187924861968761, + -0.18480064896671, -0.182082219046971, -0.178610097952015, + -0.17525355551201, -0.172987879941073, -0.17192495160226, + -0.172825248073646, -0.174278164291632, -0.174723527429581, + -0.17175504824764, -0.164765870799869, -0.159746390849454, + -0.165757659802171, -0.176609212710375, -0.187381685981811, + -0.192449421012505, -0.192206438155454, -0.188542861238606, + -0.187535685385657, -0.186028323360126, -0.185243698397217, + -0.186124227019691, -0.185843324994195, -0.185347827472984, + -0.184739138154153, -0.180931275708986, -0.179777436279974, + -0.179266814087759, -0.173279110348617, -0.166516052420013, + -0.159752944744038, -0.152989857237768, -0.149741727386003, + -0.146977473742746, -0.153209205753411, -0.156979133637344, + -0.146259774992695, -0.133343072909656, -0.131349270939468, + -0.135771393270454, -0.135002057250832, -0.13554644879984, + -0.136131458985572, -0.138184897177415, -0.140649209016423, + -0.143364255826777, -0.146555695893629, -0.148248801650872, + -0.14446229993673, -0.136779079916506, -0.131736699166114, + -0.127435639536527, -0.117732311763142, -0.109405864045616, + -0.104262609426555, -0.106262199090955, -0.116099863421558, + -0.12367333608188, -0.123385579602325, -0.118704850944682, + -0.110035686910652, -0.0901281087728331, -0.0738265007436432, + -0.0625782038221937, -0.0505264058510796, -0.0326316697695232, + -0.00954823154380819, -0.000437242041033898, 0.00934842211776039, + 0.0217285023237758, 0.0213789089649423, 0.0105999319448443, + -0.00125387508898689, -0.0131081135037307, -0.0249620284112041, + -0.0368169211120925, -0.0486710898298971, -0.0366464906333634, + 0.011743932031095, 0.011743932031095, 0.011743932031095, + 0.011743932031095, 0.011743932031095, -0.00877860743543032, + -0.0750215649604797, -0.0750215649604797, -0.0750215649604797, + -0.0750215649604797, -0.0750215649604797, -0.0749766677618027, + -0.0749766677618027, -0.0749766677618027, -0.0749766677618027, + -0.0749766677618027, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.342407137155533, -0.34168735968369, + -0.341662645339966, -0.341778776601796, -0.342674165964127, + -0.342897021821079, -0.342439979314804, -0.34308867222651, + -0.34310320019722, -0.343402402801642, -0.342962193101389, + -0.342800886683149, -0.343816989341566, -0.343381052326402, + -0.343356542880879, -0.342242105182792, -0.339931404954129, + -0.337184969642592, -0.333009595623345, -0.328471037133334, + -0.323776006065321, -0.319305849309073, -0.315550095141335, + -0.311587074317037, -0.306006374364269, -0.29490312430607, + -0.281317115823975, -0.278482552997795, -0.274787370231335, + -0.263587352328733, -0.246174193944643, -0.235280045696105, + -0.233515561134808, -0.234571922114609, -0.239014833893612, + -0.244788356771842, -0.247586692138548, -0.24708424788517, + -0.244358703584511, -0.239026975459126, -0.230405039868298, + -0.219079011900841, -0.207117799856058, -0.202803287241492, + -0.203928760762985, -0.207073776481695, -0.210444477240818, + -0.2124090315788, -0.21242752352109, -0.210521953363449, + -0.207591727561941, -0.203867754099984, -0.19991083139268, + -0.196495345251615, -0.193404742069223, -0.189977688654505, + -0.186802613256837, -0.18450601147922, -0.18296861914203, + -0.18268209257421, -0.183236821842637, -0.183375764290764, + -0.179298720864629, -0.169136497537642, -0.159999645233834, + -0.160708389400242, -0.170695964096402, -0.182834542413444, + -0.190133111945956, -0.189774515766509, -0.181865995124847, + -0.178649460018487, -0.176205642832988, -0.175588169076176, + -0.176272456718358, -0.175390088099739, -0.174979581138447, + -0.174301423952552, -0.170902393330014, -0.168362437621586, + -0.167626651931178, -0.162848382625879, -0.156085358183431, + -0.149322336727866, -0.145569017459671, -0.145320429781121, + -0.14476378847882, -0.146710138944946, -0.152231615308322, + -0.137355823058302, -0.128763088636561, -0.129711089132376, + -0.135684263223211, -0.133153582292992, -0.130835354810494, + -0.12920275802051, -0.130077727760929, -0.132374039955715, + -0.136058666472885, -0.140607501603704, -0.138996728294839, + -0.12961232082786, -0.11898172562369, -0.113313966752447, + -0.110127824454826, -0.0998582511280836, -0.0884067784817923, + -0.0810853297527424, -0.0832397600664027, -0.0999436807023284, + -0.108793099266787, -0.120983377575494, -0.123878071592165, + -0.120185421477554, -0.0998717702015729, -0.080483542037433, + -0.0592201666006943, -0.0273668374109438, -0.011272321155236, + 0.00321281704507495, 0.0212371932050949, 0.0253963881324352, + 0.014440352468829, 0.00258633236779202, -0.0092669334487808, + -0.0211206276466648, -0.0329751345011075, -0.0448296368232538, + -0.056683587744384, 0.0071553409225465, 0.011743932031095, + 0.011743932031095, 0.011743932031095, 0.011743932031095, + 0.011743932031095, 0.011743932031095, 0.011743932031095, + 0.00414889728419717, -0.0750215649604797, -0.0750215649604797, + -0.0750215649604797, -0.0750215649604797, -0.0749766677618027, + -0.0749766677618027, -0.0749766677618027, -0.0749766677618027, + -0.0749766677618027, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.342407137155533, -0.341662645339966, + -0.341662645339966, -0.342169132447515, -0.342674165964127, + -0.342896552068364, -0.34310320019722, -0.34310320019722, + -0.34316667801437, -0.343224056782027, -0.343030645768861, + -0.342889150123599, -0.342110757495561, -0.340250917926614, + -0.342067816279624, -0.343884568120198, -0.345689853489084, + -0.346284551716388, -0.346970302480385, -0.347649310491496, + -0.347575002156322, -0.348088164504227, -0.345210008625066, + -0.339415757476913, -0.334993463300751, -0.328494630439766, + -0.320318405531632, -0.312002825277295, -0.303274613979804, + -0.291263470828249, -0.275472475135435, -0.262960237204299, + -0.258401330917951, -0.257886759713624, -0.259071721322091, + -0.260805220775971, -0.26097789488898, -0.259499057516225, + -0.256370656905796, -0.250917983019956, -0.241768986206096, + -0.228742465264902, -0.216073985381653, -0.212428355979408, + -0.214291187862406, -0.218130326779974, -0.22178160789394, + -0.223741347281978, -0.223440378151107, -0.221632559660627, + -0.219119572124783, -0.215786024381736, -0.211917144331807, + -0.20786557357396, -0.203520205437944, -0.200068822810771, + -0.197412433907307, -0.194720322945126, -0.192009995540762, + -0.190498261053789, -0.189951758231912, -0.188419615881669, + -0.183644184963564, -0.173792602118637, -0.158906400708839, + -0.154203190665828, -0.163280111365025, -0.17717644042263, + -0.187410778504057, -0.180727384020674, -0.171949200231288, + -0.168844017847121, -0.16638247035914, -0.166076527531047, + -0.166801129800662, -0.164936570413184, -0.164611028592309, + -0.163863390628015, -0.16079812413302, -0.157088351007406, + -0.155804844336409, -0.152417851788505, -0.145654895749042, + -0.141358437615511, -0.141166510126631, -0.141013806058471, + -0.142581205696724, -0.1455859548839, -0.148653353252653, + -0.132801970329985, -0.126397723490189, -0.128694534728066, + -0.134233883618145, -0.13477831392782, -0.128791921908463, + -0.125157489451254, -0.124299596782803, -0.126054741877439, + -0.130049028774881, -0.133887180230931, -0.127165497393378, + -0.114789037258636, -0.106106063788344, -0.100952405118912, + -0.096359853820363, -0.0869376092447482, -0.0685950802899862, + -0.0572112036878718, -0.0582503150901816, -0.0803038192387365, + -0.10475741674315, -0.118609897425764, -0.124590840395958, + -0.122910572213821, -0.103906571142311, -0.0783013807537891, + -0.0454787832063926, -0.0125348594102519, 0.0104230647902415, + 0.0281509460575138, 0.0182799056982288, 0.00642595875488612, + -0.00542681974187436, -0.0172801051073685, -0.0291339314758213, + -0.0409875615183267, -0.0528422509111599, -0.00587333065169456, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, -0.0493273980635511, -0.0750215649604797, + -0.0750215649604797, -0.0750215649604797, -0.0749766677618027, + -0.0749766677618027, -0.0749766677618027, -0.0749766677618027, + -0.0749766677618027, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.341810030892815, -0.341662645339966, + -0.341662645339966, -0.342674165964127, -0.342674165964127, + -0.342963644326159, -0.34310320019722, -0.34310320019722, + -0.343216627836227, -0.343216627836227, -0.343031125309546, + -0.342888566796915, -0.343980304038207, -0.345050573348999, + -0.345324088731728, -0.335601198125801, -0.336704027158193, + -0.338520862176508, -0.340386713232586, -0.342462619587732, + -0.344548196509752, -0.346702923536184, -0.348905249785189, + -0.351208342788606, -0.352174078292447, -0.350187901940006, + -0.348328146931839, -0.339536678060442, -0.329719475054516, + -0.319810592618336, -0.310962923272989, -0.297735049585887, + -0.288752653506822, -0.282919113137248, -0.278116059865711, + -0.27507018082241, -0.272196911920581, -0.269057993749693, + -0.266222920596211, -0.262412170311722, -0.255175693006014, + -0.241250460744245, -0.22668617013137, -0.222140870253094, + -0.224332328128318, -0.229052665795414, -0.233210472336795, + -0.235182674201586, -0.234683375543894, -0.232776907410535, + -0.230140464092092, -0.226656035041017, -0.22241366024959, + -0.217732912278703, -0.212724574289416, -0.209453251263257, + -0.206855711081098, -0.203430351432499, -0.199820807450421, + -0.197248396766003, -0.195049331806163, -0.192498654227886, + -0.189006602825724, -0.182084847376195, -0.161830749484082, + -0.150217274819514, -0.154634835475998, -0.167684839582014, + -0.175753031581122, -0.170100362499247, -0.162032166308469, + -0.158518349893754, -0.156598609950908, -0.156566394479889, + -0.156705692081307, -0.154793540974877, -0.154242134870524, + -0.153425038470677, -0.15067221210643, -0.146471104823886, + -0.144050672699051, -0.141987084726327, -0.137178826572107, + -0.137012325260813, -0.136859756556894, -0.136707072344622, + -0.137851019982139, -0.144199187172038, -0.140204750564511, + -0.128970430279853, -0.123925259154926, -0.123156537024375, + -0.126938751667079, -0.131967101466263, -0.128370687305442, + -0.123090530847489, -0.11998523897193, -0.120357854049755, + -0.123012954607905, -0.123887725239589, -0.113658296106441, + -0.104418783325407, -0.096162371969389, -0.0833129521616228, + -0.0785500633872638, -0.0734334209166522, -0.0542947786887608, + -0.0341521744176054, -0.0306566930667739, -0.0505236490460904, + -0.0928869206711941, -0.118170376878308, -0.120775694982294, + -0.116941793975276, -0.0993028971283595, -0.0663464036015604, + -0.0424662640722772, 0.0191054249348856, 0.0221184704941255, + 0.0102653457247038, -0.0015876422885403, -0.013440469175897, + -0.0252939566607391, -0.0371477625399293, -0.0490014027138993, + -0.0492093566708082, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, -0.0701057339089503, + -0.0750215649604797, -0.0750215649604797, -0.0749766677618027, + -0.0749766677618027, -0.0749766677618027, -0.0749766677618027, + -0.0749766677618027, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342304172490206, -0.341662645339966, -0.341662645339966, + -0.341662645339966, -0.342674165964127, -0.342694049550003, + -0.34310320019722, -0.34310320019722, -0.34316168030704, + -0.343216627836227, -0.343216627836227, -0.343031602354384, + -0.342887967792776, -0.34397997036722, -0.345050573348999, + -0.345323670547127, -0.346790820360184, -0.341598908346322, + -0.329523578241832, -0.331340303848179, -0.333156644069144, + -0.33505884205403, -0.337137049855366, -0.33923947131532, + -0.341424419638593, -0.343671298087767, -0.346038408363977, + -0.348416897453167, -0.350274533706779, -0.350289010721449, + -0.345357754161352, -0.343044987967771, -0.331858721151817, + -0.317872389630749, -0.305300496024988, -0.29554343856136, + -0.288222491808053, -0.282124597585991, -0.277313391927677, + -0.274776791008547, -0.273247908299292, -0.269769849131286, + -0.257940314293707, -0.238709317699646, -0.231240371030418, + -0.233476656175916, -0.239057509307662, -0.24385213815747, + -0.246074929869485, -0.245516401912566, -0.243259951525492, + -0.240125375148527, -0.23603001508263, -0.231147237498596, + -0.226188834298528, -0.221758289467799, -0.218970444345477, + -0.216130350444908, -0.211800167286126, -0.207345783308012, + -0.203784847830953, -0.201188719009968, -0.198802840299791, + -0.194323117430115, -0.186418911496704, -0.166968938429419, + -0.150021732863, -0.149098662785681, -0.154438065193371, + -0.159228545440901, -0.157124303207881, -0.15173002556826, + -0.147896650294547, -0.147052269602121, -0.147056533308726, + -0.14707880761758, -0.145262555703396, -0.143873002525845, + -0.142986719411838, -0.14071986346514, -0.137385381887757, + -0.132409121579636, -0.131081323494869, -0.13342322714316, + -0.133675420718697, -0.133793182567922, -0.1341382952271, + -0.133967380941734, -0.135533761021014, -0.128394389270105, + -0.121649337244104, -0.119820352064028, -0.118536727336019, + -0.119740988663456, -0.123141690068944, -0.122669842434588, + -0.118743373564548, -0.115959016720254, -0.114699807670763, + -0.11671235075166, -0.115081355895466, -0.105987418942606, + -0.0972894694478246, -0.0840263545227434, -0.0674285484332897, + -0.0579611415472176, -0.0572533250829982, -0.0475097035622253, + -0.015714191348878, -0.0118436909024988, -0.0413710481959187, + -0.0902039683748206, -0.116513533116638, -0.115975410532593, + -0.113842898077542, -0.0701338958140632, 0.000771296443010182, + 0.0235552965931197, 0.0141030029541479, 0.00225101028790552, + -0.00960198027582067, -0.0214550002663965, -0.0333081312851456, + -0.0451617462629267, -0.0570151290246246, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0293055380399147, + -0.0750215649604797, -0.0750215649604797, -0.0749766677618027, + -0.0749766677618027, -0.0749766677618027, -0.0749766677618027, + -0.0749766677618027, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.341662645339966, -0.341662645339966, -0.341662645339966, + -0.341662645339966, -0.342674165964127, -0.34310320019722, + -0.34310320019722, -0.343108723765481, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.34303210243884, + -0.342887384857372, -0.344612481065366, -0.345050573348999, + -0.34642540399377, -0.346790820360184, -0.347426116200429, + -0.346630598988569, -0.350382447242737, -0.330272388413415, + -0.325975968776078, -0.327792210871209, -0.329735616910637, + -0.331811097063434, -0.333947219828722, -0.336149246621906, + -0.338489860922879, -0.340868440815345, -0.343246775464716, + -0.345264565425199, -0.345676389636297, -0.344394209476511, + -0.335059489086679, -0.32312264572089, -0.311334001623799, + -0.30127341473109, -0.292890449169947, -0.286527725271259, + -0.283846650469205, -0.283564310023126, -0.281752883525965, + -0.272855327381929, -0.251075420061704, -0.23928159553737, + -0.241835623193615, -0.248328221400185, -0.253695274696191, + -0.256322558032368, -0.255854121356788, -0.253150980157121, + -0.249262963196731, -0.244532649316352, -0.239380878386629, + -0.234318010329407, -0.230097541206939, -0.228385644541617, + -0.225040624980322, -0.21960606455274, -0.214492200529493, + -0.210868262280699, -0.208544519671651, -0.204981880374087, + -0.198147211505879, -0.187756518357645, -0.168123264358384, + -0.151458397127477, -0.147808515205568, -0.149091806808866, + -0.149325040452472, -0.149637846213108, -0.144344885641928, + -0.141422314560487, -0.140755436724399, -0.140774825214477, + -0.140470962528706, -0.138154604237469, -0.136657802336956, + -0.13568957846605, -0.132917715510064, -0.127301471131454, + -0.121227030615381, -0.117737109996119, -0.125219977966287, + -0.129411509516899, -0.128262901943219, -0.128777567174992, + -0.130323035647006, -0.129142993233837, -0.12240870352824, + -0.114121364614519, -0.114299230872608, -0.114024290190463, + -0.11389005974619, -0.114350952831457, -0.109289041703575, + -0.106572775343792, -0.10937398196366, -0.111941094031973, + -0.112007667875977, -0.108514879240439, -0.10299887343098, + -0.0889807732529129, -0.0594673557189004, -0.0439689900267932, + -0.0383223917910213, -0.0243562280055639, -0.00137836983473669, + 0.00112893182225032, 0.000211836432965484, -0.041913365619705, + -0.090583801349725, -0.113224934483251, -0.0878713384060591, + -0.0161238748478533, 0.0223642141923841, 0.0169364605671634, + 0.00608839562972858, -0.00576403877930983, -0.017616682090804, + -0.0294694232173591, -0.0413227787841526, -0.0531754386895096, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, -0.0750215649604797, -0.0749766677618027, + -0.0749766677618027, -0.0749766677618027, -0.0749766677618027, + -0.0749766677618027, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.341662645339966, -0.341662645339966, -0.341662645339966, + -0.341662645339966, -0.342674165964127, -0.34310320019722, + -0.34310320019722, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343032602531859, + -0.342886779684146, -0.344610869259381, -0.345050573348999, + -0.346423150492174, -0.346790820360184, -0.34742527566501, + -0.346630857857899, -0.350382447242737, -0.350382447242737, + -0.349921646317652, -0.32195117576539, -0.320611227385588, + -0.322436779842134, -0.324399882795876, -0.326492876005136, + -0.328665339940724, -0.330941143603435, -0.333319641419287, + -0.33569800560622, -0.337581383679232, -0.337942393333976, + -0.336566440897192, -0.331220980197159, -0.323913748607757, + -0.314574202709643, -0.306134910343876, -0.297845346520163, + -0.294282794795481, -0.29357818444645, -0.291282559518808, + -0.281988796760387, -0.260148687616529, -0.246923176739842, + -0.250044722438926, -0.257015909301161, -0.262614960726374, + -0.265454942966633, -0.265106268615788, -0.261854765615054, + -0.257120277610697, -0.2518970476744, -0.246811432752034, + -0.241879133842301, -0.238353017018345, -0.23643406366273, + -0.232189568074175, -0.226209636886814, -0.220941381202574, + -0.217138014796675, -0.213718702044103, -0.207899726659866, + -0.199286644544385, -0.185869576464667, -0.167889346455497, + -0.154178602201605, -0.14891020028085, -0.148275688250594, + -0.147440364156928, -0.144715582560292, -0.141873419790291, + -0.140083205855463, -0.139220390306975, -0.137939287591101, + -0.135354719257886, -0.131857894169533, -0.128464516228644, + -0.126610246902782, -0.123721384453802, -0.121053457028092, + -0.117515846227271, -0.112824220999442, -0.110765497010667, + -0.115319816075212, -0.120043183335989, -0.122943854807449, + -0.123762987777396, -0.120784619176392, -0.116654593543527, + -0.111845348115837, -0.111049568457326, -0.109947973475825, + -0.111445704623784, -0.10783118162, -0.100129240576395, + -0.100298934109385, -0.102806608234514, -0.107198330224976, + -0.10530214986428, -0.10251606004558, -0.0987648127905049, + -0.0847391773706858, -0.0353281247069493, 0.00679664941546369, + 0.00930913722881896, 0.0146569451243437, 0.028385129392409, + 0.0174774455215033, -0.00947344049059397, -0.057804300610973, + -0.0757377141086562, -0.0335568758487274, 0.016331394802565, + 0.0163972152301413, 0.00977545574561359, -0.00192633989976766, + -0.0137793807478842, -0.0256314738146519, -0.0374844715360415, + -0.0493373286740091, 0.0101541021813961, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.00926972048081317, -0.0749766677618027, + -0.0749766677618027, -0.0749766677618027, -0.0749766677618027, + -0.0749766677618027, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.342407137155533, -0.341832359622951, + -0.341662645339966, -0.341662645339966, -0.341662645339966, + -0.342014269218235, -0.34296758441066, -0.34310320019722, + -0.343175607938178, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343033112384885, + -0.342886163209898, -0.345050573348999, -0.345050573348999, + -0.346790820360184, -0.346790820360184, -0.347424402241202, + -0.348566580717424, -0.350382447242737, -0.350382447242737, + -0.351468213240933, -0.352602005004883, -0.352971122215695, + -0.328741111868613, -0.315246657510872, -0.317067115612212, + -0.31907331589533, -0.321192909440607, -0.323414010541166, + -0.32577067808683, -0.328149105768276, -0.329833544834521, + -0.330171028237949, -0.327166274331306, -0.326507912370688, + -0.323921680824432, -0.317142632107476, -0.308839697852375, + -0.304988384887986, -0.302315639121757, -0.297783139346347, + -0.285455936154926, -0.265642393715221, -0.254886418466192, + -0.258357610771858, -0.265076459630664, -0.270432926783483, + -0.272751751463924, -0.271966707504971, -0.268644070698892, + -0.263665237205654, -0.258580600178433, -0.253715537730884, + -0.249058774563599, -0.245474217784023, -0.242389396677008, + -0.237305228455682, -0.231234467588001, -0.225665290470776, + -0.22083700495113, -0.215363798609804, -0.207658175982173, + -0.197674714791699, -0.183521482279648, -0.167951971086441, + -0.155630984469292, -0.149869177392134, -0.14908525428189, + -0.148062815238828, -0.14565239636864, -0.142670415837398, + -0.140031594666074, -0.137683336235784, -0.134540239008291, + -0.130489250855168, -0.127407805787409, -0.123765997466332, + -0.121252292850295, -0.119370769780855, -0.116643493713849, + -0.113123841610326, -0.109126653681633, -0.103960883493894, + -0.105064405206508, -0.112186455238849, -0.116975195504236, + -0.114563907115527, -0.112576007931464, -0.10704711706275, + -0.106092786915492, -0.105627954355277, -0.105733834601382, + -0.108014320149792, -0.104237914123847, -0.0962241393716945, + -0.0972723098908282, -0.0981086855776402, -0.0996188437300288, + -0.0984441273541465, -0.0983060963241239, -0.0773731195038894, + -0.0461306287639859, -0.0097800281007887, 0.0469615364967272, + 0.0579738091168495, 0.0462919938100223, 0.0313211494461353, + 0.0195264073320548, -0.0243690682873852, -0.0374704452618745, + 0.010180349052895, 0.0151354055205897, 0.0104255573726956, + 0.0019089903612648, -0.00994307985973538, -0.021795101086184, + -0.0336475540568763, -0.0454998222156359, -0.0271481332750446, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, -0.0236229994363975, + -0.0749766677618027, -0.0749766677618027, -0.0749766677618027, + -0.0749766677618027, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.342367449447077, -0.341662645339966, + -0.341662645339966, -0.341662645339966, -0.341662645339966, + -0.342592659565962, -0.34310320019722, -0.343110119760591, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343033613442937, + -0.342885540506831, -0.345050573348999, -0.345050573348999, + -0.346790820360184, -0.346790820360184, -0.347423538550675, + -0.348561880218846, -0.350382447242737, -0.350382447242737, + -0.352602005004883, -0.352602005004883, -0.352969924771676, + -0.350183810420112, -0.351313903562802, -0.348191315179354, + -0.309881465315413, -0.311715225502516, -0.313748983360167, + -0.315907260566357, -0.318221465104281, -0.320599833137263, + -0.322135962336657, -0.321792779346164, -0.317903943480755, + -0.319725219746783, -0.31835682120093, -0.31406909092498, + -0.312242341856224, -0.307705304026742, -0.30023878118263, + -0.287494372724723, -0.272598589631395, -0.262706560633313, + -0.265295506906538, -0.272104088460602, -0.277143141394707, + -0.278338136517832, -0.276621237047575, -0.273670455853469, + -0.269448100310405, -0.264613475434187, -0.259636439297736, + -0.254686049579344, -0.250515463265727, -0.24622055695975, + -0.240803900657436, -0.234450367213997, -0.228403784880562, + -0.222054675322041, -0.214401638044915, -0.205439321112775, + -0.194432435508629, -0.181231198895897, -0.166121734601117, + -0.155367399368317, -0.151002884781567, -0.150145669925294, + -0.149023143432641, -0.146986649284559, -0.143905022708164, + -0.140280909643706, -0.136418132395341, -0.131726813861283, + -0.128362488288813, -0.123727335086881, -0.119324700480975, + -0.115472733279892, -0.113514382266075, -0.111403997636909, + -0.107970526671325, -0.104129252152216, -0.100121428718099, + -0.0991635937556754, -0.104046046852502, -0.108872731988265, + -0.109803919712584, -0.10498160366204, -0.103425947404432, + -0.100867734450997, -0.101021418484947, -0.102219224108425, + -0.102552702718837, -0.101671651193096, -0.0937876784496634, + -0.0920488255958554, -0.0902293957064195, -0.0938893415012061, + -0.0877992520871533, -0.0626329608572459, -0.0355234252972023, + -0.00825001819360275, 0.0216549998398615, 0.0567461190024402, + 0.0804484024723453, 0.0387599631150697, 0.0301229808364015, + 0.00822602018124871, 0.00338706869517278, 0.0138279759451742, + 0.00916761350927109, 0.00523858661334582, -0.0061074345342851, + -0.0179590640714896, -0.0298109752959125, -0.0416629972356895, + -0.0535160752575801, -0.110009305211424, -0.0991764416529266, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + -0.0123531579775927, -0.0749766677618027, -0.0749766677618027, + -0.0749766677618027, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342407137155533, -0.341662645339966, -0.341662645339966, + -0.341662645339966, -0.341662645339966, -0.341662645339966, + -0.343028221401821, -0.34310320019722, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343034143803273, + -0.343005101017498, -0.345050573348999, -0.345420937112698, + -0.346790820360184, -0.346790820360184, -0.347422642188174, + -0.349469550052863, -0.350382447242737, -0.350382447242737, + -0.352602005004883, -0.352602005004883, -0.352968640282864, + -0.350186047974568, -0.351436287164688, -0.351935982704163, + -0.351935982704163, -0.346766703317681, -0.309697952466774, + -0.306381911822509, -0.30844012690441, -0.310680999219271, + -0.313047555215379, -0.314401650333159, -0.311915483534875, + -0.310756720055042, -0.310850576003525, -0.313061985615494, + -0.3121544317563, -0.308111098838157, -0.299298053411868, + -0.289306441062682, -0.278383535666118, -0.269832010693878, + -0.271704954413221, -0.277846187853951, -0.282469263311514, + -0.282457149023257, -0.28030258224937, -0.277338012313753, + -0.273815182779743, -0.268480658693204, -0.263154171509948, + -0.257776127177334, -0.252998097717072, -0.247267283101274, + -0.241165121997907, -0.234510551289061, -0.227858291041819, + -0.220944800663648, -0.212275639964815, -0.20216313021676, + -0.191497361824186, -0.17913672199032, -0.166903238866822, + -0.156826299293222, -0.152540590364409, -0.150979166503151, + -0.149358625046198, -0.147210921418654, -0.143870903339707, + -0.139428393905101, -0.134228398643378, -0.129654330222023, + -0.12492338820307, -0.119931615097916, -0.115008337087134, + -0.110544872626124, -0.107657895471329, -0.106031201754191, + -0.102817020508921, -0.0990561763115083, -0.0952620421863141, + -0.0951475650588212, -0.0989723194689283, -0.103762509702452, + -0.105526898484094, -0.107057634139021, -0.109109197256967, + -0.102366839406349, -0.0994126070203998, -0.0980248745026005, + -0.0977000420306512, -0.0998263639958489, -0.0910374193426942, + -0.0864762590203256, -0.087006621694654, -0.0751388264954435, + -0.0472349075996048, -0.0206672530835939, 0.00508848721883561, + 0.0305706461218486, 0.0539403679790054, 0.0683440629128006, + 0.0555896305054176, 0.03665593813526, 0.023610453410452, + 0.0126102290631226, 0.00790505666991111, 0.00319957092199553, + -0.00286659387159677, -0.0141237608508337, -0.0259755958895817, + -0.0378274059302892, -0.0496796707801046, -0.0941359415119647, + -0.113003022968769, -0.113003022968769, -0.113003022968769, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, -0.0713258043646534, -0.0749766677618027, + -0.0749766677618027, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.342370328280228, -0.341662645339966, -0.341662645339966, + -0.341662645339966, -0.341662645339966, -0.341709659985848, + -0.34310320019722, -0.343163978569732, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343034672624862, + -0.34300197003289, -0.345050573348999, -0.345524211260913, + -0.346790820360184, -0.346790820360184, -0.347421721455268, + -0.350382447242737, -0.350382447242737, -0.350382447242737, + -0.352602005004883, -0.352602005004883, -0.352967418398435, + -0.350188415298639, -0.351451956501247, -0.351935982704163, + -0.351935982704163, -0.351935982704163, -0.343560218811035, + -0.340129253277409, -0.303814255522512, -0.301015393136232, + -0.303148226801635, -0.305500839155858, -0.306528621076117, + -0.301491453061073, -0.302119523982181, -0.306859832487404, + -0.30647601083326, -0.303099257533636, -0.297371078159311, + -0.289940938547978, -0.282408297858519, -0.277807500858212, + -0.278659642058127, -0.283485765171952, -0.286518403956607, + -0.285249383026685, -0.282447823924357, -0.278864120234402, + -0.274062126608785, -0.268932083682007, -0.26345457540188, + -0.258216378076305, -0.252433886413689, -0.244951422920615, + -0.237862812247867, -0.230425231957757, -0.223447743169811, + -0.216890353327579, -0.208524177607461, -0.197852744515886, + -0.187009499961677, -0.176845672371379, -0.166762419636285, + -0.157401533708116, -0.15334587703754, -0.150768760962904, + -0.148462986096151, -0.145901219932233, -0.141821223746236, + -0.136281934317994, -0.131756500153925, -0.126635223104545, + -0.121631340529359, -0.116472200758698, -0.111294946465823, + -0.106297660364467, -0.101981006323389, -0.100250737198288, + -0.0976634527307241, -0.0939956876562784, -0.0906765631286721, + -0.0912914372457573, -0.0964069246829699, -0.0999804608048184, + -0.101900220985197, -0.101557881645809, -0.104291490751797, + -0.0985903968735066, -0.093145680642712, -0.0934150264391959, + -0.0942057235220413, -0.097107396685593, -0.0902754721257261, + -0.0847937884144358, -0.0755470035610518, -0.0523762180712924, + -0.0292057301190878, -0.00603517936751949, 0.0171355725718973, + 0.0402461565314031, 0.0466480670353016, 0.031208000130175, + 0.0166212143253316, 0.0176833869628765, 0.00664187929547107, + 0.00193677101209835, -0.00277336500356566, -0.0102894470541829, + -0.0221409680255952, -0.0339930605205369, -0.0458441722041886, + -0.0728807651954669, -0.11392417589992, -0.113003022968769, + -0.113003022968769, -0.113003022968769, -0.113003022968769, + -0.0194223211551572, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, -0.0749766677618027, + -0.0749766677618027, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.341788883762503, -0.341662645339966, -0.341662645339966, + -0.341662645339966, -0.341662645339966, -0.342155423134322, + -0.34310320019722, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343035205931468, + -0.344336088609928, -0.345050573348999, -0.346790820360184, + -0.346790820360184, -0.346790820360184, -0.347420815382985, + -0.350382447242737, -0.350382447242737, -0.350382447242737, + -0.352602005004883, -0.352602005004883, -0.35296609392706, + -0.351006783982899, -0.35184438107974, -0.351935982704163, + -0.351935982704163, -0.350813091949166, -0.343560218811035, + -0.33482351899147, -0.33482351899147, -0.303311106101668, + -0.291271862443048, -0.295704044029234, -0.29791674359683, + -0.297015509390522, -0.293747785073508, -0.296526651561817, + -0.299015095938098, -0.298970669426433, -0.298642768474967, + -0.290704283022922, -0.287648086255573, -0.285825336593863, + -0.286137249892364, -0.288624052159547, -0.288740358925297, + -0.286400890126304, -0.282635231791209, -0.277788925117827, + -0.271888555294658, -0.265870496818284, -0.260109019835415, + -0.25414184904902, -0.24700412913447, -0.239516634764724, + -0.231788255829838, -0.222674494880262, -0.215071004915092, + -0.209998257305729, -0.203633003265477, -0.193654781108264, + -0.183374714690946, -0.173313549753849, -0.164150868525179, + -0.156560499799472, -0.152010396028174, -0.148152121721515, + -0.144699132334696, -0.141956475446103, -0.139125087476453, + -0.134368911242846, -0.129190334491975, -0.124011890469653, + -0.118833470744148, -0.113679336066551, -0.108561914131012, + -0.103397227618709, -0.0980309234655306, -0.0944421855707337, + -0.0925096042099985, -0.0896253358913957, -0.0872827452019795, + -0.089704465258092, -0.0954591081151504, -0.0971437100068046, + -0.0982750533422, -0.0978353278372351, -0.0961236756707547, + -0.0934210495023153, -0.0907989518300845, -0.092531146412758, + -0.0913125144333215, -0.0911164582107151, -0.0813956531882282, + -0.0802668236761538, -0.0660108371888094, -0.0428404057599135, + -0.0196695797486227, 0.00350124246219081, 0.0266720551592451, + 0.02226387324808, 0.00682500981716425, 0.00595074398618203, + 0.0105763399191337, 0.000673703775112716, -0.00403168796123588, + -0.00855791430762295, -0.0183073498656989, -0.0301584353303262, + -0.0420097043072216, -0.0100837303768831, 0.016014015302062, + -0.118009857833385, -0.118009857833385, -0.113003022968769, + -0.113003022968769, -0.113003022968769, -0.113003022968769, + -0.113003022968769, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0120339848827263, + -0.0749766677618027, + -0.342407137155533, -0.342407137155533, -0.342407137155533, + -0.341662645339966, -0.341662645339966, -0.341662645339966, + -0.341662645339966, -0.341662645339966, -0.34310320019722, + -0.343209115970572, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343035749668228, + -0.345050573348999, -0.345050573348999, -0.346790820360184, + -0.346790820360184, -0.346790820360184, -0.347419883506386, + -0.350382447242737, -0.350382447242737, -0.351802127062659, + -0.352602005004883, -0.352602005004883, -0.352964840618366, + -0.351475176867102, -0.351935982704163, -0.351935982704163, + -0.351935982704163, -0.348827876691896, -0.33482351899147, + -0.324955312775053, -0.285837143302329, -0.285837552330791, + -0.285837943323283, -0.285838353060955, -0.286469583153057, + -0.290371748221285, -0.286502734620847, -0.291212035424058, + -0.294824594212396, -0.295599916677989, -0.296414333112468, + -0.293237508544209, -0.291078056928962, -0.289537890025018, + -0.289485708402206, -0.290574432753632, -0.289310699306966, + -0.285864760241901, -0.280573152657968, -0.273581357942232, + -0.265723664589084, -0.258314107843824, -0.251806895904299, + -0.245138479149742, -0.23755927557242, -0.229433480739199, + -0.221968615361575, -0.211280834437845, -0.202384891939817, + -0.200416798204479, -0.196067089143205, -0.188473839031118, + -0.179584334823139, -0.170344081673522, -0.161686340446516, + -0.15427739297106, -0.148281538868714, -0.144222624775947, + -0.141790790944227, -0.13699199128703, -0.133837035257476, + -0.13082094362087, -0.127804829302895, -0.122968709001216, + -0.117740698631793, -0.112472182218029, -0.107203785857918, + -0.101935413602438, -0.0966670335935282, -0.0913986755820069, + -0.0909796663554092, -0.0873174722238722, -0.0841163164684959, + -0.0873423952676093, -0.0940184744169406, -0.0938953010803496, + -0.09183951695491, -0.0919797870344777, -0.0917426104722789, + -0.0896797073180419, -0.0879940297228447, -0.091399079517035, + -0.0928167387901469, -0.0850406865078716, -0.0755275182628047, + -0.0742875278281348, -0.0564746885190673, -0.0333040515645636, + -0.0101332280826755, 0.00873805131782363, -0.00211909093104088, + -0.00863040202997205, -0.000917997210183118, 0.00367546539158059, + -0.00529525437821123, -0.0100002756221689, -0.0144740342784204, + -0.0263253973364553, -0.0381761915392417, -0.0380682706228558, + 0.016014015302062, 0.016014015302062, 0.016014015302062, + 0.016014015302062, -0.113774302322792, -0.113003022968769, + -0.113003022968769, -0.113003022968769, -0.113003022968769, + -0.113003022968769, 0.0126799366578286, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0241590864792064, + -0.342407137155533, -0.342407137155533, -0.341736156710114, + -0.341662645339966, -0.341662645339966, -0.341662645339966, + -0.341662645339966, -0.341662645339966, -0.343141627465636, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343036286236681, + -0.345050573348999, -0.345050573348999, -0.346790820360184, + -0.346790820360184, -0.346790820360184, -0.347418954611631, + -0.350382447242737, -0.350382447242737, -0.351799183332663, + -0.352602005004883, -0.352602005004883, -0.352963511440767, + -0.35190704398923, -0.351935982704163, -0.351935982704163, + -0.351935982704163, -0.328351800575784, -0.287925472994363, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285937370160345, -0.288777180123225, + -0.289341046125637, -0.29078906317327, -0.291685055747116, + -0.292707189769161, -0.292477333646684, -0.292677187121157, + -0.290359905931069, -0.289789621722432, -0.288056605775505, + -0.283709010370867, -0.276951360405076, -0.270805201254714, + -0.264290191743468, -0.258792082445204, -0.25005552907938, + -0.241208516234666, -0.232496736384289, -0.222030335858888, + -0.211349643648681, -0.201423692562448, -0.19157126568896, + -0.186479091965157, -0.183831491337277, -0.180310827876088, + -0.174407413948761, -0.166470523959654, -0.157283894969891, + -0.147561569754135, -0.143634803756727, -0.138719732388491, + -0.133697553383843, -0.130639892884654, -0.127623764244939, + -0.124607700468657, -0.121591596940654, -0.11857544477185, + -0.115554466011217, -0.111759134029552, -0.106622997385702, + -0.10135452278629, -0.0960860713157471, -0.0908176685515661, + -0.0858831150569499, -0.0844592624850213, -0.0805683491468811, + -0.0829958172515347, -0.0890472638198443, -0.091006550570582, + -0.0896541904191893, -0.0881467048794656, -0.0885682150053951, + -0.0880493287052914, -0.086227130978968, -0.087162346108896, + -0.0858741473219894, -0.0787424144967534, -0.0707399368033962, + -0.0682914564489124, -0.0469382008909903, -0.0237672251722623, + -0.0121875586486895, -0.0210771181076433, -0.0153132314537061, + -0.00786254873294339, -0.00240599751540805, -0.0112642517529032, + -0.0158004144227211, -0.0227151639081271, -0.0343434125669753, + -0.0461940868857962, 0.0107236195868698, 0.016014015302062, + 0.016014015302062, 0.016014015302062, 0.016014015302062, + 0.016014015302062, 0.016014015302062, -0.115285969066696, + -0.113003022968769, -0.113003022968769, -0.113003022968769, + -0.113003022968769, -0.0783672486327568, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, + -0.342407137155533, -0.342310983835824, -0.341662645339966, + -0.341662645339966, -0.341662645339966, -0.341662645339966, + -0.341662645339966, -0.342894560444723, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343036840011965, + -0.345050573348999, -0.345454548165684, -0.346790820360184, + -0.346790820360184, -0.346790820360184, -0.347418016168407, + -0.350382447242737, -0.350382447242737, -0.35179617803071, + -0.352602005004883, -0.352602005004883, -0.352962181983122, + -0.351935982704163, -0.351935982704163, -0.351935982704163, + -0.301196847926159, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285936030794782, -0.28863051533699, + -0.28863051533699, -0.288621081467745, -0.288566932228824, + -0.288604648151009, -0.289421181104553, -0.290191994192529, + -0.289349019066785, -0.287970603195374, -0.285728397809928, + -0.280892576316547, -0.27579371821008, -0.271162413295312, + -0.265545510194056, -0.257099168625815, -0.248507698570439, + -0.238408581626628, -0.227727556997496, -0.217046728275565, + -0.206265414461667, -0.195122654673546, -0.183273207558689, + -0.171102437418783, -0.166472734199402, -0.16309968359978, + -0.162359905895577, -0.155333224305576, -0.144351850341778, + -0.137302310406662, -0.134072852965681, -0.130458367340384, + -0.127442375046386, -0.124426366148004, -0.121410289185367, + -0.118394262400632, -0.115378185135333, -0.112362104699062, + -0.109345940665919, -0.10632971985109, -0.103313415221498, + -0.100076048030697, -0.0955051816030896, -0.0902366772886712, + -0.0849682470838981, -0.0797203654075813, -0.0784175436921537, + -0.0783227165256763, -0.0826500954067013, -0.0845807857600461, + -0.0843916328648755, -0.0838531378382726, -0.0839930503009705, + -0.0822102049775635, -0.0809640066371958, -0.0782024647523903, + -0.0741652003357193, -0.0673641426826698, -0.0633138122449695, + -0.0605142837549928, -0.0378339837642337, -0.0328378898724318, + -0.0298286261883138, -0.022241960206391, -0.014807221944133, + -0.00998404308290495, -0.0172332358054389, -0.0216853063407165, + -0.0305116394697528, -0.0423623339308397, -0.0146645534641684, + 0.0228668488562107, 0.0228668488562107, 0.0162355229436905, + 0.016014015302062, 0.016014015302062, 0.016014015302062, + 0.016014015302062, 0.016014015302062, -0.0182404836393937, + -0.113003022968769, -0.113003022968769, -0.113003022968769, + -0.113003022968769, -0.113003022968769, 0.0233223194176318, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, + -0.342407137155533, -0.34167859718382, -0.341662645339966, + -0.341662645339966, -0.341662645339966, -0.341662645339966, + -0.341662645339966, -0.343215489623064, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.34303741526685, + -0.345050573348999, -0.346150772002477, -0.346790820360184, + -0.346790820360184, -0.346790820360184, -0.35009570985743, + -0.350382447242737, -0.350382447242737, -0.352602005004883, + -0.352602005004883, -0.352602005004883, -0.352368589697416, + -0.351935982704163, -0.351935982704163, -0.290420081019423, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285934657502835, -0.28863051533699, + -0.28863051533699, -0.288801729679108, -0.288978285308104, + -0.289111226797104, -0.289054517850075, -0.285407969016011, + -0.286774148982437, -0.285138963984494, -0.283891635326811, + -0.280363228740722, -0.277956731727189, -0.272579384704396, + -0.264466556850144, -0.254777947587416, -0.24410605720002, + -0.23317781704967, -0.221166609858266, -0.209046307770976, + -0.196875502554017, -0.184704471878522, -0.17253362143068, + -0.160362750511555, -0.148205640688094, -0.139002278458398, + -0.138612260876375, -0.134100624768833, -0.128967095581094, + -0.128737600827761, -0.126148748868334, -0.123533429872985, + -0.120917667195953, -0.118212823654494, -0.115196646584321, + -0.112180611801785, -0.109164561830934, -0.106148336223133, + -0.103132301636001, -0.100116034636561, -0.0970997601078607, + -0.0940834877226181, -0.091067228664529, -0.0880054542875805, + -0.0843872349147584, -0.0791187494156373, -0.0740447160397555, + -0.0728741235939622, -0.0757287969225443, -0.0782867935679564, + -0.0794444695648663, -0.0790258372344434, -0.0774351029945313, + -0.0755533617561422, -0.0733763453697776, -0.0696372465596056, + -0.0663867629818382, -0.0598981737319633, -0.0578441593501525, + -0.0510185965793766, -0.0443109467396212, -0.0366284062128298, + -0.0291867420694087, -0.0217519223697556, -0.0159236156276116, + -0.0232028147991834, -0.0272648904824917, -0.0385313835913655, + -0.042132138154762, 0.0210472352023515, 0.0228668488562107, + 0.0228668488562107, 0.0228668488562107, 0.0228668488562107, + 0.016014015302062, 0.016014015302062, 0.016014015302062, + 0.016014015302062, 0.016014015302062, 0.016014015302062, + 0.00217568341741046, -0.113003022968769, -0.113003022968769, + -0.113003022968769, -0.113003022968769, 0.00460567429044999, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, + -0.342407137155533, -0.341662645339966, -0.341662645339966, + -0.341662645339966, -0.341662645339966, -0.341662645339966, + -0.342625928032335, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343037981155206, + -0.345050573348999, -0.346476300652127, -0.346790820360184, + -0.346790820360184, -0.346790820360184, -0.350090472564912, + -0.350382447242737, -0.350382447242737, -0.352602005004883, + -0.352602005004883, -0.352602005004883, -0.352154293122558, + -0.351935982704163, -0.302561573071846, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285933269284122, -0.28863051533699, + -0.288714167172895, -0.288958826070883, -0.289111226797104, + -0.289111226797104, -0.289323300123215, -0.288198232650757, + -0.286675818481233, -0.28344401717186, -0.281906057238449, + -0.279660368545169, -0.277779430631472, -0.271355616950559, + -0.261035456925895, -0.249968934892231, -0.238899549023682, + -0.22800944840776, -0.217274477827899, -0.206624319252405, + -0.196209682144414, -0.185794246914271, -0.175377296266349, + -0.16495951456136, -0.154540208816587, -0.144120126916358, + -0.133785184413273, -0.127423728334596, -0.122367257553074, + -0.117996505221848, -0.116289930909922, -0.113090639259435, + -0.110019735891777, -0.107448712891013, -0.10504197797094, + -0.102625108486065, -0.100218370953457, -0.0977258282761762, + -0.0951853871312247, -0.0926136531763405, -0.0900313725179321, + -0.0872692535734842, -0.084451010138799, -0.0816354567183, + -0.0788025003904859, -0.0758039337015191, -0.0725088900693755, + -0.0682268789390911, -0.0685125427312643, -0.0698689814626803, + -0.0719064590157864, -0.0723236576558737, -0.070655866153929, + -0.068664559582654, -0.0657051825122593, -0.0631864013056616, + -0.0600241318474838, -0.055963203633089, -0.054396746041657, + -0.0510931634116717, -0.0435663086732062, -0.0361314700384185, + -0.0286966569802189, -0.0233635652068327, -0.029172731352363, + -0.034701041978739, -0.0465514390311533, 0.0238205436617136, + 0.0238205436617136, 0.0238205436617136, 0.0228668488562107, + 0.0228668488562107, 0.0228668488562107, 0.0228668488562107, + 0.017457697765318, 0.016014015302062, 0.016014015302062, + 0.016014015302062, 0.016014015302062, 0.016014015302062, + 0.016014015302062, -0.085074435985994, -0.113003022968769, + -0.113003022968769, -0.113003022968769, -0.113003022968769, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, + -0.341828942037597, -0.341662645339966, -0.341662645339966, + -0.341662645339966, -0.341662645339966, -0.341662645339966, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343130325135389, + -0.345050573348999, -0.346790820360184, -0.346790820360184, + -0.346790820360184, -0.346790820360184, -0.350085220018355, + -0.350382447242737, -0.350392462177792, -0.352602005004883, + -0.352602005004883, -0.352602005004883, -0.350354425701483, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285931858752382, -0.28863051533699, + -0.288960453057668, -0.289111226797104, -0.289111226797104, + -0.289153657463036, -0.288444350296024, -0.288198232650757, + -0.28344401717186, -0.28344401717186, -0.2807437479496, + -0.279456800771491, -0.277774804376037, -0.277473300695419, + -0.277473300695419, -0.277473300695419, -0.277473300695419, + -0.236921497636624, -0.233445671035404, -0.240139295430919, + -0.235622647688327, -0.226457255843256, -0.215696661868038, + -0.208918116062008, -0.199274032861947, -0.189469486494672, + -0.179666219690499, -0.169860864951035, -0.160057176786013, + -0.150255188845106, -0.140452205569271, -0.13065094976679, + -0.120848291584003, -0.111068787655311, -0.10584273314687, + -0.103056026791055, -0.0985695880667942, -0.0942557229869474, + -0.0898746083151376, -0.0854934332341564, -0.0811126139378002, + -0.0773670749979181, -0.0744314844339033, -0.0714966318853795, + -0.0690703594152521, -0.0666562054800306, -0.0641450577556306, + -0.0616341837206433, -0.0591232514875832, -0.0562810746194525, + -0.0583595707998609, -0.0625352163362732, -0.0643368575050929, + -0.063105441737179, -0.0631791597796254, -0.0600554882280482, + -0.0565571674621145, -0.0543476500235067, -0.052594472734846, + -0.0505021253001796, -0.043076407016816, -0.035643145557768, + -0.0294920579316039, -0.0345136404432562, -0.0426870983197168, + -0.0518876764389233, -0.0493417493999004, -0.0102229491434631, + 0.0238205436617136, 0.0238205436617136, 0.0228668488562107, + 0.0228668488562107, 0.0228668488562107, 0.0228668488562107, + 0.0228668488562107, 0.016014015302062, 0.016014015302062, + 0.016014015302062, 0.016014015302062, 0.016014015302062, + 0.016014015302062, 0.016014015302062, -0.113003022968769, + -0.113003022968769, -0.113003022968769, -0.113003022968769, + 0.0290018498783662, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, + -0.341662645339966, -0.341662645339966, -0.341662645339966, + -0.341662645339966, -0.341662645339966, -0.342307575134425, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.344102795969157, + -0.345113890617272, -0.346790820360184, -0.346790820360184, + -0.346790820360184, -0.346790820360184, -0.350276298561737, + -0.350382447242737, -0.350514574886089, -0.352602005004883, + -0.352602005004883, -0.352602005004883, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285930467317529, -0.28863051533699, + -0.289111226797104, -0.289111226797104, -0.289111226797104, + -0.289184837006529, -0.288198232650757, -0.287200276946976, + -0.28344401717186, -0.282142529682109, -0.2807437479496, + -0.279457504918607, -0.277775110527134, -0.277473300695419, + -0.277473300695419, -0.277473300695419, -0.277473300695419, + -0.277473300695419, -0.243221270450179, -0.220648580807434, + -0.178834423422813, -0.14916887885908, -0.138442978262901, + -0.132412970066071, -0.132269500527871, -0.126238822937012, + -0.131358908318581, -0.153980041620598, -0.151399088356215, + -0.147521440824199, -0.161907189490666, -0.175906361467254, + -0.166769653224895, -0.156968551592764, -0.147167956312853, + -0.13736777995048, -0.127567793370994, -0.117767291011043, + -0.107976101803631, -0.100761251299599, -0.0933373444054856, + -0.0875261271935529, -0.0839530688130422, -0.0795724104270902, + -0.0751918711552247, -0.0708113078436475, -0.0664306926091732, + -0.0620503194639666, -0.0576701413629411, -0.0532900015611635, + -0.051340588711281, -0.0542169431740342, -0.0574335841700743, + -0.0589991906547945, -0.0588792009978815, -0.0574350028357681, + -0.0546537318184004, -0.0535953083456853, -0.0513014828814308, + -0.0500010637241536, -0.0425864167441429, -0.0365300917480262, + -0.0403867978029706, -0.0480469329443586, -0.0493417493999004, + -0.0493417493999004, -0.0493417493999004, -0.0493417493999004, + -0.014689799220697, 0.0238205436617136, 0.0228668488562107, + 0.0228668488562107, 0.0228668488562107, 0.0228668488562107, + 0.0228668488562107, 0.016014015302062, 0.016014015302062, + 0.016014015302062, 0.016014015302062, 0.016014015302062, + 0.016014015302062, 0.016014015302062, -0.0429327083959714, + -0.113003022968769, -0.113003022968769, -0.113003022968769, + -0.0911744871444835, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, + -0.341662645339966, -0.341662645339966, -0.341662645339966, + -0.341662645339966, -0.341662645339966, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.344099866349272, + -0.345144298861833, -0.346790820360184, -0.346790820360184, + -0.346790820360184, -0.346790820360184, -0.350382447242737, + -0.350382447242737, -0.350511421867798, -0.352602005004883, + -0.352602005004883, -0.29742957164956, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285929037312382, -0.288715924996672, + -0.289111226797104, -0.289111226797104, -0.289111226797104, + -0.288198232650757, -0.288198232650757, -0.28344401717186, + -0.28344401717186, -0.2807437479496, -0.2807437479496, + -0.279458253173807, -0.277775434067312, -0.277473300695419, + -0.277473300695419, -0.277473300695419, -0.277473300695419, + -0.277473300695419, -0.277473300695419, -0.21738338861064, + -0.14827012305719, -0.138094395489429, -0.132412970066071, + -0.132412970066071, -0.126238822937012, -0.126238822937012, + -0.12563690976233, -0.122188638832174, -0.122274957597256, + -0.122274957597256, -0.126121491193771, -0.126121491193771, + -0.127641871434993, -0.131759141420168, -0.132288664579391, + -0.132288664579391, -0.137996017159325, -0.138776406645775, + -0.144326919365029, -0.13307270506653, -0.120847343699067, + -0.112710595231565, -0.114142277833639, -0.104900967656425, + -0.0951030132735641, -0.0853063881467714, -0.0792195909582059, + -0.0741832001593468, -0.0691712730597328, -0.0648923569374705, + -0.0605124158804003, -0.0561324399399303, -0.0517527543747427, + -0.0518673142804492, -0.0545667750767362, -0.0553151843714522, + -0.0540635415275454, -0.0525952331231816, -0.0508305620164743, + -0.0495036123675947, -0.0430538616660524, -0.0462119061599935, + -0.0493417493999004, -0.0493417493999004, -0.0493417493999004, + -0.0493417493999004, -0.0493417493999004, -0.0493417493999004, + -0.0493417493999004, -0.00745098313975493, 0.0228668488562107, + 0.0228668488562107, 0.0228668488562107, 0.0228668488562107, + 0.0228668488562107, 0.0222416786753955, 0.016014015302062, + 0.016014015302062, 0.016014015302062, 0.016014015302062, + 0.016014015302062, 0.016014015302062, 0.016014015302062, + -0.0707132103272255, -0.113003022968769, -0.113003022968769, + -0.113003022968769, 0.0309572304628199, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, + -0.341662645339966, -0.341662645339966, -0.341662645339966, + -0.341662645339966, -0.341716757792356, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.344096860484748, + -0.346463455611752, -0.346790820360184, -0.346790820360184, + -0.346790820360184, -0.346790820360184, -0.350382447242737, + -0.350382447242737, -0.35216386348315, -0.352602005004883, + -0.296867878901628, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285927570375635, -0.289069618984675, + -0.289111226797104, -0.289111226797104, -0.289212576865074, + -0.288198232650757, -0.288198232650757, -0.28344401717186, + -0.28344401717186, -0.2807437479496, -0.2807437479496, + -0.279458979145084, -0.277775755565564, -0.277473300695419, + -0.277473300695419, -0.277473300695419, -0.277473300695419, + -0.277473300695419, -0.277473300695419, -0.173210973276344, + -0.138442978262901, -0.132412970066071, -0.132412970066071, + -0.132412970066071, -0.126238822937012, -0.126238822937012, + -0.125638787024821, -0.122188737646608, -0.122274957597256, + -0.122274957597256, -0.124039218973327, -0.126121491193771, + -0.126121491193771, -0.126910297518811, -0.129773813576437, + -0.132288664579391, -0.132288664579391, -0.138776406645775, + -0.104989435471346, -0.0826159377029143, -0.0652253505996707, + -0.0638580322265625, -0.0638580322265625, -0.0638580322265625, + -0.0638580322265625, -0.0589481815695763, -0.0675337641372709, + -0.0653291491381282, -0.0596722014965625, -0.0571106760274289, + -0.0820311870555763, -0.0738001940614779, -0.0654247135682664, + -0.0588854886946407, -0.0545954752236286, -0.0513948697833853, + -0.0515722376060921, -0.0516574833847993, -0.0495978051100766, + -0.0495505492258988, -0.0491893256703356, -0.0495580893428623, + -0.049557994018393, -0.0495579011613502, -0.0495578117391713, + -0.049557688201817, -0.0495575735341207, -0.0495574505247929, + -0.049557318587467, -0.0495571802108803, -0.0168294633689081, + 0.0228668488562107, 0.0228668488562107, 0.0228668488562107, + 0.0228668488562107, 0.0228668488562107, 0.0176419044944536, + 0.016014015302062, 0.016014015302062, 0.016014015302062, + 0.016014015302062, 0.016014015302062, 0.016014015302062, + 0.016014015302062, -0.113003022968769, -0.113003022968769, + -0.113003022968769, -0.0785536355305095, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, + -0.341662645339966, -0.341662645339966, -0.341662645339966, + -0.341662645339966, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.345050573348999, + -0.346790820360184, -0.346790820360184, -0.346790820360184, + -0.346790820360184, -0.346790820360184, -0.350382447242737, + -0.350382447242737, -0.352602005004883, -0.337381427170782, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285926092895998, -0.289111226797104, + -0.289111226797104, -0.289111226797104, -0.288425717149884, + -0.288198232650757, -0.284552021302029, -0.28344401717186, + -0.282631476401726, -0.2807437479496, -0.2807437479496, + -0.279459720537489, -0.277776070954904, -0.277473300695419, + -0.277473300695419, -0.277473300695419, -0.277473300695419, + -0.277473300695419, -0.277473300695419, -0.251404528498035, + -0.132412970066071, -0.132412970066071, -0.132412970066071, + -0.128481652208351, -0.126238822937012, -0.126238822937012, + -0.125640755673318, -0.122188837767703, -0.122274957597256, + -0.122274957597256, -0.122274957597256, -0.126121491193771, + -0.126121491193771, -0.126121491193771, -0.126121491193771, + -0.129839937361755, -0.132288664579391, -0.134292152839507, + -0.083821275166235, -0.0638580322265625, -0.0638580322265625, + -0.0638580322265625, -0.0638580322265625, -0.0638580322265625, + -0.0589481815695763, -0.0535944513976574, -0.0535944513976574, + -0.0529667329136378, -0.0493960529565811, -0.0493960529565811, + -0.0522247231739908, -0.0568307348907977, -0.0590006653494851, + -0.0601683147251606, -0.0517532977815338, -0.0506760329008102, + -0.0506760329008102, -0.0498463471579223, -0.0487668832556844, + -0.0482698492705822, -0.049453929066658, -0.049453929066658, + -0.049453929066658, -0.049453929066658, -0.049453929066658, + -0.049453929066658, -0.049453929066658, -0.049453929066658, + -0.049453929066658, -0.049453929066658, -0.049453929066658, + 0.0190181360698946, 0.0228668488562107, 0.0228668488562107, + 0.0228668488562107, 0.0228668488562107, 0.0228668488562107, + 0.016014015302062, 0.016014015302062, 0.016014015302062, + 0.016014015302062, 0.016014015302062, 0.016014015302062, + 0.016014015302062, -0.005351842698825, -0.113003022968769, + -0.113003022968769, -0.113003022968769, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, + -0.341662645339966, -0.341662645339966, -0.341662645339966, + -0.341662645339966, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.343216627836227, + -0.343216627836227, -0.343216627836227, -0.345050573348999, + -0.346790820360184, -0.346790820360184, -0.346790820360184, + -0.346790820360184, -0.348003866233941, -0.350382447242737, + -0.350382447242737, -0.352602005004883, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.285478293895721, -0.285478293895721, + -0.285478293895721, -0.286644434171981, -0.289111226797104, + -0.289111226797104, -0.289067064300709, -0.288198232650757, + -0.288198232650757, -0.283549437839087, -0.28344401717186, + -0.280993364733928, -0.2807437479496, -0.2807437479496, + -0.279460462843599, -0.277776399578055, -0.277473300695419, + -0.277473300695419, -0.277473300695419, -0.277473300695419, + -0.277473300695419, -0.277473300695419, -0.250754966376429, + -0.132412970066071, -0.132412970066071, -0.132412970066071, + -0.126238822937012, -0.126238822937012, -0.126238822937012, + -0.125642638037386, -0.122188937477281, -0.122274957597256, + -0.122274957597256, -0.122274957597256, -0.122805795105721, + -0.126121491193771, -0.126121491193771, -0.126121491193771, + -0.127308406277369, -0.129495354645449, -0.132288664579391, + -0.0638580322265625, -0.0638580322265625, -0.0638580322265625, + -0.0638580322265625, -0.0638580322265625, -0.0590234908252845, + -0.0539471679580287, -0.0535944513976574, -0.0535944513976574, + -0.0493960529565811, -0.0493960529565811, -0.0493960529565811, + -0.0522246813324968, -0.0568307156600967, -0.0590006703407606, + -0.0554008729111515, -0.0506760329008102, -0.0506760329008102, + -0.0497824347930071, -0.0496994145214558, -0.0489980205893517, + -0.0482773212389458, -0.0483477323777895, -0.049453929066658, + -0.049453929066658, -0.049453929066658, -0.049453929066658, + -0.049453929066658, -0.049453929066658, -0.049453929066658, + -0.049453929066658, -0.049453929066658, -0.049453929066658, + -0.049453929066658, 0.0228668488562107, 0.0228668488562107, + 0.0228668488562107, 0.0228668488562107, 0.0228668488562107, + 0.016014015302062, 0.016014015302062, 0.016014015302062, + 0.016014015302062, 0.016014015302062, 0.016014015302062, + 0.016014015302062, 0.016014015302062, -0.0891496830318213, + -0.113003022968769, -0.113003022968769, -0.0294217562375901, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135, 0.0321612022817135, 0.0321612022817135, + 0.0321612022817135 + ]).reshape(ny, nx) elif name == "u": return np.asarray([ 0, 0, 0, 0, 0.000747702477737098, -0.000703950240413499, From f484dc7480025d54a7d254b4c096c03eb582cea0 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Einar=20=C3=96rn=20=C3=93lason?= Date: Fri, 6 Dec 2024 10:06:14 +0100 Subject: [PATCH 18/21] Update rad2deg in constants.hpp I converted 180/pi to a hex float here: https://observablehq.com/@jrus/hexfloat --- core/src/include/constants.hpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/core/src/include/constants.hpp b/core/src/include/constants.hpp index 38e0400a5..29fedeb50 100644 --- a/core/src/include/constants.hpp +++ b/core/src/include/constants.hpp @@ -37,7 +37,7 @@ const double deg2rad = 0x1.1df46a2529d39p-6; // radians to degrees // TODO: Rewrite as a hex float -const double rad2deg = 1. / deg2rad; +const double rad2deg = 0x1.ca5dc1a63c1f8p+5; } //! Properties of water ice around 0˚C and 101.3 kPa From cfd1b89627792e9d5415fa0d35fba09d9d234fc9 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Einar=20=C3=96rn=20=C3=93lason?= Date: Fri, 6 Dec 2024 10:08:02 +0100 Subject: [PATCH 19/21] Remove a TODO in constants.hpp This is a follow-up on the previous commit (should have used git commit-amend). --- core/src/include/constants.hpp | 1 - 1 file changed, 1 deletion(-) diff --git a/core/src/include/constants.hpp b/core/src/include/constants.hpp index 29fedeb50..930c02077 100644 --- a/core/src/include/constants.hpp +++ b/core/src/include/constants.hpp @@ -36,7 +36,6 @@ const double tau = 6.28318530717958647652; const double deg2rad = 0x1.1df46a2529d39p-6; // radians to degrees -// TODO: Rewrite as a hex float const double rad2deg = 0x1.ca5dc1a63c1f8p+5; } From a71da9a5b524cfba9007bae611c31ee457222604 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Einar=20=C3=96rn=20=C3=93lason?= Date: Fri, 6 Dec 2024 12:35:45 +0100 Subject: [PATCH 20/21] Minor changes after PR review This commit addresses the minor changes Tim asked for in his review. This includes re-naming variables and correcting spelling mistakes. --- .../modules/include/ProtectedArrayNames.ipp | 2 +- dynamics/src/CGDynamicsKernel.cpp | 26 +++++++++---------- .../src/include/BrittleCGDynamicsKernel.hpp | 10 +++---- dynamics/src/include/CGDynamicsKernel.hpp | 6 ++--- dynamics/src/include/VPCGDynamicsKernel.hpp | 10 +++---- .../OceanBoundaryModule/ConfiguredOcean.cpp | 4 +-- .../FluxConfiguredOcean.cpp | 4 +-- .../OceanBoundaryModule/TOPAZOcean.cpp | 7 +++-- .../OceanBoundaryModule/UniformOcean.cpp | 4 +-- 9 files changed, 36 insertions(+), 37 deletions(-) diff --git a/core/src/modules/include/ProtectedArrayNames.ipp b/core/src/modules/include/ProtectedArrayNames.ipp index 3fdff26d4..31d6c1184 100644 --- a/core/src/modules/include/ProtectedArrayNames.ipp +++ b/core/src/modules/include/ProtectedArrayNames.ipp @@ -40,4 +40,4 @@ { "sss_slab", "SLAB_SSS" }, // Slab ocean surface salinity PSU { "qdw", "SLAB_QDW" }, // Slab ocean temperature nudging heat flux, W m⁻² { "fdw", "SLAB_FDW" }, // Slab ocean salinity nudging water flux, kg s⁻¹ m⁻² -{ "ssh", "SSH" }, // Slab ocean salinity nudging water flux, kg s⁻¹ m⁻² + { "ssh", "SSH" }, // Slab ocean salinity nudging water flux, kg s⁻¹ m⁻² diff --git a/dynamics/src/CGDynamicsKernel.cpp b/dynamics/src/CGDynamicsKernel.cpp index 07f0c768e..7994eb0ea 100644 --- a/dynamics/src/CGDynamicsKernel.cpp +++ b/dynamics/src/CGDynamicsKernel.cpp @@ -1,7 +1,7 @@ /*! * @file CGDynamicsKernel.cpp * - * @date Aug 23, 2024 + * @date 06 Dec 2024 * @author Tim Spain */ @@ -36,8 +36,8 @@ void CGDynamicsKernel::initialise( cgH.resize_by_mesh(*smesh); cgA.resize_by_mesh(*smesh); - uGradSeasurfaceHeight.resize_by_mesh(*smesh); - vGradSeasurfaceHeight.resize_by_mesh(*smesh); + xGradSeaSurfaceHeight.resize_by_mesh(*smesh); + yGradSeaSurfaceHeight.resize_by_mesh(*smesh); dStressX.resize_by_mesh(*smesh); dStressY.resize_by_mesh(*smesh); @@ -193,8 +193,8 @@ void CGDynamicsKernel::ComputeGradientOfSeaSurfaceHeight( // Interpolate to CG2 (maybe own function in interpolation?) if (CGDEGREE == 1) { - uGradSeasurfaceHeight = uGrad; - vGradSeasurfaceHeight = vGrad; + xGradSeaSurfaceHeight = uGrad; + yGradSeaSurfaceHeight = vGrad; } else { // outer nodes size_t icg1 = 0; @@ -202,8 +202,8 @@ void CGDynamicsKernel::ComputeGradientOfSeaSurfaceHeight( for (size_t iy = 0; iy <= smesh->ny; ++iy) { size_t icg2 = (2 * smesh->nx + 1) * 2 * iy; for (size_t ix = 0; ix <= smesh->nx; ++ix, ++icg1, icg2 += 2) { - uGradSeasurfaceHeight(icg2) = uGrad(icg1); - vGradSeasurfaceHeight(icg2) = vGrad(icg1); + xGradSeaSurfaceHeight(icg2) = uGrad(icg1); + yGradSeaSurfaceHeight(icg2) = vGrad(icg1); } } // along lines @@ -213,8 +213,8 @@ void CGDynamicsKernel::ComputeGradientOfSeaSurfaceHeight( size_t icg1 = (smesh->nx + 1) * iy; size_t icg2 = (2 * smesh->nx + 1) * 2 * iy + 1; for (size_t ix = 0; ix < smesh->nx; ++ix, ++icg1, icg2 += 2) { - uGradSeasurfaceHeight(icg2) = 0.5 * (uGrad(icg1) + uGrad(icg1 + 1)); - vGradSeasurfaceHeight(icg2) = 0.5 * (vGrad(icg1) + vGrad(icg1 + 1)); + xGradSeaSurfaceHeight(icg2) = 0.5 * (uGrad(icg1) + uGrad(icg1 + 1)); + yGradSeaSurfaceHeight(icg2) = 0.5 * (vGrad(icg1) + vGrad(icg1 + 1)); } } #pragma omp parallel for @@ -223,8 +223,8 @@ void CGDynamicsKernel::ComputeGradientOfSeaSurfaceHeight( size_t icg1 = (smesh->nx + 1) * iy; size_t icg2 = (2 * smesh->nx + 1) * (2 * iy + 1); for (size_t ix = 0; ix <= smesh->nx; ++ix, ++icg1, icg2 += 2) { - uGradSeasurfaceHeight(icg2) = 0.5 * (uGrad(icg1) + uGrad(icg1 + cg1row)); - vGradSeasurfaceHeight(icg2) = 0.5 * (vGrad(icg1) + vGrad(icg1 + cg1row)); + xGradSeaSurfaceHeight(icg2) = 0.5 * (uGrad(icg1) + uGrad(icg1 + cg1row)); + yGradSeaSurfaceHeight(icg2) = 0.5 * (vGrad(icg1) + vGrad(icg1 + cg1row)); } } @@ -235,10 +235,10 @@ void CGDynamicsKernel::ComputeGradientOfSeaSurfaceHeight( size_t icg1 = (smesh->nx + 1) * iy; size_t icg2 = (2 * smesh->nx + 1) * (2 * iy + 1) + 1; for (size_t ix = 0; ix < smesh->nx; ++ix, ++icg1, icg2 += 2) { - uGradSeasurfaceHeight(icg2) = 0.25 + xGradSeaSurfaceHeight(icg2) = 0.25 * (uGrad(icg1) + uGrad(icg1 + 1) + uGrad(icg1 + cg1row) + uGrad(icg1 + cg1row + 1)); - vGradSeasurfaceHeight(icg2) = 0.25 + yGradSeaSurfaceHeight(icg2) = 0.25 * (vGrad(icg1) + vGrad(icg1 + 1) + vGrad(icg1 + cg1row) + vGrad(icg1 + cg1row + 1)); } diff --git a/dynamics/src/include/BrittleCGDynamicsKernel.hpp b/dynamics/src/include/BrittleCGDynamicsKernel.hpp index a2599faf6..dc6aa6b64 100644 --- a/dynamics/src/include/BrittleCGDynamicsKernel.hpp +++ b/dynamics/src/include/BrittleCGDynamicsKernel.hpp @@ -1,7 +1,7 @@ /*! * @file BrittleCGDynamicsKernel.hpp * - * @date 05 Dec 2024 + * @date 06 Dec 2024 * @author Tim Spain * @author Einar Ólason */ @@ -40,8 +40,8 @@ template class BrittleCGDynamicsKernel : public CGDynamicsKern using CGDynamicsKernel::u; using CGDynamicsKernel::v; - using CGDynamicsKernel::uGradSeasurfaceHeight; - using CGDynamicsKernel::vGradSeasurfaceHeight; + using CGDynamicsKernel::xGradSeaSurfaceHeight; + using CGDynamicsKernel::yGradSeaSurfaceHeight; using CGDynamicsKernel::uAtmos; using CGDynamicsKernel::vAtmos; using CGDynamicsKernel::uOcean; @@ -210,9 +210,9 @@ template class BrittleCGDynamicsKernel : public CGDynamicsKern // Stress gradient const double gradX = dStressX(i) / pmap->lumpedcgmass(i) - - params.rhoIce * cgH(i) * PhysicalConstants::g * uGradSeasurfaceHeight(i); + - params.rhoIce * cgH(i) * PhysicalConstants::g * xGradSeaSurfaceHeight(i); const double gradY = dStressY(i) / pmap->lumpedcgmass(i) - - params.rhoIce * cgH(i) * PhysicalConstants::g * vGradSeasurfaceHeight(i); + - params.rhoIce * cgH(i) * PhysicalConstants::g * yGradSeaSurfaceHeight(i); u(i) = alpha * uIce + beta * vIce + dteOverMass * (alpha * (gradX + tauX) + beta * (gradY + tauY)); diff --git a/dynamics/src/include/CGDynamicsKernel.hpp b/dynamics/src/include/CGDynamicsKernel.hpp index ccf3daee2..bdf1011c1 100644 --- a/dynamics/src/include/CGDynamicsKernel.hpp +++ b/dynamics/src/include/CGDynamicsKernel.hpp @@ -1,7 +1,7 @@ /*! * @file CGDynamicsKernel.hpp * - * @date Jan 31, 2024 + * @date 06 Dec 2024 * @author Tim Spain */ @@ -61,8 +61,8 @@ class CGDynamicsKernel : public DynamicsKernel { CGVector cgH; // CG gradient of the seaSurfaceHeight - CGVector uGradSeasurfaceHeight; - CGVector vGradSeasurfaceHeight; + CGVector xGradSeaSurfaceHeight; + CGVector yGradSeaSurfaceHeight; // divergence of stress CGVector dStressX; diff --git a/dynamics/src/include/VPCGDynamicsKernel.hpp b/dynamics/src/include/VPCGDynamicsKernel.hpp index 761c0c1c5..43e9b0d99 100644 --- a/dynamics/src/include/VPCGDynamicsKernel.hpp +++ b/dynamics/src/include/VPCGDynamicsKernel.hpp @@ -1,7 +1,7 @@ /*! * @file VPCGDynamicsKernel.hpp * - * @date 05 Dec 2024 + * @date 06 Dec 2024 * @author Tim Spain */ @@ -36,8 +36,8 @@ template class VPCGDynamicsKernel : public CGDynamicsKernel::u; using CGDynamicsKernel::v; - using CGDynamicsKernel::uGradSeasurfaceHeight; - using CGDynamicsKernel::vGradSeasurfaceHeight; + using CGDynamicsKernel::xGradSeaSurfaceHeight; + using CGDynamicsKernel::yGradSeaSurfaceHeight; using CGDynamicsKernel::uAtmos; using CGDynamicsKernel::vAtmos; using CGDynamicsKernel::uOcean; @@ -129,7 +129,7 @@ template class VPCGDynamicsKernel : public CGDynamicsKernellumpedcgmass(i))); v(i) = (1.0 / (params.rhoIce * cgH(i) / deltaT * (1.0 + beta) // implicit parts @@ -141,7 +141,7 @@ template class VPCGDynamicsKernel : public CGDynamicsKernellumpedcgmass(i))); } } diff --git a/physics/src/modules/OceanBoundaryModule/ConfiguredOcean.cpp b/physics/src/modules/OceanBoundaryModule/ConfiguredOcean.cpp index dff59381b..a7b7a283d 100644 --- a/physics/src/modules/OceanBoundaryModule/ConfiguredOcean.cpp +++ b/physics/src/modules/OceanBoundaryModule/ConfiguredOcean.cpp @@ -1,7 +1,7 @@ /*! * @file ConfiguredOcean.cpp * - * @date 20 Nov 2024 + * @date 06 Dec 2024 * @author Tim Spain */ @@ -96,7 +96,7 @@ void ConfiguredOcean::setData(const ModelState::DataMap& ms) tf = Module::getImplementation()(sssExt[0]); cpml = Water::rho * Water::cp * mld[0]; - /* It's only the SSH gradient which has an effect, so being able to sett a constant SSH is + /* It's only the SSH gradient which has an effect, so being able to set a constant SSH is * useless. */ ssh = 0.; diff --git a/physics/src/modules/OceanBoundaryModule/FluxConfiguredOcean.cpp b/physics/src/modules/OceanBoundaryModule/FluxConfiguredOcean.cpp index df2ef8655..30ea7759c 100644 --- a/physics/src/modules/OceanBoundaryModule/FluxConfiguredOcean.cpp +++ b/physics/src/modules/OceanBoundaryModule/FluxConfiguredOcean.cpp @@ -1,7 +1,7 @@ /*! * @file FluxConfiguredOcean.cpp * - * @date 20 Nov 2024 + * @date 06 Dec 2024 * @author Tim Spain */ @@ -79,7 +79,7 @@ void FluxConfiguredOcean::setData(const ModelState::DataMap& ms) tf = Module::getImplementation()(sss[0]); cpml = Water::rho * Water::cp * mld[0]; - /* It's only the SSH gradient which has an effect, so being able to sett a constant SSH is + /* It's only the SSH gradient which has an effect, so being able to set a constant SSH is * useless. */ ssh = 0.; } diff --git a/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp b/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp index 61d06d268..754aea2b0 100644 --- a/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp +++ b/physics/src/modules/OceanBoundaryModule/TOPAZOcean.cpp @@ -1,15 +1,15 @@ /*! * @file TOPAZOcean.cpp * - * @date 24 Sep 2024 + * @date 06 Dec 2024 * @author Tim Spain */ #include "include/TOPAZOcean.hpp" #include "include/Finalizer.hpp" -#include "include/IIceOceanHeatFlux.hpp" #include "include/IFreezingPoint.hpp" +#include "include/IIceOceanHeatFlux.hpp" #include "include/NextsimModule.hpp" #include "include/ParaGridIO.hpp" #include "include/constants.hpp" @@ -57,8 +57,7 @@ void TOPAZOcean::configure() void TOPAZOcean::updateBefore(const TimestepTime& tst) { - // TODO: Get more authoritative names for the forcings - std::set forcings = { sstName, sssName, "mld", uName, vName, sshName }; + std::set forcings = { sstName, sssName, mldName, uName, vName, sshName }; ModelState state = ParaGridIO::readForcingTimeStatic(forcings, tst.start, filePath); sstExt = state.data.at(sstName); diff --git a/physics/src/modules/OceanBoundaryModule/UniformOcean.cpp b/physics/src/modules/OceanBoundaryModule/UniformOcean.cpp index d79e25cd5..fbf789fb9 100644 --- a/physics/src/modules/OceanBoundaryModule/UniformOcean.cpp +++ b/physics/src/modules/OceanBoundaryModule/UniformOcean.cpp @@ -1,7 +1,7 @@ /*! * @file UniformOcean.cpp * - * @date 23 Aug 2024 + * @date 06 Dec 2024 * @author Tim Spain */ @@ -25,7 +25,7 @@ void UniformOcean::setData(const ModelState::DataMap& ms) cpml = Water::rho * Water::cp * mld[0]; qio = qio0; - /* It's only the SSH gradient which has an effect, so being able to sett a constant SSH is + /* It's only the SSH gradient which has an effect, so being able to set a constant SSH is * useless. */ ssh = 0.; } From 1f32a60fbbed23283d493991426b990ba1ede31a Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Einar=20=C3=96rn=20=C3=93lason?= Date: Fri, 6 Dec 2024 13:28:12 +0100 Subject: [PATCH 21/21] Fix sign error in mEVP solver As per Tim's comment on PR #755. Also some mino cleaning of the mEVP momentum solver code. --- dynamics/src/include/VPCGDynamicsKernel.hpp | 22 ++++++++++----------- 1 file changed, 11 insertions(+), 11 deletions(-) diff --git a/dynamics/src/include/VPCGDynamicsKernel.hpp b/dynamics/src/include/VPCGDynamicsKernel.hpp index 43e9b0d99..11ee990ee 100644 --- a/dynamics/src/include/VPCGDynamicsKernel.hpp +++ b/dynamics/src/include/VPCGDynamicsKernel.hpp @@ -106,7 +106,6 @@ template class VPCGDynamicsKernel : public CGDynamicsKernel class VPCGDynamicsKernel : public CGDynamicsKernellumpedcgmass(i))); - v(i) = (1.0 + + dStressX(i) / pmap->lumpedcgmass(i)); // Internal stress term + v(i) = 1.0 / (params.rhoIce * cgH(i) / deltaT * (1.0 + beta) // implicit parts + cgA(i) * FOcean * absocn) // implicit parts * (params.rhoIce * cgH(i) / deltaT * (beta * v(i) + v0(i)) // pseudo-timestepping + cgA(i) * (FAtm * absatm * vAtmos(i) + // atm forcing - FOcean * absocn * SC * vOcean(i)) // ocean forcing - + params.rhoIce * cgH(i) * params.fc - * v(i) // Coriolis - here the reversed sign of uOcnRel is used + FOcean * absocn * vOcean(i)) // ocean forcing + - params.rhoIce * cgH(i) * params.fc * uPrev // Coriolis - params.rhoIce * cgH(i) * PhysicalConstants::g * yGradSeaSurfaceHeight(i) // sea surface - + dStressY(i) / pmap->lumpedcgmass(i))); + + dStressY(i) / pmap->lumpedcgmass(i)); // Internal stress term } }