diff --git a/dumux/discretization/cellcentered/mpfa/darcyslaw.hh b/dumux/discretization/cellcentered/mpfa/darcyslaw.hh index 6338d004c127c706aedbe8016f0d096860d0fcb2..de9b1d59020954e7ba38a352b044cb30f3095136 100644 --- a/dumux/discretization/cellcentered/mpfa/darcyslaw.hh +++ b/dumux/discretization/cellcentered/mpfa/darcyslaw.hh @@ -25,12 +25,6 @@ #ifndef DUMUX_DISCRETIZATION_CC_MPFA_DARCYS_LAW_HH #define DUMUX_DISCRETIZATION_CC_MPFA_DARCYS_LAW_HH -#include <memory> - -#include <dune/common/float_cmp.hh> - -#include <dumux/common/math.hh> -#include <dumux/common/parameters.hh> #include <dumux/implicit/properties.hh> #include <dumux/discretization/cellcentered/mpfa/facetypes.hh> @@ -41,6 +35,8 @@ namespace Properties { // forward declaration of properties NEW_PROP_TAG(ProblemEnableGravity); +NEW_PROP_TAG(MpfaHelper); +NEW_PROP_TAG(BoundaryInteractionVolume); } /*! @@ -50,6 +46,8 @@ NEW_PROP_TAG(ProblemEnableGravity); template <class TypeTag> class DarcysLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> { + using Implementation = typename GET_PROP_TYPE(TypeTag, AdvectionType); + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); using Problem = typename GET_PROP_TYPE(TypeTag, Problem); using GridView = typename GET_PROP_TYPE(TypeTag, GridView); @@ -69,7 +67,6 @@ class DarcysLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> using CoefficientVector = typename BoundaryInteractionVolume::Vector; static constexpr int numPhases = GET_PROP_VALUE(TypeTag, NumPhases); - static constexpr bool facetCoupling = GET_PROP_VALUE(TypeTag, MpfaFacetCoupling); static constexpr bool useTpfaBoundary = GET_PROP_VALUE(TypeTag, UseTpfaBoundary); static constexpr bool enableInteriorBoundaries = GET_PROP_VALUE(TypeTag, EnableInteriorBoundaries); @@ -91,10 +88,6 @@ class DarcysLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> advectionVolVarsPositions_ = iv.volVarsPositions(); advectionTij_ = iv.getTransmissibilities(localFaceData); - // we will need the neumann flux transformation only on interior boundaries with facet coupling - if (enableInteriorBoundaries && facetCoupling) - advectionCij_ = iv.getNeumannFluxTransformationCoefficients(localFaceData); - // The neumann fluxes always have to be set per phase for (unsigned int phaseIdx = 0; phaseIdx < numPhases; ++phaseIdx) phaseNeumannFluxes_[phaseIdx] = iv.getNeumannFlux(localFaceData, phaseIdx); @@ -116,11 +109,6 @@ class DarcysLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> const CoefficientVector& advectionTij() const { return advectionTij_; } - //! Returns the vector of coefficients with which the vector of neumann boundary conditions - //! has to be multiplied in order to transform them on the scvf this cache belongs to - const CoefficientVector& advectionCij() const - { return advectionCij_; } - //! If the useTpfaBoundary property is set to false, the boundary conditions //! are put into the local systems leading to possible contributions on all faces Scalar advectionNeumannFlux(unsigned int phaseIdx) const @@ -131,7 +119,6 @@ class DarcysLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> Stencil advectionVolVarsStencil_; PositionVector advectionVolVarsPositions_; CoefficientVector advectionTij_; - CoefficientVector advectionCij_; std::array<Scalar, numPhases> phaseNeumannFluxes_; }; @@ -174,7 +161,7 @@ public: const unsigned int phaseIdx, const ElementFluxVariablesCache& elemFluxVarsCache) { - const bool gravity = GET_PARAM_FROM_GROUP(TypeTag, bool, Problem, EnableGravity); + static const bool gravity = GET_PARAM_FROM_GROUP(TypeTag, bool, Problem, EnableGravity); const auto& fluxVarsCache = elemFluxVarsCache[scvf]; const auto& volVarsStencil = fluxVarsCache.advectionVolVarsStencil(); @@ -182,38 +169,17 @@ public: const auto& tij = fluxVarsCache.advectionTij(); const bool isInteriorBoundary = enableInteriorBoundaries && fluxVarsCache.isInteriorBoundary(); - // For interior Neumann boundaries when using Tpfa for Neumann boundary conditions, we simply - // return the user-specified flux. We assume phaseIdx = eqIdx here. + // For interior Neumann boundaries when using Tpfa on boundaries, return the user-specified flux + // We assume phaseIdx = eqIdx here. if (isInteriorBoundary && useTpfaBoundary && fluxVarsCache.interiorBoundaryDataSelf().faceType() == MpfaFaceTypes::interiorNeumann) return scvf.area()* elemVolVars[scvf.insideScvIdx()].extrusionFactor()* - problem.neumann(element, - fvGeometry, - elemVolVars, - scvf)[phaseIdx]; + problem.neumann(element, fvGeometry, elemVolVars, scvf)[phaseIdx]; // Calculate the interface density for gravity evaluation - const auto rho = [&] () - { - if (!gravity) - return Scalar(0.0); - else - { - // Treat interior boundaries differently - if (enableInteriorBoundaries && isInteriorBoundary) - { - const auto& data = fluxVarsCache.interiorBoundaryDataSelf(); - if (facetCoupling || data.faceType() == MpfaFaceTypes::interiorDirichlet) - return data.facetVolVars(fvGeometry).density(phaseIdx); - else - return interpolateDensity(elemVolVars, scvf, phaseIdx); - } - else - return interpolateDensity(elemVolVars, scvf, phaseIdx); - } - } (); + const auto rho = Implementation::interpolateDensity(fvGeometry, elemVolVars, scvf, fluxVarsCache, phaseIdx, isInteriorBoundary); // calculate Tij*pj Scalar flux(0.0); @@ -240,18 +206,66 @@ public: if (!enableInteriorBoundaries) return useTpfaBoundary ? flux : flux + fluxVarsCache.advectionNeumannFlux(phaseIdx); - ////////////////////////////////////////////////////////////////// // Handle interior boundaries - ////////////////////////////////////////////////////////////////// + flux += Implementation::computeInteriorBoundaryContribution(problem, fvGeometry, elemVolVars, fluxVarsCache, phaseIdx, rho); - // For active facet coupling we will have to transform the interior flux vector - const auto& cij = fluxVarsCache.advectionCij(); + // return overall resulting flux + return useTpfaBoundary ? flux : flux + fluxVarsCache.advectionNeumannFlux(phaseIdx); + } + + static Scalar interpolateDensity(const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolumeFace& scvf, + const FluxVariablesCache& fluxVarsCache, + const unsigned int phaseIdx, + const bool isInteriorBoundary) + { + static const bool gravity = GET_PARAM_FROM_GROUP(TypeTag, bool, Problem, EnableGravity); - // The vector of interior neumann fluxes - CoefficientVector facetCouplingFluxes(cij.size(), 0.0); + if (!gravity) + return Scalar(0.0); + else + { + // Treat interior Dirichlet boundaries differently + if (isInteriorBoundary) + { + const auto& data = fluxVarsCache.interiorBoundaryDataSelf(); + if (data.faceType() == MpfaFaceTypes::interiorDirichlet) + return data.facetVolVars(fvGeometry).density(phaseIdx); + } + + // use arithmetic mean of the densities around the scvf + if (!scvf.boundary()) + { + Scalar rho = elemVolVars[scvf.insideScvIdx()].density(phaseIdx); + for (auto outsideIdx : scvf.outsideScvIndices()) + rho += elemVolVars[outsideIdx].density(phaseIdx); + return rho/(scvf.outsideScvIndices().size()+1); + } + else + return elemVolVars[scvf.outsideScvIdx()].density(phaseIdx); + } + } + + static Scalar computeInteriorBoundaryContribution(const Problem& problem, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const FluxVariablesCache& fluxVarsCache, + unsigned int phaseIdx, Scalar rho) + { + static const bool gravity = GET_PARAM_FROM_GROUP(TypeTag, bool, Problem, EnableGravity); + + // obtain the transmissibilites associated with all pressures + const auto& tij = fluxVarsCache.advectionTij(); + + // the interior dirichlet boundaries local indices start after + // the cell and the domain Dirichlet boundary pressures + const auto startIdx = fluxVarsCache.advectionVolVarsStencil().size(); + + // add interior Dirichlet boundary contributions + Scalar flux = 0.0; for (auto&& data : fluxVarsCache.interiorBoundaryData()) { - // Add additional Dirichlet fluxes for interior Dirichlet faces if (data.faceType() == MpfaFaceTypes::interiorDirichlet) { Scalar h = data.facetVolVars(fvGeometry).pressure(phaseIdx); @@ -264,60 +278,11 @@ public: h -= rho*(g*x); } - // The transmissibilities of interior dirichlet boundaries are placed at the end - // So we simply keep incrementing the local index - flux += tij[localIdx + data.localIndexInInteractionVolume()]*h; - } - - // add neumann fluxes for interior Neumann faces if facet coupling is active - if (facetCoupling && data.faceType() == MpfaFaceTypes::interiorNeumann) - { - // get the volvars of the actual interior neumann face - const auto facetVolVars = data.facetVolVars(fvGeometry); - - // get the scvf corresponding to actual interior neumann face - const auto& curScvf = fvGeometry.scvf(data.scvfIndex()); - - // calculate "lekage factor" - const auto n = curScvf.unitOuterNormal(); - const auto v = [&] () - { - auto res = n; - res *= -0.5*facetVolVars.extrusionFactor(); - res -= curScvf.ipGlobal(); - res += curScvf.facetCorner(); - res /= res.two_norm2(); - return res; - } (); - - // add value to vector of interior neumann fluxes - facetCouplingFluxes[data.localIndexInInteractionVolume()] -= facetVolVars.pressure(phaseIdx)* - MpfaHelper::nT_M_v(n, facetVolVars.permeability(), v); + flux += tij[startIdx + data.localIndexInInteractionVolume()]*h; } } - // return overall resulting flux - const Scalar interiorNeumannFlux = facetCoupling ? cij*facetCouplingFluxes : 0.0; - return useTpfaBoundary ? - flux + interiorNeumannFlux : - flux + interiorNeumannFlux + fluxVarsCache.advectionNeumannFlux(phaseIdx); - } - -private: - static Scalar interpolateDensity(const ElementVolumeVariables& elemVolVars, - const SubControlVolumeFace& scvf, - const unsigned int phaseIdx) - { - // use arithmetic mean of the densities around the scvf - if (!scvf.boundary()) - { - Scalar rho = elemVolVars[scvf.insideScvIdx()].density(phaseIdx); - for (auto outsideIdx : scvf.outsideScvIndices()) - rho += elemVolVars[outsideIdx].density(phaseIdx); - return rho/(scvf.outsideScvIndices().size()+1); - } - else - return elemVolVars[scvf.outsideScvIdx()].density(phaseIdx); + return flux; } }; diff --git a/dumux/discretization/cellcentered/mpfa/fickslaw.hh b/dumux/discretization/cellcentered/mpfa/fickslaw.hh index 3ca55a8fcfc90e9d9d6dc14db178b18e48164a48..be41e0885a68bfb0b2aed9d3e498df2afe76ea52 100644 --- a/dumux/discretization/cellcentered/mpfa/fickslaw.hh +++ b/dumux/discretization/cellcentered/mpfa/fickslaw.hh @@ -43,6 +43,8 @@ namespace Dumux template <class TypeTag> class FicksLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> { + using Implementation = typename GET_PROP_TYPE(TypeTag, MolecularDiffusionType); + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); using Problem = typename GET_PROP_TYPE(TypeTag, Problem); using GridView = typename GET_PROP_TYPE(TypeTag, GridView); @@ -65,7 +67,6 @@ class FicksLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> static constexpr int numPhases = GET_PROP_VALUE(TypeTag, NumPhases); static constexpr bool useTpfaBoundary = GET_PROP_VALUE(TypeTag, UseTpfaBoundary); - static constexpr bool facetCoupling = GET_PROP_VALUE(TypeTag, MpfaFacetCoupling); static constexpr bool enableInteriorBoundaries = GET_PROP_VALUE(TypeTag, EnableInteriorBoundaries); //! The cache used in conjunction with the mpfa Fick's Law @@ -87,11 +88,10 @@ class FicksLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> unsigned int phaseIdx, unsigned int compIdx) { const auto& localFaceData = iv.getLocalFaceData(scvf); - diffusionVolVarsStencils_[phaseIdx][compIdx] = iv.volVarsStencil(); diffusionTij_[phaseIdx][compIdx] = iv.getTransmissibilities(localFaceData); - - if (enableInteriorBoundaries) - diffusionCij_[phaseIdx][compIdx] = iv.getNeumannFluxTransformationCoefficients(localFaceData); + // get the stencil only for the first call + if (phaseIdx == 0 && compIdx == 0) + diffusionVolVarsStencil_ = iv.volVarsStencil(); //! For compositional models, we associate neumann fluxes with the phases (main components) //! This is done in the AdvectionCache. However, in single-phasic models we solve the phase AND @@ -106,18 +106,13 @@ class FicksLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> //! computation. This includes all participating boundary volume variables //! and it can be different for the phases & components. const Stencil& diffusionVolVarsStencil(unsigned int phaseIdx, unsigned int compIdx) const - { return diffusionVolVarsStencils_[phaseIdx][compIdx]; } + { return diffusionVolVarsStencil_; } //! Returns the transmissibilities associated with the volume variables //! This can be different for the phases & components. const CoefficientVector& diffusionTij(unsigned int phaseIdx, unsigned int compIdx) const { return diffusionTij_[phaseIdx][compIdx]; } - //! Returns the vector of coefficients with which the vector of neumann boundary conditions - //! has to be multiplied in order to transform them on the scvf this cache belongs to - const CoefficientVector& diffusionCij(unsigned int phaseIdx, unsigned int compIdx) const - { return diffusionCij_[phaseIdx][compIdx]; } - //! If the useTpfaBoundary property is set to false, the boundary conditions //! are put into the local systems leading to possible contributions on all faces Scalar componentNeumannFlux(unsigned int compIdx) const @@ -128,9 +123,8 @@ class FicksLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> private: // Quantities associated with molecular diffusion - std::array< std::array<Stencil, numComponents>, numPhases> diffusionVolVarsStencils_; + Stencil diffusionVolVarsStencil_; std::array< std::array<CoefficientVector, numComponents>, numPhases> diffusionTij_; - std::array< std::array<CoefficientVector, numComponents>, numPhases> diffusionCij_; // diffusive neumann flux for single-phasic models std::array<Scalar, numComponents> componentNeumannFluxes_; @@ -194,70 +188,25 @@ public: && fluxVarsCache.interiorBoundaryDataSelf().faceType() == MpfaFaceTypes::interiorNeumann) return scvf.area()* elemVolVars[scvf.insideScvIdx()].extrusionFactor()* - problem.neumann(element, - fvGeometry, - elemVolVars, - scvf)[compIdx]; + problem.neumann(element, fvGeometry, elemVolVars, scvf)[compIdx]; // get the scaling factor for the effective diffusive fluxes - const auto effFactor = [&] () - { - // Treat interior boundaries differently - if (isInteriorBoundary) - { - const auto& data = fluxVarsCache.interiorBoundaryDataSelf(); - - // interpolate as usual for interior Neumann faces without facet coupling - if (data.faceType() == MpfaFaceTypes::interiorNeumann && !facetCoupling) - return calculateEffectiveDiffusivityFactor(elemVolVars, scvf, phaseIdx); - // use harmonic mean between the interior and the facet volvars - else - { - const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; - const auto factor = EffDiffModel::effectiveDiffusivity(insideVolVars.porosity(), - insideVolVars.saturation(phaseIdx), - /*Diffusion coefficient*/ 1.0); - - const auto facetVolVars = data.facetVolVars(fvGeometry); - const auto outsideFactor = EffDiffModel::effectiveDiffusivity(facetVolVars.porosity(), - facetVolVars.saturation(phaseIdx), - /*Diffusion coefficient*/ 1.0); - - return harmonicMean(factor, outsideFactor); - } - } - else - return calculateEffectiveDiffusivityFactor(elemVolVars, scvf, phaseIdx); - } (); + const auto effFactor = Implementation::computeEffectivityFactor(fvGeometry, elemVolVars, scvf, fluxVarsCache, phaseIdx, isInteriorBoundary); // if factor is zero, the flux will end up zero anyway if (effFactor == 0.0) return 0.0; // lambda functions depending on if we use mole or mass fractions - auto getX = [useMoles, phaseIdx, compIdx] (const VolumeVariables& volVars) + auto getX = [useMoles, phaseIdx, compIdx] (const auto& volVars) { return useMoles ? volVars.moleFraction(phaseIdx, compIdx) : volVars.massFraction(phaseIdx, compIdx); }; - auto getRho = [useMoles, phaseIdx] (const VolumeVariables& volVars) + auto getRho = [useMoles, phaseIdx] (const auto& volVars) { return useMoles ? volVars.molarDensity(phaseIdx) : volVars.density(phaseIdx); }; // calculate the density at the interface - const auto rho = [&] () - { - // maybe use the density of the interior BC on the facet - if (isInteriorBoundary) - { - const auto& data = fluxVarsCache.interiorBoundaryDataSelf(); - - if (facetCoupling || data.faceType() == MpfaFaceTypes::interiorDirichlet) - return useMoles ? data.facetVolVars(fvGeometry).molarDensity(phaseIdx) : data.facetVolVars(fvGeometry).density(phaseIdx); - else - return interpolateDensity(elemVolVars, scvf, getRho); - } - else - return interpolateDensity(elemVolVars, scvf, getRho); - } (); + const auto rho = Implementation::interpolateDensity(fvGeometry, elemVolVars, scvf, fluxVarsCache, getRho, isInteriorBoundary); // calculate Tij*xj Scalar flux(0.0); @@ -269,69 +218,30 @@ public: if (!enableInteriorBoundaries) return useTpfaBoundary ? flux*rho*effFactor : flux*rho*effFactor + fluxVarsCache.componentNeumannFlux(compIdx); - ////////////////////////////////////////////////////////////////// // Handle interior boundaries - ////////////////////////////////////////////////////////////////// - - // get coefficients to transform the vector of interior neumann boundary conditions - const auto& cij = fluxVarsCache.diffusionCij(phaseIdx, compIdx); - - // The vector of interior neumann fluxes - CoefficientVector facetCouplingFluxes(cij.size(), 0.0); - for (auto&& data : fluxVarsCache.interiorBoundaryData()) - { - // Add additional Dirichlet fluxes for interior Dirichlet faces - if (data.faceType() == MpfaFaceTypes::interiorDirichlet) - { - // The transmissibilities of interior dirichlet boundaries are placed at the end - // So we simply keep incrementing the local index - const auto x = useMoles ? - data.facetVolVars(fvGeometry).moleFraction(phaseIdx, compIdx) : - data.facetVolVars(fvGeometry).massFraction(phaseIdx, compIdx); - flux += tij[localIdx + data.localIndexInInteractionVolume()]*x; - } - - // add neumann fluxes for interior Neumann faces - if (facetCoupling && data.faceType() == MpfaFaceTypes::interiorNeumann) - { - // get the scvf corresponding to actual interior boundary face - const auto& curScvf = fvGeometry.scvf(data.scvfIndex()); - - // get the volvars of the actual interior neumann face - const auto facetVolVars = data.facetVolVars(fvGeometry); - - // calculate "lekage factor" - const auto n = curScvf.unitOuterNormal(); - const auto v = [&] () - { - auto res = n; - res *= -0.5*facetVolVars.extrusionFactor(); - res -= curScvf.ipGlobal(); - res += curScvf.facetCorner(); - res /= res.two_norm2(); - return res; - } (); - - // add value to vector of interior neumann fluxes - facetCouplingFluxes[data.localIndexInInteractionVolume()] += MpfaHelper::nT_M_v(n, - facetVolVars.diffusionCoefficient(phaseIdx, compIdx), - v); - } - } + flux += Implementation::computeInteriorBoundaryContribution(fvGeometry, elemVolVars, fluxVarsCache, getX, phaseIdx, compIdx); // return overall resulting flux - const Scalar interiorNeumannFlux = facetCoupling ? cij*facetCouplingFluxes : 0.0; - return useTpfaBoundary ? - flux + interiorNeumannFlux : - flux + interiorNeumannFlux + fluxVarsCache.componentNeumannFlux(compIdx); + return useTpfaBoundary ? flux*rho*effFactor : flux*rho*effFactor + fluxVarsCache.componentNeumannFlux(compIdx); } -private: template<typename GetRhoFunction> - static Scalar interpolateDensity(const ElementVolumeVariables& elemVolVars, + static Scalar interpolateDensity(const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, const SubControlVolumeFace& scvf, - const GetRhoFunction& getRho) + const FluxVariablesCache& fluxVarsCache, + const GetRhoFunction& getRho, + const bool isInteriorBoundary) { + + // maybe use the density of the interior BC on the facet + if (isInteriorBoundary) + { + const auto& data = fluxVarsCache.interiorBoundaryDataSelf(); + if (data.faceType() == MpfaFaceTypes::interiorDirichlet) + return getRho(data.facetVolVars(fvGeometry)); + } + // use arithmetic mean of the densities around the scvf if (!scvf.boundary()) { @@ -348,14 +258,39 @@ private: //! scaled to get the effective diffusivity. For this we use the effective diffusivity with //! a diffusion coefficient of 1.0 as input. Then we scale the transmissibilites during flux //! calculation (above) with the harmonic average of the two factors - static Scalar calculateEffectiveDiffusivityFactor(const ElementVolumeVariables& elemVolVars, - const SubControlVolumeFace& scvf, - const unsigned int phaseIdx) + static Scalar computeEffectivityFactor(const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolumeFace& scvf, + const FluxVariablesCache& fluxVarsCache, + const unsigned int phaseIdx, + const bool isInteriorBoundary) { + // Treat interior boundaries differently + if (isInteriorBoundary) + { + const auto& data = fluxVarsCache.interiorBoundaryDataSelf(); + // use harmonic mean between the interior and the facet volvars + if (data.faceType() == MpfaFaceTypes::interiorDirichlet) + { + const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; + const auto factor = EffDiffModel::effectiveDiffusivity(insideVolVars.porosity(), + insideVolVars.saturation(phaseIdx), + /*Diffusion coefficient*/ 1.0); + + const auto facetVolVars = data.facetVolVars(fvGeometry); + const auto outsideFactor = EffDiffModel::effectiveDiffusivity(facetVolVars.porosity(), + facetVolVars.saturation(phaseIdx), + /*Diffusion coefficient*/ 1.0); + + return harmonicMean(factor, outsideFactor); + } + } + + // use the harmonic mean between inside and outside const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; const auto factor = EffDiffModel::effectiveDiffusivity(insideVolVars.porosity(), - insideVolVars.saturation(phaseIdx), - /*Diffusion coefficient*/ 1.0); + insideVolVars.saturation(phaseIdx), + /*Diffusion coefficient*/ 1.0); if (!scvf.boundary()) { @@ -376,6 +311,29 @@ private: return factor; } + + template<typename GetXFunction> + static Scalar computeInteriorBoundaryContribution(const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const FluxVariablesCache& fluxVarsCache, + const GetXFunction& getX, + unsigned int phaseIdx, unsigned int compIdx) + { + // obtain the transmissibilites associated with all pressures + const auto& tij = fluxVarsCache.diffusionTij(phaseIdx, compIdx); + + // the interior dirichlet boundaries local indices start after + // the cell and the domain Dirichlet boundary pressures + const auto startIdx = fluxVarsCache.diffusionVolVarsStencil(phaseIdx, compIdx).size(); + + // add interior Dirichlet boundary contributions + Scalar flux = 0.0; + for (auto&& data : fluxVarsCache.interiorBoundaryData()) + if (data.faceType() == MpfaFaceTypes::interiorDirichlet) + flux += tij[startIdx + data.localIndexInInteractionVolume()]*getX(data.facetVolVars(fvGeometry)); + + return flux; + } }; } // end namespace diff --git a/dumux/discretization/cellcentered/mpfa/fluxvariablescachefiller.hh b/dumux/discretization/cellcentered/mpfa/fluxvariablescachefiller.hh index 09241b93c9d190e3a9c077dfbfaa22bb8894f1e2..9b181c641c5bb89d8f8c4705e9a1d9f30d9217b4 100644 --- a/dumux/discretization/cellcentered/mpfa/fluxvariablescachefiller.hh +++ b/dumux/discretization/cellcentered/mpfa/fluxvariablescachefiller.hh @@ -35,7 +35,6 @@ namespace Properties { NEW_PROP_TAG(NumPhases); NEW_PROP_TAG(NumComponents); -NEW_PROP_TAG(ThermalConductivityModel); }; /*! diff --git a/dumux/discretization/cellcentered/mpfa/fourierslaw.hh b/dumux/discretization/cellcentered/mpfa/fourierslaw.hh index 385d78849244e75ae64e62ab5a5c8f03d1368dfc..27c5d07a3d4759bc3d20fc46f1e54bf0e4d907b1 100644 --- a/dumux/discretization/cellcentered/mpfa/fourierslaw.hh +++ b/dumux/discretization/cellcentered/mpfa/fourierslaw.hh @@ -41,6 +41,8 @@ namespace Dumux template <class TypeTag> class FouriersLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> { + using Implementation = typename GET_PROP_TYPE(TypeTag, HeatConductionType); + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); using Problem = typename GET_PROP_TYPE(TypeTag, Problem); using MpfaHelper = typename GET_PROP_TYPE(TypeTag, MpfaHelper); @@ -59,7 +61,6 @@ class FouriersLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> using Element = typename GridView::template Codim<0>::Entity; using IndexType = typename GridView::IndexSet::IndexType; - static constexpr bool facetCoupling = GET_PROP_VALUE(TypeTag, MpfaFacetCoupling); static constexpr bool useTpfaBoundary = GET_PROP_VALUE(TypeTag, UseTpfaBoundary); static constexpr bool enableInteriorBoundaries = GET_PROP_VALUE(TypeTag, EnableInteriorBoundaries); @@ -78,9 +79,6 @@ class FouriersLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> heatConductionVolVarsStencil_ = iv.volVarsStencil(); heatConductionTij_ = iv.getTransmissibilities(localFaceData); heatNeumannFlux_ = iv.getNeumannFlux(localFaceData, energyEqIdx); - - if (enableInteriorBoundaries) - heatConductionCij_ = iv.getNeumannFluxTransformationCoefficients(localFaceData); } //! Returns the volume variables indices necessary for heat conduction flux @@ -94,11 +92,6 @@ class FouriersLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> const CoefficientVector& heatConductionTij() const { return heatConductionTij_; } - //! Returns the vector of coefficients with which the vector of neumann boundary conditions - //! has to be multiplied in order to transform them on the scvf this cache belongs to - const CoefficientVector& heatConductionCij() const - { return heatConductionCij_; } - //! If the useTpfaBoundary property is set to false, the boundary conditions //! are put into the local systems leading to possible contributions on all faces Scalar heatNeumannFlux() const @@ -108,7 +101,6 @@ class FouriersLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> // Quantities associated with heat conduction Stencil heatConductionVolVarsStencil_; CoefficientVector heatConductionTij_; - CoefficientVector heatConductionCij_; Scalar heatNeumannFlux_; }; @@ -155,17 +147,13 @@ public: const auto& tij = fluxVarsCache.heatConductionTij(); const bool isInteriorBoundary = enableInteriorBoundaries && fluxVarsCache.isInteriorBoundary(); - // For interior Neumann boundaries when using Tpfa for Neumann boundary conditions, we simply - // return the user-specified flux + // For interior Neumann boundaries when using Tpfa on boundaries, return the user-specified flux if (isInteriorBoundary && useTpfaBoundary && fluxVarsCache.interiorBoundaryDataSelf().faceType() == MpfaFaceTypes::interiorNeumann) return scvf.area()* elemVolVars[scvf.insideScvIdx()].extrusionFactor()* - problem.neumann(element, - fvGeometry, - elemVolVars, - scvf)[energyEqIdx]; + problem.neumann(element, fvGeometry, elemVolVars, scvf)[energyEqIdx]; // calculate Tij*tj Scalar flux(0.0); @@ -177,68 +165,31 @@ public: if (!enableInteriorBoundaries) return useTpfaBoundary ? flux : flux + fluxVarsCache.heatNeumannFlux(); - ////////////////////////////////////////////////////////////////// // Handle interior boundaries - ////////////////////////////////////////////////////////////////// + flux += Implementation::computeInteriorBoundaryContribution(fvGeometry, elemVolVars, fluxVarsCache); + + // return overall resulting flux + return useTpfaBoundary ? flux : flux + fluxVarsCache.heatNeumannFlux(); + } - // get coefficients to transform the vector of interior neumann boundary conditions - const auto& cij = fluxVarsCache.heatConductionCij(); + static Scalar computeInteriorBoundaryContribution(const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const FluxVariablesCache& fluxVarsCache) + { + // obtain the transmissibilites associated with all pressures + const auto& tij = fluxVarsCache.heatConductionTij(); + + // the interior dirichlet boundaries local indices start after + // the cell and the domain Dirichlet boundary pressures + const auto startIdx = fluxVarsCache.heatConductionVolVarsStencil().size(); - // The Vector of interior neumann fluxes - CoefficientVector facetCouplingFluxes(cij.size(), 0.0); + // add interior Dirichlet boundary contributions + Scalar flux = 0.0; for (auto&& data : fluxVarsCache.interiorBoundaryData()) - { - // Add additional Dirichlet fluxes for interior Dirichlet faces if (data.faceType() == MpfaFaceTypes::interiorDirichlet) - { - // The transmissibilities of interior dirichlet boundaries are placed at the end - // So we simply keep incrementing the local index - flux += tij[localIdx + data.localIndexInInteractionVolume()]*data.facetVolVars(fvGeometry).temperature(); - } - - // add neumann fluxes for interior Neumann faces - if (data.faceType() == MpfaFaceTypes::interiorNeumann) - { - if (facetCoupling) - { - // get the scvf corresponding to actual interior boundary face - const auto& curScvf = fvGeometry.scvf(data.scvfIndex()); - - // obtain the complete data on the facet element - const auto completeFacetData = data.completeCoupledFacetData(); - - // calculate "lekage factor" - const auto n = curScvf.unitOuterNormal(); - const auto v = [&] () - { - auto res = n; - res *= -0.5*completeFacetData.volVars().extrusionFactor(); - res -= curScvf.ipGlobal(); - res += curScvf.facetCorner(); - res /= res.two_norm2(); - return res; - } (); - - // get the thermal conductivity in the facet element - const auto facetLambda = ThermalConductivityModel::effectiveThermalConductivity(completeFacetData.volVars(), - completeFacetData.spatialParams(), - completeFacetData.element(), - completeFacetData.fvGeometry(), - completeFacetData.scv()); - - // add value to vector of interior neumann fluxes - facetCouplingFluxes[data.localIndexInInteractionVolume()] += MpfaHelper::nT_M_v(n, - facetLambda, - v); - } - } - } + flux += tij[startIdx + data.localIndexInInteractionVolume()]*data.facetVolVars(fvGeometry).temperature(); - // return overall resulting flux - const Scalar interiorNeumannFlux = facetCoupling ? cij*facetCouplingFluxes : 0.0; - return useTpfaBoundary ? - flux + interiorNeumannFlux : - flux + interiorNeumannFlux + fluxVarsCache.heatNeumannFlux(); + return flux; } }; diff --git a/dumux/discretization/cellcentered/mpfa/globalfvgeometry.hh b/dumux/discretization/cellcentered/mpfa/globalfvgeometry.hh index e8e02feadc1cad1f7c31ed1c70cdf00908ab6949..97592fe79f57e3348d8ad7848cd64adbcec087e0 100644 --- a/dumux/discretization/cellcentered/mpfa/globalfvgeometry.hh +++ b/dumux/discretization/cellcentered/mpfa/globalfvgeometry.hh @@ -18,31 +18,21 @@ *****************************************************************************/ /*! * \file - * \brief Base class for the finite volume geometry vector for box models + * \brief Base class for the finite volume geometry vector for mpfa models * This builds up the sub control volumes and sub control volume faces * for each element. */ -#ifndef DUMUX_DISCRETIZATION_CC_MPFA_GLOBALFVGEOMETRY_HH -#define DUMUX_DISCRETIZATION_CC_MPFA_GLOBALFVGEOMETRY_HH +#ifndef DUMUX_DISCRETIZATION_CC_MPFA_GLOBALFVGEOMETRY_BASE_HH +#define DUMUX_DISCRETIZATION_CC_MPFA_GLOBALFVGEOMETRY_BASE_HH + +#include <dune/geometry/multilineargeometry.hh> +#include <dune/geometry/referenceelements.hh> -#include <dumux/discretization/cellcentered/mpfa/globalfvgeometrybase.hh> -#include "methods.hh" +#include <dumux/implicit/cellcentered/mpfa/properties.hh> +#include <dumux/common/elementmap.hh> namespace Dumux { -//! Forward declaration of the method-specific specialization -//! By default, the methods simply inherit from the base class -//! Methods that use a different implementation have to provide this below -template<class TypeTag, MpfaMethods method, bool EnableFVElementGeometryCache> -class CCMpfaGlobalFVGeometryImplementation : public CCMpfaGlobalFVGeometryBase<TypeTag, EnableFVElementGeometryCache> -{ - using ParentType = CCMpfaGlobalFVGeometryBase<TypeTag, EnableFVElementGeometryCache>; - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - -public: - CCMpfaGlobalFVGeometryImplementation(const GridView& gridView) : ParentType(gridView) {} -}; - /*! * \ingroup ImplicitModel * \brief Base class for the finite volume geometry vector for mpfa models @@ -50,10 +40,736 @@ public: * for each element. */ template<class TypeTag, bool EnableFVElementGeometryCache> -using CCMpfaGlobalFVGeometry = CCMpfaGlobalFVGeometryImplementation<TypeTag, GET_PROP_VALUE(TypeTag, MpfaMethod), EnableFVElementGeometryCache>; +class CCMpfaGlobalFVGeometry +{}; -} // end namespace +// specialization in case the FVElementGeometries are stored +template<class TypeTag> +class CCMpfaGlobalFVGeometry<TypeTag, true> +{ + using Implementation = typename GET_PROP_TYPE(TypeTag, GlobalFVGeometry); + + //! The actual implementation might overwrite the update() routine + friend Implementation; + //! The local class needs access to the problem + friend typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using MpfaHelper = typename GET_PROP_TYPE(TypeTag, MpfaHelper); + using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); + using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using GlobalInteractionVolumeSeeds = typename GET_PROP_TYPE(TypeTag, GlobalInteractionVolumeSeeds); + using BoundaryInteractionVolume = typename GET_PROP_TYPE(TypeTag, BoundaryInteractionVolume); + using InteractionVolume = typename GET_PROP_TYPE(TypeTag, InteractionVolume); + using InteractionVolumeSeed = typename InteractionVolume::Seed; + using BoundaryInteractionVolumeSeed = typename BoundaryInteractionVolume::Seed; + using Element = typename GridView::template Codim<0>::Entity; + + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using CoordScalar = typename GridView::ctype; + using IndexType = typename GridView::IndexSet::IndexType; + using LocalIndexType = typename InteractionVolume::LocalIndexType; + + static constexpr int dim = GridView::dimension; + static constexpr int dimWorld = GridView::dimensionworld; + using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; + using ReferenceElements = typename Dune::ReferenceElements<CoordScalar, dim>; + + static constexpr bool enableInteriorBoundaries = GET_PROP_VALUE(TypeTag, EnableInteriorBoundaries); + +public: + //! Constructor + CCMpfaGlobalFVGeometry(const GridView gridView) + : gridView_(gridView), elementMap_(gridView), globalInteractionVolumeSeeds_(gridView) {} + + //! The total number of sub control volumes + std::size_t numScv() const + { return scvs_.size(); } + + //! The total number of sub control volume faces + std::size_t numScvf() const + { return scvfs_.size(); } + + //! The total number of scvfs on the domain boundaries + std::size_t numDomainBoundaryScvf() const + { return numDomainBoundaryScvf_; } + + //! The total number of scvfs on the interior boundaries + std::size_t numInteriorBoundaryScvf() const + { return numInteriorBoundaryScvf_; } + + //! The total number of scvfs connected to branching points + std::size_t numBranchingPointScvf() const + { return numBranchingPointScvf_; } + + //! The total number of vertices connected to branching points + std::size_t numBranchingPointVertices() const + { return numBranchingPointVertices_; } + + //! The total number of vertices on interior and domain boundaries + std::size_t numInteriorOrDomainBoundaryVertices() const + { return numInteriorOrDomainBoundaryVertices_; } + + // Get an element from a sub control volume contained in it + Element element(const SubControlVolume& scv) const + { return elementMap_.element(scv.elementIndex()); } + + // Get an element from a global element index + Element element(IndexType eIdx) const + { return elementMap_.element(eIdx); } + + //! Get the inner interaction volume seed corresponding to an scvf + const InteractionVolumeSeed& interactionVolumeSeed(const SubControlVolumeFace& scvf) const + { return globalInteractionVolumeSeeds_.seed(scvf); } + + //! Get the boundary interaction volume seed corresponding to an scvf + const BoundaryInteractionVolumeSeed& boundaryInteractionVolumeSeed(const SubControlVolumeFace& scvf) const + { return globalInteractionVolumeSeeds_.boundarySeed(scvf); } + + //! Returns whether or not an scvf is on an interior boundary + bool isOnInteriorBoundary(const SubControlVolumeFace& scvf) const + { return enableInteriorBoundaries ? interiorBoundaryScvfs_[scvf.index()] : false; } + + //! Returns whether or not an scvf touches the domain boundary + bool touchesDomainBoundary(const SubControlVolumeFace& scvf) const + { return domainBoundaryVertices_[scvf.vertexIndex()]; } + + //! Returns whether or not an scvf touches the domain boundary + bool touchesInteriorBoundary(const SubControlVolumeFace& scvf) const + { return enableInteriorBoundaries ? interiorBoundaryVertices_[scvf.vertexIndex()] : false; } + + //! Returns whether or not an scvf belongs to a boundary interaction volume + bool isInBoundaryInteractionVolume(const SubControlVolumeFace& scvf) const + { return touchesDomainBoundary(scvf) || touchesInteriorBoundary(scvf) || touchesBranchingPoint(scvf); } + + //! Returns whether or not an scvf touches a branching point (for dim < dimWorld) + bool touchesBranchingPoint(const SubControlVolumeFace& scvf) const + { return dim == dimWorld ? false : branchingVertices_[scvf.vertexIndex()]; } + + //! update all fvElementGeometries (do this again after grid adaption) + void update(const Problem& problem) + { + problemPtr_ = &problem; + + // resize containers + const auto numVert = gridView_.size(dim); + const auto numScvs = gridView_.size(0); + const auto numScvfs = MpfaHelper::getGlobalNumScvf(gridView_); + + scvs_.resize(numScvs); + scvfs_.reserve(numScvfs); + scvfIndicesOfScv_.resize(numScvs); + elementMap_.resize(numScvs); + + // Keep track of domain (and mabybe interior) boundaries + domainBoundaryVertices_.resize(numVert, false); + std::vector<bool> interiorOrDomainBoundaryVertices(numVert, false); + if (enableInteriorBoundaries) + { + interiorBoundaryVertices_.resize(numVert, false); + interiorBoundaryScvfs_.resize(numScvfs, false); + } + + // Maybe keep track of branching points + if (dim < dimWorld) + branchingVertices_.resize(gridView_.size(dim), false); + + // find vertices on processor boundaries + const auto isGhostVertex = MpfaHelper::findGhostVertices(problem, gridView_); + + // the quadrature point to be used on the scvfs + static const Scalar q = GET_PARAM_FROM_GROUP(TypeTag, Scalar, Mpfa, Q); + + // Build the SCVs and SCV faces + IndexType scvfIdx = 0; + numDomainBoundaryScvf_ = 0; + numInteriorBoundaryScvf_ = 0; + numBranchingPointScvf_ = 0; + numBranchingPointVertices_ = 0; + numInteriorOrDomainBoundaryVertices_ = 0; + for (const auto& element : elements(gridView_)) + { + const auto eIdx = problem.elementMapper().index(element); + + // the element geometry + auto elementGeometry = element.geometry(); + + // fill the element map with seeds + elementMap_[eIdx] = element.seed(); + + // The local scvf index set + std::vector<IndexType> scvfIndexSet; + scvfIndexSet.reserve(MpfaHelper::getNumLocalScvfs(elementGeometry.type())); + + // for network grids there might be multiple intersection with the same geometryInInside + // we indentify those by the indexInInside for now (assumes conforming grids at branching facets) + std::vector<std::vector<IndexType>> outsideIndices; + if (dim < dimWorld) + { + outsideIndices.resize(element.subEntities(1)); + for (const auto& intersection : intersections(gridView_, element)) + { + if (intersection.neighbor()) + { + const auto& outside = intersection.outside(); + auto nIdx = problem.elementMapper().index(outside); + outsideIndices[intersection.indexInInside()].push_back(nIdx); + } + } + } + + // construct the sub control volume faces + for (const auto& is : intersections(gridView_, element)) + { + const auto indexInInside = is.indexInInside(); + const bool boundary = is.boundary(); + const bool neighbor = is.neighbor(); + const bool interiorBoundary = enableInteriorBoundaries ? problem.isInteriorBoundary(element, is) : false; + + // for network grids, skip the rest if handled already + if (dim < dimWorld && neighbor && outsideIndices[indexInInside].empty()) + continue; + + // determine the outside volvar indices + const std::vector<IndexType> nIndices = neighbor && dim == dimWorld ? + std::vector<IndexType>({problem.elementMapper().index(is.outside())}) : + std::vector<IndexType>(); + + // get the intersection corners according to generic numbering + const auto numCorners = is.geometry().corners(); + std::vector<GlobalPosition> isCorners(numCorners); + + // if outside level > inside level, use the outside element in the following + const bool useNeighbor = neighbor && is.outside().level() > element.level(); + const auto& e = useNeighbor ? is.outside() : element; + const auto indexInElement = useNeighbor ? is.indexInOutside() : indexInInside; + const auto eg = e.geometry(); + const auto& refElement = ReferenceElements::general(eg.type()); + + for (unsigned int c = 0; c < numCorners; ++c) + isCorners[c] = eg.global(refElement.position(refElement.subEntity(indexInElement, 1, c, dim), dim)); + + // make the scv faces belonging to each corner of the intersection + for (unsigned int c = 0; c < numCorners; ++c) + { + // get the global vertex index the scv face is connected to + const auto vIdxLocal = refElement.subEntity(indexInElement, 1, c, dim); + const auto vIdxGlobal = problem.vertexMapper().subIndex(e, vIdxLocal, dim); + + // do not build scvfs connected to a processor boundary + if (isGhostVertex[vIdxGlobal]) + continue; + + // is vertex on a branching point? + if (dim < dimWorld && outsideIndices[indexInInside].size() > 1) + { + if (!branchingVertices_[vIdxGlobal]) + numBranchingPointVertices_++; + branchingVertices_[vIdxGlobal] = true; + numBranchingPointScvf_++; + } + + // make the scv face (for non-boundary scvfs on network grids, use precalculated outside indices) + if (!boundary) + { + const auto& outsideScvIndices = dim == dimWorld ? nIndices : outsideIndices[indexInInside]; + scvfIndexSet.push_back(scvfIdx); + scvfs_.emplace_back(MpfaHelper(), + MpfaHelper::getScvfCorners(isCorners, c), + is.centerUnitOuterNormal(), + vIdxGlobal, + vIdxLocal, + scvfIdx, + eIdx, + outsideScvIndices, + q, + boundary + ); + } + else + { + const std::vector<IndexType> boundaryIdx = [&] () + { + IndexType bIdx = numScvs + numDomainBoundaryScvf_++; + return std::vector<IndexType>({bIdx}); + } (); + scvfIndexSet.push_back(scvfIdx); + scvfs_.emplace_back(MpfaHelper(), + MpfaHelper::getScvfCorners(isCorners, c), + is.centerUnitOuterNormal(), + vIdxGlobal, + vIdxLocal, + scvfIdx, + eIdx, + boundaryIdx, + q, + boundary + ); + } + + // if a new interior or domain boundary has been found, increase counter + if ((boundary || interiorBoundary) && !interiorOrDomainBoundaryVertices[vIdxGlobal]) + { + interiorOrDomainBoundaryVertices[vIdxGlobal] = true; + numInteriorOrDomainBoundaryVertices_++; + } + + // store info on which vertices are on the domain/interior boundary + if (boundary) + domainBoundaryVertices_[vIdxGlobal] = true; + if (enableInteriorBoundaries && interiorBoundary) + { + interiorBoundaryVertices_[vIdxGlobal] = true; + interiorBoundaryScvfs_[scvfIdx] = true; + numInteriorBoundaryScvf_++; + } + + // increment scvf counter + scvfIdx++; + } + + // for network grids, clear outside indices to not make a second scvf on that facet + if (dim < dimWorld) + outsideIndices[indexInInside].clear(); + } + + // create sub control volume for this element + scvs_[eIdx] = SubControlVolume(std::move(elementGeometry), eIdx); + + // Save the scvf indices belonging to this scv to build up fv element geometries fast + scvfIndicesOfScv_[eIdx] = scvfIndexSet; + } + + // Make the flip index set for network and surface grids + if (dim < dimWorld) + { + flipScvfIndices_.resize(scvfs_.size()); + for (auto&& scvf : scvfs_) + { + if (scvf.boundary()) + continue; + + const auto numOutsideScvs = scvf.numOutsideScvs(); + const auto vIdxGlobal = scvf.vertexIndex(); + const auto insideScvIdx = scvf.insideScvIdx(); + + flipScvfIndices_[scvf.index()].resize(numOutsideScvs); + for (unsigned int i = 0; i < numOutsideScvs; ++i) + { + const auto outsideScvIdx = scvf.outsideScvIdx(i); + for (auto outsideScvfIndex : scvfIndicesOfScv_[outsideScvIdx]) + { + const auto& outsideScvf = this->scvf(outsideScvfIndex); + if (outsideScvf.vertexIndex() == vIdxGlobal && + MpfaHelper::contains(outsideScvf.outsideScvIndices(), insideScvIdx)) + { + flipScvfIndices_[scvf.index()][i] = outsideScvfIndex; + // there is always only one flip face in an outside element + break; + } + } + + } + } + } + + // make sure we found as many scvfs as previously estimated + assert(scvfIdx == numScvfs); + + // Initialize the interaction volume seeds + globalInteractionVolumeSeeds_.update(problem, interiorOrDomainBoundaryVertices); + } + + /*! + * \brief Return a local restriction of this global object + * The local object is only functional after calling its bind/bindElement method + * This is a free function that will be found by means of ADL + */ + friend inline FVElementGeometry localView(const Implementation& global) + { return FVElementGeometry(global); } + + //! Get a sub control volume with a global scv index + const SubControlVolume& scv(IndexType scvIdx) const + { return scvs_[scvIdx]; } + + //! Get a sub control volume face with a global scvf index + const SubControlVolumeFace& scvf(IndexType scvfIdx) const + { return scvfs_[scvfIdx]; } + + const SubControlVolumeFace& flipScvf(IndexType scvfIdx, unsigned int outsideScvfIdx = 0) const + { return scvfs_[flipScvfIndices_[scvfIdx][outsideScvfIdx]]; } + + //! Get the sub control volume face indices of an scv by global index + const std::vector<IndexType>& scvfIndicesOfScv(IndexType scvIdx) const + { return scvfIndicesOfScv_[scvIdx]; } + + //! Return a const reference to the grid view + const GridView& gridView() const + { return gridView_; } -// further specializations of this class for the available methods have to be included here +private: + + const Problem& problem_() const + { return *problemPtr_; } + + const Problem* problemPtr_; + GridView gridView_; + + // vectors that store the geometries + Dumux::ElementMap<GridView> elementMap_; + std::vector<SubControlVolume> scvs_; + std::vector<SubControlVolumeFace> scvfs_; + + // vectors that store the global data + std::vector<std::vector<IndexType>> scvfIndicesOfScv_; + std::vector<bool> domainBoundaryVertices_; + std::vector<bool> interiorBoundaryScvfs_; + std::vector<bool> interiorBoundaryVertices_; + std::vector<bool> branchingVertices_; + std::size_t numInteriorOrDomainBoundaryVertices_; + std::size_t numDomainBoundaryScvf_; + std::size_t numInteriorBoundaryScvf_; + std::size_t numBranchingPointScvf_; + std::size_t numBranchingPointVertices_; + // needed for embedded surface and network grids (dim < dimWorld) + std::vector<std::vector<IndexType>> flipScvfIndices_; + + // the global interaction volume seeds + GlobalInteractionVolumeSeeds globalInteractionVolumeSeeds_; +}; + +// specialization in case the FVElementGeometries are not stored +template<class TypeTag> +class CCMpfaGlobalFVGeometry<TypeTag, false> +{ + //! The local fvGeometry needs access to the problem + friend typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + + using Implementation = typename GET_PROP_TYPE(TypeTag, GlobalFVGeometry); + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using MpfaHelper = typename GET_PROP_TYPE(TypeTag, MpfaHelper); + using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); + using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using GlobalInteractionVolumeSeeds = typename GET_PROP_TYPE(TypeTag, GlobalInteractionVolumeSeeds); + using BoundaryInteractionVolume = typename GET_PROP_TYPE(TypeTag, BoundaryInteractionVolume); + using InteractionVolume = typename GET_PROP_TYPE(TypeTag, InteractionVolume); + using InteractionVolumeSeed = typename InteractionVolume::Seed; + using BoundaryInteractionVolumeSeed = typename BoundaryInteractionVolume::Seed; + using Element = typename GridView::template Codim<0>::Entity; + + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using CoordScalar = typename GridView::ctype; + using IndexType = typename GridView::IndexSet::IndexType; + using LocalIndexType = typename InteractionVolume::LocalIndexType; + + static constexpr int dim = GridView::dimension; + static constexpr int dimWorld = GridView::dimensionworld; + + using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; + using ReferenceElements = typename Dune::ReferenceElements<CoordScalar, dim>; + + static constexpr bool enableInteriorBoundaries = GET_PROP_VALUE(TypeTag, EnableInteriorBoundaries); + +public: + //! Constructor + CCMpfaGlobalFVGeometry(const GridView gridView) + : gridView_(gridView), elementMap_(gridView), globalInteractionVolumeSeeds_(gridView_) {} + + //! The total number of sub control volumes + std::size_t numScv() const + { return numScvs_; } + + //! The total number of sub control volume faces + std::size_t numScvf() const + { return numScvf_; } + + //! The total number of scvfs on the interior boundaries + std::size_t numDomainBoundaryScvf() const + { return numDomainBoundaryScvf_; } + + //! The total number of scvfs on the interior boundaries + std::size_t numInteriorBoundaryScvf() const + { return numInteriorBoundaryScvf_; } + + //! The total number of scvfs connected to branching points + std::size_t numBranchingPointScvf() const + { return numBranchingPointScvf_; } + + //! The total number of vertices connected to branching points + std::size_t numBranchingPointVertices() const + { return numBranchingPointVertices_; } + + //! The total number of vertices on the boundary + std::size_t numInteriorOrDomainBoundaryVertices() const + { return numInteriorOrDomainBoundaryVertices_; } + + // Get an element from a sub control volume contained in it + Element element(const SubControlVolume& scv) const + { return elementMap_.element(scv.elementIndex()); } + + // Get an element from a global element index + Element element(IndexType eIdx) const + { return elementMap_.element(eIdx); } + + //! Return the gridView this global object lives on + const GridView& gridView() const + { return gridView_; } + + //! Get the inner interaction volume seed corresponding to an scvf + const InteractionVolumeSeed& interactionVolumeSeed(const SubControlVolumeFace& scvf) const + { return globalInteractionVolumeSeeds_.seed(scvf); } + + //! Get the boundary interaction volume seed corresponding to an scvf + const BoundaryInteractionVolumeSeed& boundaryInteractionVolumeSeed(const SubControlVolumeFace& scvf) const + { return globalInteractionVolumeSeeds_.boundarySeed(scvf); } + + //! Returns whether or not an scvf is on an interior boundary + bool isOnInteriorBoundary(const SubControlVolumeFace& scvf) const + { return enableInteriorBoundaries ? interiorBoundaryScvfs_[scvf.index()] : false; } + + //! Returns whether or not an scvf touches the domain boundary + bool touchesDomainBoundary(const SubControlVolumeFace& scvf) const + { return domainBoundaryVertices_[scvf.vertexIndex()]; } + + //! Returns whether or not an scvf touches the domain boundary + bool touchesInteriorBoundary(const SubControlVolumeFace& scvf) const + { return enableInteriorBoundaries ? interiorBoundaryVertices_[scvf.vertexIndex()] : false; } + + //! Returns whether or not an scvf belongs to a boundary interaction volume + bool isInBoundaryInteractionVolume(const SubControlVolumeFace& scvf) const + { return touchesDomainBoundary(scvf) || touchesInteriorBoundary(scvf) || touchesBranchingPoint(scvf); } + + //! Returns whether or not a vertex is on a processor boundary + bool isGhostVertex(const IndexType vIdxGlobal) const + { return ghostVertices_[vIdxGlobal]; } + + //! Returns whether or not an scvf touches a branching point (for dim < dimWorld) + bool touchesBranchingPoint(const SubControlVolumeFace& scvf) const + { return dim < dimWorld ? branchingVertices_[scvf.vertexIndex()] : false; } + + //! update all fvElementGeometries (do this again after grid adaption) + void update(const Problem& problem) + { + problemPtr_ = &problem; + + // resize the containers + const auto numScvfs = MpfaHelper::getGlobalNumScvf(gridView_); + const auto numVert = gridView_.size(dim); + numScvs_ = gridView_.size(0); + + elementMap_.resize(numScvs_); + scvfIndicesOfScv_.resize(numScvs_); + neighborVolVarIndices_.resize(numScvs_); + + // keep track of the domain (and maybe interior) boundaries + domainBoundaryVertices_.resize(numVert, false); + std::vector<bool> interiorOrDomainBoundaryVertices(numVert, false); + if (enableInteriorBoundaries) + { + interiorBoundaryScvfs_.resize(numScvfs, false); + interiorBoundaryVertices_.resize(numVert, false); + } + + // keep track of branching points + if (dim < dimWorld) + branchingVertices_.resize(gridView_.size(dim), false); + + // find vertices on processor boundaries + ghostVertices_ = MpfaHelper::findGhostVertices(problem, gridView_); + + // Store necessary info on SCVs and SCV faces + // reset counters for the tracking of the indices + numScvf_ = 0; + numDomainBoundaryScvf_ = 0; + numInteriorBoundaryScvf_ = 0; + numBranchingPointScvf_ = 0; + numBranchingPointVertices_ = 0; + numInteriorOrDomainBoundaryVertices_ = 0; + for (const auto& element : elements(gridView_)) + { + const auto eIdx = problem.elementMapper().index(element); + + // fill the element map with seeds + elementMap_[eIdx] = element.seed(); + + // the element geometry and reference element + auto eg = element.geometry(); + + // the element-wise index sets for finite volume geometry + const auto numLocalFaces = MpfaHelper::getNumLocalScvfs(eg.type()); + std::vector<IndexType> scvfsIndexSet; + std::vector< std::vector<IndexType> > neighborVolVarIndexSet; + scvfsIndexSet.reserve(numLocalFaces); + neighborVolVarIndexSet.reserve(numLocalFaces); + + // for network grids there might be multiple intersection with the same geometryInInside + // we indentify those by the indexInInside for now (assumes conforming grids at branching facets) + std::vector<std::vector<IndexType>> outsideIndices; + if (dim < dimWorld) + { + outsideIndices.resize(element.subEntities(1)); + for (const auto& intersection : intersections(gridView_, element)) + { + if (intersection.neighbor()) + { + const auto& outside = intersection.outside(); + auto nIdx = problem.elementMapper().index(outside); + outsideIndices[intersection.indexInInside()].push_back(nIdx); + } + } + } + + unsigned int localFaceIdx = 0; + // construct the sub control volume faces + for (const auto& is : intersections(gridView_, element)) + { + const auto indexInInside = is.indexInInside(); + const bool boundary = is.boundary(); + const bool neighbor = is.neighbor(); + const bool interiorBoundary = enableInteriorBoundaries ? problem.isInteriorBoundary(element, is) : false; + + // for network grids, skip the rest if handled already + if (dim < dimWorld && neighbor && outsideIndices[indexInInside].empty()) + continue; + + // determine the outside volvar indices + const std::vector<IndexType> nIndices = neighbor && dim == dimWorld ? + std::vector<IndexType>({problem.elementMapper().index(is.outside())}) : + std::vector<IndexType>(); + + // if outside level > inside level, use the outside element in the following + const bool useNeighbor = neighbor && is.outside().level() > element.level(); + const auto& e = useNeighbor ? is.outside() : element; + const auto indexInElement = useNeighbor ? is.indexInOutside() : indexInInside; + const auto eg = e.geometry(); + const auto& refElement = ReferenceElements::general(eg.type()); + + // make the scv faces of the intersection + for (unsigned int c = 0; c < is.geometry().corners(); ++c) + { + // get the global vertex index the scv face is connected to (mpfa-o method does not work for hanging nodes!) + const auto vIdxLocal = refElement.subEntity(indexInElement, 1, c, dim); + const auto vIdxGlobal = problem.vertexMapper().subIndex(e, vIdxLocal, dim); + + // do not build scvfs connected to a processor boundary + if (ghostVertices_[vIdxGlobal]) + continue; + + // is vertex on a branching point? + if (dim < dimWorld && outsideIndices[indexInInside].size() > 1) + { + if (!branchingVertices_[vIdxGlobal]) + numBranchingPointVertices_++; + branchingVertices_[vIdxGlobal] = true; + numBranchingPointScvf_++; + } + + // store information on the scv face (for inner scvfs on network grids use precalculated outside indices) + if (!boundary) + { + const auto& outsideScvIndices = dim == dimWorld ? nIndices : outsideIndices[indexInInside]; + scvfsIndexSet.push_back(numScvf_++); + neighborVolVarIndexSet.push_back(outsideScvIndices); + } + else + { + const std::vector<IndexType> boundaryIdx = [&] () + { + IndexType bIdx = numScvs_ + numDomainBoundaryScvf_++; + return std::vector<IndexType>({bIdx}); + } (); + scvfsIndexSet.push_back(numScvf_++); + neighborVolVarIndexSet.push_back(boundaryIdx); + } + + // if a new interior or domain boundary has been found, increase counter + if ((boundary || interiorBoundary) && !interiorOrDomainBoundaryVertices[vIdxGlobal]) + { + interiorOrDomainBoundaryVertices[vIdxGlobal] = true; + numInteriorOrDomainBoundaryVertices_++; + } + + // store info on which vertices are on the domain/interior boundary + if (boundary) + domainBoundaryVertices_[vIdxGlobal] = true; + if (enableInteriorBoundaries && interiorBoundary) + { + interiorBoundaryVertices_[vIdxGlobal] = true; + interiorBoundaryScvfs_[numScvf_-1] = true; + numInteriorBoundaryScvf_++; + } + + // increment counter + localFaceIdx++; + } + + // for network grids, clear outside indices to not make a second scvf on that facet + if (dim < dimWorld) + outsideIndices[indexInInside].clear(); + } + + // store the sets of indices in the data container + scvfIndicesOfScv_[eIdx] = scvfsIndexSet; + neighborVolVarIndices_[eIdx] = neighborVolVarIndexSet; + } + + // make sure we found as many scvfs as previously estimated + assert(numScvf_ == numScvfs); + + // Initialize the interaction volume seeds + globalInteractionVolumeSeeds_.update(problem, interiorOrDomainBoundaryVertices); + } + + const std::vector<IndexType>& scvfIndicesOfScv(IndexType scvIdx) const + { return scvfIndicesOfScv_[scvIdx]; } + + const std::vector< std::vector<IndexType> >& neighborVolVarIndices(IndexType scvIdx) const + { return neighborVolVarIndices_[scvIdx]; } + + /*! + * \brief Return a local restriction of this global object + * The local object is only functional after calling its bind/bindElement method + * This is a free function that will be found by means of ADL + */ + friend inline FVElementGeometry localView(const Implementation& global) + { return FVElementGeometry(global); } + +private: + + const Problem& problem_() const + { return *problemPtr_; } + + const Problem* problemPtr_; + + GridView gridView_; + + // Information on the global number of geometries + std::size_t numScvs_; + std::size_t numScvf_; + std::size_t numDomainBoundaryScvf_; + std::size_t numInteriorBoundaryScvf_; + std::size_t numBranchingPointScvf_; + std::size_t numBranchingPointVertices_; + std::size_t numInteriorOrDomainBoundaryVertices_; + + // vectors that store the global data + Dumux::ElementMap<GridView> elementMap_; + std::vector<std::vector<IndexType>> scvfIndicesOfScv_; + std::vector< std::vector< std::vector<IndexType> > > neighborVolVarIndices_; + std::vector<bool> domainBoundaryVertices_; + std::vector<bool> interiorBoundaryScvfs_; + std::vector<bool> interiorBoundaryVertices_; + std::vector<bool> ghostVertices_; + std::vector<bool> branchingVertices_; + + // the global interaction volume seeds + GlobalInteractionVolumeSeeds globalInteractionVolumeSeeds_; +}; + +} // end namespace #endif diff --git a/dumux/discretization/cellcentered/mpfa/globalfvgeometrybase.hh b/dumux/discretization/cellcentered/mpfa/globalfvgeometrybase.hh deleted file mode 100644 index 6d2a1195004eda87b4d02d347e343ad00f80d70e..0000000000000000000000000000000000000000 --- a/dumux/discretization/cellcentered/mpfa/globalfvgeometrybase.hh +++ /dev/null @@ -1,775 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \brief Base class for the finite volume geometry vector for mpfa models - * This builds up the sub control volumes and sub control volume faces - * for each element. - */ -#ifndef DUMUX_DISCRETIZATION_CC_MPFA_GLOBALFVGEOMETRY_BASE_HH -#define DUMUX_DISCRETIZATION_CC_MPFA_GLOBALFVGEOMETRY_BASE_HH - -#include <dune/geometry/multilineargeometry.hh> -#include <dune/geometry/referenceelements.hh> - -#include <dumux/implicit/cellcentered/mpfa/properties.hh> -#include <dumux/common/elementmap.hh> - -namespace Dumux -{ -/*! - * \ingroup ImplicitModel - * \brief Base class for the finite volume geometry vector for mpfa models - * This builds up the sub control volumes and sub control volume faces - * for each element. - */ -template<class TypeTag, bool EnableFVElementGeometryCache> -class CCMpfaGlobalFVGeometryBase -{}; - -// specialization in case the FVElementGeometries are stored -template<class TypeTag> -class CCMpfaGlobalFVGeometryBase<TypeTag, true> -{ - using Implementation = typename GET_PROP_TYPE(TypeTag, GlobalFVGeometry); - - //! The actual implementation might overwrite the update() routine - friend Implementation; - //! The local class needs access to the problem - friend typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using MpfaHelper = typename GET_PROP_TYPE(TypeTag, MpfaHelper); - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using GlobalInteractionVolumeSeeds = typename GET_PROP_TYPE(TypeTag, GlobalInteractionVolumeSeeds); - using BoundaryInteractionVolume = typename GET_PROP_TYPE(TypeTag, BoundaryInteractionVolume); - using InteractionVolume = typename GET_PROP_TYPE(TypeTag, InteractionVolume); - using InteractionVolumeSeed = typename InteractionVolume::Seed; - using BoundaryInteractionVolumeSeed = typename BoundaryInteractionVolume::Seed; - using Element = typename GridView::template Codim<0>::Entity; - - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using CoordScalar = typename GridView::ctype; - using IndexType = typename GridView::IndexSet::IndexType; - using LocalIndexType = typename InteractionVolume::LocalIndexType; - - static constexpr int dim = GridView::dimension; - static constexpr int dimWorld = GridView::dimensionworld; - using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; - using ReferenceElements = typename Dune::ReferenceElements<CoordScalar, dim>; - - static constexpr bool enableInteriorBoundaries = GET_PROP_VALUE(TypeTag, EnableInteriorBoundaries); - -public: - //! Constructor - CCMpfaGlobalFVGeometryBase(const GridView gridView) - : gridView_(gridView), elementMap_(gridView), globalInteractionVolumeSeeds_(gridView) {} - - //! The total number of sub control volumes - std::size_t numScv() const - { return scvs_.size(); } - - //! The total number of sub control volume faces - std::size_t numScvf() const - { return scvfs_.size(); } - - //! The total number of scvfs on the domain boundaries - std::size_t numDomainBoundaryScvf() const - { return numDomainBoundaryScvf_; } - - //! The total number of scvfs on the interior boundaries - std::size_t numInteriorBoundaryScvf() const - { return numInteriorBoundaryScvf_; } - - //! The total number of scvfs connected to branching points - std::size_t numBranchingPointScvf() const - { return numBranchingPointScvf_; } - - //! The total number of vertices connected to branching points - std::size_t numBranchingPointVertices() const - { return numBranchingPointVertices_; } - - //! The total number of vertices on interior and domain boundaries - std::size_t numInteriorOrDomainBoundaryVertices() const - { return numInteriorOrDomainBoundaryVertices_; } - - // Get an element from a sub control volume contained in it - Element element(const SubControlVolume& scv) const - { return elementMap_.element(scv.elementIndex()); } - - // Get an element from a global element index - Element element(IndexType eIdx) const - { return elementMap_.element(eIdx); } - - //! Get the inner interaction volume seed corresponding to an scvf - const InteractionVolumeSeed& interactionVolumeSeed(const SubControlVolumeFace& scvf) const - { return globalInteractionVolumeSeeds_.seed(scvf); } - - //! Get the boundary interaction volume seed corresponding to an scvf - const BoundaryInteractionVolumeSeed& boundaryInteractionVolumeSeed(const SubControlVolumeFace& scvf) const - { return globalInteractionVolumeSeeds_.boundarySeed(scvf); } - - //! Returns whether or not an scvf is on an interior boundary - bool isOnInteriorBoundary(const SubControlVolumeFace& scvf) const - { return enableInteriorBoundaries ? interiorBoundaryScvfs_[scvf.index()] : false; } - - //! Returns whether or not an scvf touches the domain boundary - bool touchesDomainBoundary(const SubControlVolumeFace& scvf) const - { return domainBoundaryVertices_[scvf.vertexIndex()]; } - - //! Returns whether or not an scvf touches the domain boundary - bool touchesInteriorBoundary(const SubControlVolumeFace& scvf) const - { return enableInteriorBoundaries ? interiorBoundaryVertices_[scvf.vertexIndex()] : false; } - - //! Returns whether or not an scvf belongs to a boundary interaction volume - bool isInBoundaryInteractionVolume(const SubControlVolumeFace& scvf) const - { return touchesDomainBoundary(scvf) || touchesInteriorBoundary(scvf) || touchesBranchingPoint(scvf); } - - //! Returns whether or not an scvf touches a branching point (for dim < dimWorld) - bool touchesBranchingPoint(const SubControlVolumeFace& scvf) const - { return dim == dimWorld ? false : branchingVertices_[scvf.vertexIndex()]; } - - //! update all fvElementGeometries (do this again after grid adaption) - void update(const Problem& problem) - { - problemPtr_ = &problem; - - // resize containers - const auto numVert = gridView_.size(dim); - const auto numScvs = gridView_.size(0); - const auto numScvfs = MpfaHelper::getGlobalNumScvf(gridView_); - - scvs_.resize(numScvs); - scvfs_.reserve(numScvfs); - scvfIndicesOfScv_.resize(numScvs); - elementMap_.resize(numScvs); - - // Keep track of domain (and mabybe interior) boundaries - domainBoundaryVertices_.resize(numVert, false); - std::vector<bool> interiorOrDomainBoundaryVertices(numVert, false); - if (enableInteriorBoundaries) - { - interiorBoundaryVertices_.resize(numVert, false); - interiorBoundaryScvfs_.resize(numScvfs, false); - } - - // Maybe keep track of branching points - if (dim < dimWorld) - branchingVertices_.resize(gridView_.size(dim), false); - - // find vertices on processor boundaries - const auto isGhostVertex = MpfaHelper::findGhostVertices(problem, gridView_); - - // the quadrature point to be used on the scvfs - static const Scalar q = GET_PARAM_FROM_GROUP(TypeTag, Scalar, Mpfa, Q); - - // Build the SCVs and SCV faces - IndexType scvfIdx = 0; - numDomainBoundaryScvf_ = 0; - numInteriorBoundaryScvf_ = 0; - numBranchingPointScvf_ = 0; - numBranchingPointVertices_ = 0; - numInteriorOrDomainBoundaryVertices_ = 0; - for (const auto& element : elements(gridView_)) - { - const auto eIdx = problem.elementMapper().index(element); - - // the element geometry - auto elementGeometry = element.geometry(); - - // fill the element map with seeds - elementMap_[eIdx] = element.seed(); - - // The local scvf index set - std::vector<IndexType> scvfIndexSet; - scvfIndexSet.reserve(MpfaHelper::getNumLocalScvfs(elementGeometry.type())); - - // for network grids there might be multiple intersection with the same geometryInInside - // we indentify those by the indexInInside for now (assumes conforming grids at branching facets) - std::vector<std::vector<IndexType>> outsideIndices; - if (dim < dimWorld) - { - outsideIndices.resize(element.subEntities(1)); - for (const auto& intersection : intersections(gridView_, element)) - { - if (intersection.neighbor()) - { - const auto& outside = intersection.outside(); - auto nIdx = problem.elementMapper().index(outside); - outsideIndices[intersection.indexInInside()].push_back(nIdx); - } - } - } - - // construct the sub control volume faces - for (const auto& is : intersections(gridView_, element)) - { - const auto indexInInside = is.indexInInside(); - const bool boundary = is.boundary(); - const bool neighbor = is.neighbor(); - const bool interiorBoundary = enableInteriorBoundaries ? problem.isInteriorBoundary(element, is) : false; - - // for network grids, skip the rest if handled already - if (dim < dimWorld && neighbor && outsideIndices[indexInInside].empty()) - continue; - - // determine the outside volvar indices - const std::vector<IndexType> nIndices = neighbor && dim == dimWorld ? - std::vector<IndexType>({problem.elementMapper().index(is.outside())}) : - std::vector<IndexType>(); - - // get the intersection corners according to generic numbering - const auto numCorners = is.geometry().corners(); - std::vector<GlobalPosition> isCorners(numCorners); - - // if outside level > inside level, use the outside element in the following - const bool useNeighbor = neighbor && is.outside().level() > element.level(); - const auto& e = useNeighbor ? is.outside() : element; - const auto indexInElement = useNeighbor ? is.indexInOutside() : indexInInside; - const auto eg = e.geometry(); - const auto& refElement = ReferenceElements::general(eg.type()); - - for (unsigned int c = 0; c < numCorners; ++c) - isCorners[c] = eg.global(refElement.position(refElement.subEntity(indexInElement, 1, c, dim), dim)); - - // make the scv faces belonging to each corner of the intersection - for (unsigned int c = 0; c < numCorners; ++c) - { - // get the global vertex index the scv face is connected to - const auto vIdxLocal = refElement.subEntity(indexInElement, 1, c, dim); - const auto vIdxGlobal = problem.vertexMapper().subIndex(e, vIdxLocal, dim); - - // do not build scvfs connected to a processor boundary - if (isGhostVertex[vIdxGlobal]) - continue; - - // is vertex on a branching point? - if (dim < dimWorld && outsideIndices[indexInInside].size() > 1) - { - if (!branchingVertices_[vIdxGlobal]) - numBranchingPointVertices_++; - branchingVertices_[vIdxGlobal] = true; - numBranchingPointScvf_++; - } - - // make the scv face (for non-boundary scvfs on network grids, use precalculated outside indices) - if (!boundary) - { - const auto& outsideScvIndices = dim == dimWorld ? nIndices : outsideIndices[indexInInside]; - scvfIndexSet.push_back(scvfIdx); - scvfs_.emplace_back(MpfaHelper(), - MpfaHelper::getScvfCorners(isCorners, c), - is.centerUnitOuterNormal(), - vIdxGlobal, - vIdxLocal, - scvfIdx, - eIdx, - outsideScvIndices, - q, - boundary - ); - } - else - { - const std::vector<IndexType> boundaryIdx = [&] () - { - IndexType bIdx = numScvs + numDomainBoundaryScvf_++; - return std::vector<IndexType>({bIdx}); - } (); - scvfIndexSet.push_back(scvfIdx); - scvfs_.emplace_back(MpfaHelper(), - MpfaHelper::getScvfCorners(isCorners, c), - is.centerUnitOuterNormal(), - vIdxGlobal, - vIdxLocal, - scvfIdx, - eIdx, - boundaryIdx, - q, - boundary - ); - } - - // if a new interior or domain boundary has been found, increase counter - if ((boundary || interiorBoundary) && !interiorOrDomainBoundaryVertices[vIdxGlobal]) - { - interiorOrDomainBoundaryVertices[vIdxGlobal] = true; - numInteriorOrDomainBoundaryVertices_++; - } - - // store info on which vertices are on the domain/interior boundary - if (boundary) - domainBoundaryVertices_[vIdxGlobal] = true; - if (enableInteriorBoundaries && interiorBoundary) - { - interiorBoundaryVertices_[vIdxGlobal] = true; - interiorBoundaryScvfs_[scvfIdx] = true; - numInteriorBoundaryScvf_++; - } - - // increment scvf counter - scvfIdx++; - } - - // for network grids, clear outside indices to not make a second scvf on that facet - if (dim < dimWorld) - outsideIndices[indexInInside].clear(); - } - - // create sub control volume for this element - scvs_[eIdx] = SubControlVolume(std::move(elementGeometry), eIdx); - - // Save the scvf indices belonging to this scv to build up fv element geometries fast - scvfIndicesOfScv_[eIdx] = scvfIndexSet; - } - - // Make the flip index set for network and surface grids - if (dim < dimWorld) - { - flipScvfIndices_.resize(scvfs_.size()); - for (auto&& scvf : scvfs_) - { - if (scvf.boundary()) - continue; - - const auto numOutsideScvs = scvf.numOutsideScvs(); - const auto vIdxGlobal = scvf.vertexIndex(); - const auto insideScvIdx = scvf.insideScvIdx(); - - flipScvfIndices_[scvf.index()].resize(numOutsideScvs); - for (unsigned int i = 0; i < numOutsideScvs; ++i) - { - const auto outsideScvIdx = scvf.outsideScvIdx(i); - for (auto outsideScvfIndex : scvfIndicesOfScv_[outsideScvIdx]) - { - const auto& outsideScvf = this->scvf(outsideScvfIndex); - if (outsideScvf.vertexIndex() == vIdxGlobal && - MpfaHelper::contains(outsideScvf.outsideScvIndices(), insideScvIdx)) - { - flipScvfIndices_[scvf.index()][i] = outsideScvfIndex; - // there is always only one flip face in an outside element - break; - } - } - - } - } - } - - // make sure we found as many scvfs as previously estimated - assert(scvfIdx == numScvfs); - - // Initialize the interaction volume seeds - globalInteractionVolumeSeeds_.update(problem, interiorOrDomainBoundaryVertices); - } - - /*! - * \brief Return a local restriction of this global object - * The local object is only functional after calling its bind/bindElement method - * This is a free function that will be found by means of ADL - */ - friend inline FVElementGeometry localView(const Implementation& global) - { return FVElementGeometry(global); } - - //! Get a sub control volume with a global scv index - const SubControlVolume& scv(IndexType scvIdx) const - { return scvs_[scvIdx]; } - - //! Get a sub control volume face with a global scvf index - const SubControlVolumeFace& scvf(IndexType scvfIdx) const - { return scvfs_[scvfIdx]; } - - const SubControlVolumeFace& flipScvf(IndexType scvfIdx, unsigned int outsideScvfIdx = 0) const - { return scvfs_[flipScvfIndices_[scvfIdx][outsideScvfIdx]]; } - - //! Get the sub control volume face indices of an scv by global index - const std::vector<IndexType>& scvfIndicesOfScv(IndexType scvIdx) const - { return scvfIndicesOfScv_[scvIdx]; } - - //! Return a const reference to the grid view - const GridView& gridView() const - { return gridView_; } - -private: - - const Problem& problem_() const - { return *problemPtr_; } - - const Problem* problemPtr_; - GridView gridView_; - - // vectors that store the geometries - Dumux::ElementMap<GridView> elementMap_; - std::vector<SubControlVolume> scvs_; - std::vector<SubControlVolumeFace> scvfs_; - - // vectors that store the global data - std::vector<std::vector<IndexType>> scvfIndicesOfScv_; - std::vector<bool> domainBoundaryVertices_; - std::vector<bool> interiorBoundaryScvfs_; - std::vector<bool> interiorBoundaryVertices_; - std::vector<bool> branchingVertices_; - std::size_t numInteriorOrDomainBoundaryVertices_; - std::size_t numDomainBoundaryScvf_; - std::size_t numInteriorBoundaryScvf_; - std::size_t numBranchingPointScvf_; - std::size_t numBranchingPointVertices_; - // needed for embedded surface and network grids (dim < dimWorld) - std::vector<std::vector<IndexType>> flipScvfIndices_; - - // the global interaction volume seeds - GlobalInteractionVolumeSeeds globalInteractionVolumeSeeds_; -}; - -// specialization in case the FVElementGeometries are not stored -template<class TypeTag> -class CCMpfaGlobalFVGeometryBase<TypeTag, false> -{ - //! The local fvGeometry needs access to the problem - friend typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - - using Implementation = typename GET_PROP_TYPE(TypeTag, GlobalFVGeometry); - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using MpfaHelper = typename GET_PROP_TYPE(TypeTag, MpfaHelper); - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using GlobalInteractionVolumeSeeds = typename GET_PROP_TYPE(TypeTag, GlobalInteractionVolumeSeeds); - using BoundaryInteractionVolume = typename GET_PROP_TYPE(TypeTag, BoundaryInteractionVolume); - using InteractionVolume = typename GET_PROP_TYPE(TypeTag, InteractionVolume); - using InteractionVolumeSeed = typename InteractionVolume::Seed; - using BoundaryInteractionVolumeSeed = typename BoundaryInteractionVolume::Seed; - using Element = typename GridView::template Codim<0>::Entity; - - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using CoordScalar = typename GridView::ctype; - using IndexType = typename GridView::IndexSet::IndexType; - using LocalIndexType = typename InteractionVolume::LocalIndexType; - - static constexpr int dim = GridView::dimension; - static constexpr int dimWorld = GridView::dimensionworld; - - using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; - using ReferenceElements = typename Dune::ReferenceElements<CoordScalar, dim>; - - static constexpr bool enableInteriorBoundaries = GET_PROP_VALUE(TypeTag, EnableInteriorBoundaries); - -public: - //! Constructor - CCMpfaGlobalFVGeometryBase(const GridView gridView) - : gridView_(gridView), elementMap_(gridView), globalInteractionVolumeSeeds_(gridView_) {} - - //! The total number of sub control volumes - std::size_t numScv() const - { return numScvs_; } - - //! The total number of sub control volume faces - std::size_t numScvf() const - { return numScvf_; } - - //! The total number of scvfs on the interior boundaries - std::size_t numDomainBoundaryScvf() const - { return numDomainBoundaryScvf_; } - - //! The total number of scvfs on the interior boundaries - std::size_t numInteriorBoundaryScvf() const - { return numInteriorBoundaryScvf_; } - - //! The total number of scvfs connected to branching points - std::size_t numBranchingPointScvf() const - { return numBranchingPointScvf_; } - - //! The total number of vertices connected to branching points - std::size_t numBranchingPointVertices() const - { return numBranchingPointVertices_; } - - //! The total number of vertices on the boundary - std::size_t numInteriorOrDomainBoundaryVertices() const - { return numInteriorOrDomainBoundaryVertices_; } - - // Get an element from a sub control volume contained in it - Element element(const SubControlVolume& scv) const - { return elementMap_.element(scv.elementIndex()); } - - // Get an element from a global element index - Element element(IndexType eIdx) const - { return elementMap_.element(eIdx); } - - //! Return the gridView this global object lives on - const GridView& gridView() const - { return gridView_; } - - //! Get the inner interaction volume seed corresponding to an scvf - const InteractionVolumeSeed& interactionVolumeSeed(const SubControlVolumeFace& scvf) const - { return globalInteractionVolumeSeeds_.seed(scvf); } - - //! Get the boundary interaction volume seed corresponding to an scvf - const BoundaryInteractionVolumeSeed& boundaryInteractionVolumeSeed(const SubControlVolumeFace& scvf) const - { return globalInteractionVolumeSeeds_.boundarySeed(scvf); } - - //! Returns whether or not an scvf is on an interior boundary - bool isOnInteriorBoundary(const SubControlVolumeFace& scvf) const - { return enableInteriorBoundaries ? interiorBoundaryScvfs_[scvf.index()] : false; } - - //! Returns whether or not an scvf touches the domain boundary - bool touchesDomainBoundary(const SubControlVolumeFace& scvf) const - { return domainBoundaryVertices_[scvf.vertexIndex()]; } - - //! Returns whether or not an scvf touches the domain boundary - bool touchesInteriorBoundary(const SubControlVolumeFace& scvf) const - { return enableInteriorBoundaries ? interiorBoundaryVertices_[scvf.vertexIndex()] : false; } - - //! Returns whether or not an scvf belongs to a boundary interaction volume - bool isInBoundaryInteractionVolume(const SubControlVolumeFace& scvf) const - { return touchesDomainBoundary(scvf) || touchesInteriorBoundary(scvf) || touchesBranchingPoint(scvf); } - - //! Returns whether or not a vertex is on a processor boundary - bool isGhostVertex(const IndexType vIdxGlobal) const - { return ghostVertices_[vIdxGlobal]; } - - //! Returns whether or not an scvf touches a branching point (for dim < dimWorld) - bool touchesBranchingPoint(const SubControlVolumeFace& scvf) const - { return dim < dimWorld ? branchingVertices_[scvf.vertexIndex()] : false; } - - //! update all fvElementGeometries (do this again after grid adaption) - void update(const Problem& problem) - { - problemPtr_ = &problem; - - // resize the containers - const auto numScvfs = MpfaHelper::getGlobalNumScvf(gridView_); - const auto numVert = gridView_.size(dim); - numScvs_ = gridView_.size(0); - - elementMap_.resize(numScvs_); - scvfIndicesOfScv_.resize(numScvs_); - neighborVolVarIndices_.resize(numScvs_); - - // keep track of the domain (and maybe interior) boundaries - domainBoundaryVertices_.resize(numVert, false); - std::vector<bool> interiorOrDomainBoundaryVertices(numVert, false); - if (enableInteriorBoundaries) - { - interiorBoundaryScvfs_.resize(numScvfs, false); - interiorBoundaryVertices_.resize(numVert, false); - } - - // keep track of branching points - if (dim < dimWorld) - branchingVertices_.resize(gridView_.size(dim), false); - - // find vertices on processor boundaries - ghostVertices_ = MpfaHelper::findGhostVertices(problem, gridView_); - - // Store necessary info on SCVs and SCV faces - // reset counters for the tracking of the indices - numScvf_ = 0; - numDomainBoundaryScvf_ = 0; - numInteriorBoundaryScvf_ = 0; - numBranchingPointScvf_ = 0; - numBranchingPointVertices_ = 0; - numInteriorOrDomainBoundaryVertices_ = 0; - for (const auto& element : elements(gridView_)) - { - const auto eIdx = problem.elementMapper().index(element); - - // fill the element map with seeds - elementMap_[eIdx] = element.seed(); - - // the element geometry and reference element - auto eg = element.geometry(); - - // the element-wise index sets for finite volume geometry - const auto numLocalFaces = MpfaHelper::getNumLocalScvfs(eg.type()); - std::vector<IndexType> scvfsIndexSet; - std::vector< std::vector<IndexType> > neighborVolVarIndexSet; - scvfsIndexSet.reserve(numLocalFaces); - neighborVolVarIndexSet.reserve(numLocalFaces); - - // for network grids there might be multiple intersection with the same geometryInInside - // we indentify those by the indexInInside for now (assumes conforming grids at branching facets) - std::vector<std::vector<IndexType>> outsideIndices; - if (dim < dimWorld) - { - outsideIndices.resize(element.subEntities(1)); - for (const auto& intersection : intersections(gridView_, element)) - { - if (intersection.neighbor()) - { - const auto& outside = intersection.outside(); - auto nIdx = problem.elementMapper().index(outside); - outsideIndices[intersection.indexInInside()].push_back(nIdx); - } - } - } - - unsigned int localFaceIdx = 0; - // construct the sub control volume faces - for (const auto& is : intersections(gridView_, element)) - { - const auto indexInInside = is.indexInInside(); - const bool boundary = is.boundary(); - const bool neighbor = is.neighbor(); - const bool interiorBoundary = enableInteriorBoundaries ? problem.isInteriorBoundary(element, is) : false; - - // for network grids, skip the rest if handled already - if (dim < dimWorld && neighbor && outsideIndices[indexInInside].empty()) - continue; - - // determine the outside volvar indices - const std::vector<IndexType> nIndices = neighbor && dim == dimWorld ? - std::vector<IndexType>({problem.elementMapper().index(is.outside())}) : - std::vector<IndexType>(); - - // if outside level > inside level, use the outside element in the following - const bool useNeighbor = neighbor && is.outside().level() > element.level(); - const auto& e = useNeighbor ? is.outside() : element; - const auto indexInElement = useNeighbor ? is.indexInOutside() : indexInInside; - const auto eg = e.geometry(); - const auto& refElement = ReferenceElements::general(eg.type()); - - // make the scv faces of the intersection - for (unsigned int c = 0; c < is.geometry().corners(); ++c) - { - // get the global vertex index the scv face is connected to (mpfa-o method does not work for hanging nodes!) - const auto vIdxLocal = refElement.subEntity(indexInElement, 1, c, dim); - const auto vIdxGlobal = problem.vertexMapper().subIndex(e, vIdxLocal, dim); - - // do not build scvfs connected to a processor boundary - if (ghostVertices_[vIdxGlobal]) - continue; - - // is vertex on a branching point? - if (dim < dimWorld && outsideIndices[indexInInside].size() > 1) - { - if (!branchingVertices_[vIdxGlobal]) - numBranchingPointVertices_++; - branchingVertices_[vIdxGlobal] = true; - numBranchingPointScvf_++; - } - - // store information on the scv face (for inner scvfs on network grids use precalculated outside indices) - if (!boundary) - { - const auto& outsideScvIndices = dim == dimWorld ? nIndices : outsideIndices[indexInInside]; - scvfsIndexSet.push_back(numScvf_++); - neighborVolVarIndexSet.push_back(outsideScvIndices); - } - else - { - const std::vector<IndexType> boundaryIdx = [&] () - { - IndexType bIdx = numScvs_ + numDomainBoundaryScvf_++; - return std::vector<IndexType>({bIdx}); - } (); - scvfsIndexSet.push_back(numScvf_++); - neighborVolVarIndexSet.push_back(boundaryIdx); - } - - // if a new interior or domain boundary has been found, increase counter - if ((boundary || interiorBoundary) && !interiorOrDomainBoundaryVertices[vIdxGlobal]) - { - interiorOrDomainBoundaryVertices[vIdxGlobal] = true; - numInteriorOrDomainBoundaryVertices_++; - } - - // store info on which vertices are on the domain/interior boundary - if (boundary) - domainBoundaryVertices_[vIdxGlobal] = true; - if (enableInteriorBoundaries && interiorBoundary) - { - interiorBoundaryVertices_[vIdxGlobal] = true; - interiorBoundaryScvfs_[numScvf_-1] = true; - numInteriorBoundaryScvf_++; - } - - // increment counter - localFaceIdx++; - } - - // for network grids, clear outside indices to not make a second scvf on that facet - if (dim < dimWorld) - outsideIndices[indexInInside].clear(); - } - - // store the sets of indices in the data container - scvfIndicesOfScv_[eIdx] = scvfsIndexSet; - neighborVolVarIndices_[eIdx] = neighborVolVarIndexSet; - } - - // make sure we found as many scvfs as previously estimated - assert(numScvf_ == numScvfs); - - // Initialize the interaction volume seeds - globalInteractionVolumeSeeds_.update(problem, interiorOrDomainBoundaryVertices); - } - - const std::vector<IndexType>& scvfIndicesOfScv(IndexType scvIdx) const - { return scvfIndicesOfScv_[scvIdx]; } - - const std::vector< std::vector<IndexType> >& neighborVolVarIndices(IndexType scvIdx) const - { return neighborVolVarIndices_[scvIdx]; } - - /*! - * \brief Return a local restriction of this global object - * The local object is only functional after calling its bind/bindElement method - * This is a free function that will be found by means of ADL - */ - friend inline FVElementGeometry localView(const Implementation& global) - { return FVElementGeometry(global); } - -private: - - const Problem& problem_() const - { return *problemPtr_; } - - const Problem* problemPtr_; - - GridView gridView_; - - // Information on the global number of geometries - std::size_t numScvs_; - std::size_t numScvf_; - std::size_t numDomainBoundaryScvf_; - std::size_t numInteriorBoundaryScvf_; - std::size_t numBranchingPointScvf_; - std::size_t numBranchingPointVertices_; - std::size_t numInteriorOrDomainBoundaryVertices_; - - // vectors that store the global data - Dumux::ElementMap<GridView> elementMap_; - std::vector<std::vector<IndexType>> scvfIndicesOfScv_; - std::vector< std::vector< std::vector<IndexType> > > neighborVolVarIndices_; - std::vector<bool> domainBoundaryVertices_; - std::vector<bool> interiorBoundaryScvfs_; - std::vector<bool> interiorBoundaryVertices_; - std::vector<bool> ghostVertices_; - std::vector<bool> branchingVertices_; - - // the global interaction volume seeds - GlobalInteractionVolumeSeeds globalInteractionVolumeSeeds_; -}; - -} // end namespace - -#endif diff --git a/dumux/discretization/cellcentered/mpfa/interiorboundarydata.hh b/dumux/discretization/cellcentered/mpfa/interiorboundarydata.hh index 0ab82f8efcbf4c28d8376b3b0de8787bd66b65e0..dfbe9753232d3273e5ad7843d068859ad3cbec58 100644 --- a/dumux/discretization/cellcentered/mpfa/interiorboundarydata.hh +++ b/dumux/discretization/cellcentered/mpfa/interiorboundarydata.hh @@ -27,21 +27,16 @@ namespace Dumux { - -//! forward declaration of property tags -namespace Properties -{ - NEW_PROP_TAG(SpatialParams); - NEW_PROP_TAG(FacetCoupling); -} - +/*! + * \ingroup CCMpfa + * \brief Class to store additional data related to interior boundary facets. + */ template<class TypeTag> class InteriorBoundaryData { using Problem = typename GET_PROP_TYPE(TypeTag, Problem); using GridView = typename GET_PROP_TYPE(TypeTag, GridView); using Element = typename GridView::template Codim<0>::Entity; - using SpatialParams = typename GET_PROP_TYPE(TypeTag, SpatialParams); using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables); using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); @@ -50,42 +45,6 @@ class InteriorBoundaryData using IndexType = typename GridView::IndexSet::IndexType; using LocalIndexType = typename BoundaryInteractionVolume::LocalIndexType; - //! Dummy type for the CompleteCoupledFacetData struct. - //! Implementations need to have at least the provided interfaces. - //! Note that the return types are also "wrong" (Here just to satisfy the compiler) - struct CompleteCoupledFacetData - { - const Problem& problem() const - { - DUNE_THROW(Dune::NotImplemented, "No implementation of the CompleteCoupledFacetData class provided"); - } - - const SpatialParams& spatialParams() const - { - DUNE_THROW(Dune::NotImplemented, "No implementation of the CompleteCoupledFacetData class provided"); - } - - const VolumeVariables volVars() const - { - DUNE_THROW(Dune::NotImplemented, "No implementation of the CompleteCoupledFacetData class provided"); - } - - const Element element() const - { - DUNE_THROW(Dune::NotImplemented, "No implementation of the CompleteCoupledFacetData class provided"); - } - - const FVElementGeometry fvGeometry() const - { - DUNE_THROW(Dune::NotImplemented, "No implementation of the CompleteCoupledFacetData class provided"); - } - - const FVElementGeometry scv() const - { - DUNE_THROW(Dune::NotImplemented, "No implementation of the CompleteCoupledFacetData class provided"); - } - }; - public: //! the constructor InteriorBoundaryData(const Problem& problem, @@ -122,17 +81,13 @@ public: //! returns the volume variables for interior dirichlet boundaries VolumeVariables facetVolVars(const FVElementGeometry& fvGeometry) const { - //! This cannot be called when FacetCoupling is active - static const bool isFacetCoupling = GET_PROP_VALUE(TypeTag, MpfaFacetCoupling); - assert(!isFacetCoupling && "For models with a coupled problem on the element facets you have to" - "provide a suitable implementation of the InteriorBoundaryData class"); - //! This can only be called for interior Dirichlet boundaries assert(faceType_ == MpfaFaceTypes::interiorDirichlet && "requesting Dirichlet vol vars for a face which is" "not marked as interior Dirichlet face."); - auto element = problem_().model().globalFvGeometry().element(elementIndex()); - auto priVars = problem_().dirichlet(element, fvGeometry.scvf(scvfIndex())); + const auto& scvf = fvGeometry.scvf(scvfIndex()); + const auto element = problem_().model().globalFvGeometry().element(scvf.insideScvIdx()); + const auto priVars = problem_().dirichlet(element, scvf); VolumeVariables volVars; volVars.update(ElementSolutionVector({priVars}), @@ -143,19 +98,6 @@ public: return volVars; } - //! The following interface is to be overloaded for problems using facet coupling. - //! prepares all the necessary variables of the other domain. - //! Note that also an implementation of the CompleteFacetData structure has to be provided. - CompleteCoupledFacetData completeCoupledFacetData() const - { - if (GET_PROP_VALUE(TypeTag, MpfaFacetCoupling)) - DUNE_THROW(Dune::InvalidStateException, "You have to use an InteriorBoundaryData class designed " - "for handling a coupled problem on the element facets."); - else - DUNE_THROW(Dune::InvalidStateException, "FacetCoupling is not active. " - "Calling completeCoupledFacetData() for uncoupled problems is invalid."); - } - private: const Problem& problem_() const { return *problemPtr_; } diff --git a/dumux/discretization/cellcentered/mpfa/lmethod/interactionvolume.hh b/dumux/discretization/cellcentered/mpfa/lmethod/interactionvolume.hh index 6ab3030efd62216e261933b8b7cb2e4d56fe7e6c..c5647e7b05c14c65e93ccd35e5b656c3e4aa6b20 100644 --- a/dumux/discretization/cellcentered/mpfa/lmethod/interactionvolume.hh +++ b/dumux/discretization/cellcentered/mpfa/lmethod/interactionvolume.hh @@ -66,7 +66,8 @@ public: * \brief Base class for the interaction volumes of the mpfa-l method. */ template<class TypeTag> -class CCMpfaInteractionVolumeImplementation<TypeTag, MpfaMethods::lMethod> : public CCMpfaInteractionVolumeBase<TypeTag, CCMpfaLInteractionVolumeTraits<TypeTag>> +class CCMpfaInteractionVolumeImplementation<TypeTag, MpfaMethods::lMethod> + : public CCMpfaInteractionVolumeBase<TypeTag, CCMpfaLInteractionVolumeTraits<TypeTag>> { // The interaction volume implementation has to be friend friend typename GET_PROP_TYPE(TypeTag, InteractionVolume); diff --git a/dumux/discretization/cellcentered/mpfa/omethod/interactionvolume.hh b/dumux/discretization/cellcentered/mpfa/omethod/interactionvolume.hh index 73991700b7ae86df988dcd21ecf8c5476b41f66f..28d37d8079dcfc47aac441cef31417f44ca05657 100644 --- a/dumux/discretization/cellcentered/mpfa/omethod/interactionvolume.hh +++ b/dumux/discretization/cellcentered/mpfa/omethod/interactionvolume.hh @@ -61,7 +61,8 @@ public: }; //! Forward declaration of the mpfa-o interaction volume -template<class TypeTag, class Traits> class CCMpfaOInteractionVolume; +template<class TypeTag, class Traits, class Implementation> +class CCMpfaOInteractionVolume; /*! * \ingroup Mpfa @@ -71,17 +72,24 @@ template<class TypeTag, class Traits> class CCMpfaOInteractionVolume; * traits class. */ template<class TypeTag> -class CCMpfaInteractionVolumeImplementation<TypeTag, MpfaMethods::oMethod> : public CCMpfaOInteractionVolume<TypeTag, CCMpfaOInteractionVolumeTraits<TypeTag>> +class CCMpfaInteractionVolumeImplementation<TypeTag, MpfaMethods::oMethod> + : public CCMpfaOInteractionVolume<TypeTag, + CCMpfaOInteractionVolumeTraits<TypeTag>, + CCMpfaInteractionVolumeImplementation<TypeTag, MpfaMethods::oMethod>> { - using Traits = CCMpfaOInteractionVolumeTraits<TypeTag>; - using ParentType = CCMpfaOInteractionVolume<TypeTag, Traits>; + using ThisType = CCMpfaInteractionVolumeImplementation<TypeTag, MpfaMethods::oMethod>; + using TraitsType = CCMpfaOInteractionVolumeTraits<TypeTag>; + using ParentType = CCMpfaOInteractionVolume<TypeTag, TraitsType, ThisType>; using Problem = typename GET_PROP_TYPE(TypeTag, Problem); using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); - using IVSeed = typename Traits::Seed; + using IVSeed = typename TraitsType::Seed; public: + // state the traits class type + using Traits = TraitsType; + CCMpfaInteractionVolumeImplementation(const IVSeed& seed, const Problem& problem, const FVElementGeometry& fvGeometry, @@ -91,15 +99,13 @@ public: }; -template<class TypeTag, class Traits> +template<class TypeTag, class Traits, class Implementation> class CCMpfaOInteractionVolume : public CCMpfaInteractionVolumeBase<TypeTag, Traits> { - // The interaction volume implementation has to be friend, - // because some methods use the mpfa-o interaction volume as base - friend typename GET_PROP_TYPE(TypeTag, InteractionVolume); - using Implementation = typename GET_PROP_TYPE(TypeTag, InteractionVolume); - using ParentType = CCMpfaInteractionVolumeBase<TypeTag, Traits>; + // The actual implementation has to be friend + friend Implementation; + using ParentType = CCMpfaInteractionVolumeBase<TypeTag, Traits>; using Problem = typename GET_PROP_TYPE(TypeTag, Problem); using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); using GridView = typename GET_PROP_TYPE(TypeTag, GridView); @@ -111,7 +117,6 @@ class CCMpfaOInteractionVolume : public CCMpfaInteractionVolumeBase<TypeTag, Tra using InteriorBoundaryData = typename GET_PROP_TYPE(TypeTag, InteriorBoundaryData); static constexpr bool useTpfaBoundary = GET_PROP_VALUE(TypeTag, UseTpfaBoundary); - static constexpr bool facetCoupling = GET_PROP_VALUE(TypeTag, MpfaFacetCoupling); static constexpr bool enableInteriorBoundaries = GET_PROP_VALUE(TypeTag, EnableInteriorBoundaries); static const int dim = GridView::dimension; @@ -149,7 +154,7 @@ public: bind(seed); // initialize the vector containing the neumann fluxes - assembleNeumannFluxVector_(); + asImp_().assembleNeumannFluxVector(); } template<typename GetTensorFunction> @@ -280,6 +285,45 @@ public: return flux; } + // Per default we do not add additional terms for interior Neumann boundaries + // Overload this function to realize interior membranes etc... + template<typename GetTensorFunction> + Scalar interiorNeumannTerm(const GetTensorFunction& getTensor, + const Element& element, + const LocalScvfType& localScvf, + const InteriorBoundaryData& data) const + { return 0.0; } + + void assembleNeumannFluxVector() + { + // initialize the neumann fluxes vector to zero + neumannFluxes_.resize(fluxFaceIndexSet_.size(), PrimaryVariables(0.0)); + + if (!onDomainOrInteriorBoundary() || useTpfaBoundary) + return; + + LocalIndexType fluxFaceIdx = 0; + for (auto localFluxFaceIdx : fluxFaceIndexSet_) + { + const auto& localScvf = localScvf_(localFluxFaceIdx); + const auto faceType = localScvf.faceType(); + + if (faceType == MpfaFaceTypes::neumann || faceType == MpfaFaceTypes::interiorNeumann) + { + const auto& element = localElement_(localScvf.insideLocalScvIndex()); + const auto& globalScvf = fvGeometry_().scvf(localScvf.insideGlobalScvfIndex()); + auto neumannFlux = problem_().neumann(element, this->fvGeometry_(), this->elemVolVars_(), globalScvf); + neumannFlux *= globalScvf.area(); + neumannFlux *= elemVolVars_()[globalScvf.insideScvIdx()].extrusionFactor(); + + // The flux is assumed to be prescribed in the form of -D*gradU + neumannFluxes_[fluxFaceIdx] = neumannFlux; + } + + fluxFaceIdx++; + } + } + const LocalFaceData& getLocalFaceData(const SubControlVolumeFace& scvf) const { return globalLocalScvfPairedData_[this->findIndexInVector(globalScvfIndices_, scvf.index())].second; } @@ -425,36 +469,6 @@ private: } } - void assembleNeumannFluxVector_() - { - // initialize the neumann fluxes vector to zero - neumannFluxes_.resize(fluxFaceIndexSet_.size(), PrimaryVariables(0.0)); - - if (!onDomainOrInteriorBoundary() || useTpfaBoundary) - return; - - LocalIndexType fluxFaceIdx = 0; - for (auto localFluxFaceIdx : fluxFaceIndexSet_) - { - const auto& localScvf = localScvf_(localFluxFaceIdx); - const auto faceType = localScvf.faceType(); - - if (faceType == MpfaFaceTypes::neumann || (faceType == MpfaFaceTypes::interiorNeumann && !facetCoupling)) - { - const auto& element = localElement_(localScvf.insideLocalScvIndex()); - const auto& globalScvf = fvGeometry_().scvf(localScvf.insideGlobalScvfIndex()); - auto neumannFlux = problem_().neumann(element, this->fvGeometry_(), this->elemVolVars_(), globalScvf); - neumannFlux *= globalScvf.area(); - neumannFlux *= elemVolVars_()[globalScvf.insideScvIdx()].extrusionFactor(); - - // The flux is assumed to be prescribed in the form of -D*gradU - neumannFluxes_[fluxFaceIdx] = neumannFlux; - } - - fluxFaceIdx++; - } - } - template<typename GetTensorFunction> void assembleLocalMatrices_(const GetTensorFunction& getTensor, DynamicMatrix& A, @@ -512,37 +526,13 @@ private: { // on interior neumann faces, apply xi factor // However, if this is a boundary face at the same time, don't! - A[idxInFluxFaces][curIdxInFluxFaces] += localScvf.globalScvf().boundary() ? - posWijk[localDir] : xi*posWijk[localDir]; + A[idxInFluxFaces][curIdxInFluxFaces] += localScvf.globalScvf().boundary() ? posWijk[localDir] : xi*posWijk[localDir]; - // add values from other domain in case of facet coupling - if (facetCoupling && curIdxInFluxFaces == idxInFluxFaces) + // maybe add terms stemming from the interior boundary (in case of facet coupling or membrane modelling) + if (curIdxInFluxFaces == idxInFluxFaces) { - // get interior boundary data const auto& data = interiorBoundaryData_[this->findIndexInVector(interiorBoundaryScvfIndexSet_(), curLocalScvfIdx)]; - - // obtain the complete data on the facet element - const auto completeFacetData = data.completeCoupledFacetData(); - - // calculate "leakage factor" - const auto n = curLocalScvf.unitOuterNormal(); - const auto v = [&] () - { - auto res = n; - res *= -0.5*completeFacetData.volVars().extrusionFactor(); - res -= curLocalScvf.ip(); - res += curLocalScvf.globalScvf().facetCorner(); - res /= res.two_norm2(); - return res; - } (); - - // substract n*T*v from diagonal matrix entry - const auto facetTensor = getTensor(completeFacetData.problem(), - completeFacetData.element(), - completeFacetData.volVars(), - completeFacetData.fvGeometry(), - completeFacetData.scv()); - A[idxInFluxFaces][curIdxInFluxFaces] -= MpfaHelper::nT_M_v(n, facetTensor, v); + A[idxInFluxFaces][curIdxInFluxFaces] += asImp_().interiorNeumannTerm(getTensor, element, curLocalScvf, data); } } // this means we are on an interior face @@ -765,6 +755,12 @@ private: return wijk; } + Implementation& asImp_() + { return static_cast<Implementation&> (*this); } + + const Implementation& asImp_() const + { return static_cast<const Implementation&> (*this); } + const Problem& problem_() const { return *problemPtr_; } diff --git a/dumux/discretization/cellcentered/mpfa/omethodfps/interactionvolume.hh b/dumux/discretization/cellcentered/mpfa/omethodfps/interactionvolume.hh index 6a905987d6bbff25c1c9560da92e0b3e266d2ac9..8ff3f3186a8b186ab5ddf423c180a15c1c63f303 100644 --- a/dumux/discretization/cellcentered/mpfa/omethodfps/interactionvolume.hh +++ b/dumux/discretization/cellcentered/mpfa/omethodfps/interactionvolume.hh @@ -43,12 +43,9 @@ class CCMpfaOFpsInteractionVolumeTraits : public CCMpfaOInteractionVolumeTraits< public: // Interior boundaries can not yet be handled by the currend o-method fps implementation // In that case we use the o-interactionvolume, otherwise we use its own interaction volumes at the boundary - // TODO Fix the std::conditional - using BoundaryInteractionVolume = typename CCMpfaOInteractionVolumeTraits<TypeTag>::BoundaryInteractionVolume; - // using BoundaryInteractionVolume = typename std::conditional<GET_PROP_VALUE(TypeTag, EnableInteriorBoundaries), - // typename CCMpfaOInteractionVolumeTraits<TypeTag>::BoundaryInteractionVolume, - // typename CCMpfaInteractionVolumeImplementation<TypeTag, MpfaMethods::oMethodFps> - // >::type; + using BoundaryInteractionVolume = typename std::conditional<GET_PROP_VALUE(TypeTag, EnableInteriorBoundaries), + CCMpfaInteractionVolumeImplementation<TypeTag, MpfaMethods::oMethod>, + CCMpfaInteractionVolumeImplementation<TypeTag, MpfaMethods::oMethodFps>>::type; // The local sub-control volume type differs from the standard mpfa-o method using LocalScvType = CCMpfaOFpsLocalScv<TypeTag>; @@ -58,10 +55,14 @@ public: * \brief Base class for the interaction volumes of the mpfa-o method with full pressure support. */ template<class TypeTag> -class CCMpfaInteractionVolumeImplementation<TypeTag, MpfaMethods::oMethodFps> : public CCMpfaOInteractionVolume<TypeTag, CCMpfaOFpsInteractionVolumeTraits<TypeTag>> +class CCMpfaInteractionVolumeImplementation<TypeTag, MpfaMethods::oMethodFps> + : public CCMpfaOInteractionVolume<TypeTag, + CCMpfaOFpsInteractionVolumeTraits<TypeTag>, + CCMpfaInteractionVolumeImplementation<TypeTag, MpfaMethods::oMethodFps>> { using Traits = CCMpfaOFpsInteractionVolumeTraits<TypeTag>; - using ParentType = CCMpfaOInteractionVolume<TypeTag, Traits>; + using ThisType = CCMpfaInteractionVolumeImplementation<TypeTag, MpfaMethods::oMethodFps>; + using ParentType = CCMpfaOInteractionVolume<TypeTag, Traits, ThisType>; using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); using Problem = typename GET_PROP_TYPE(TypeTag, Problem); @@ -202,8 +203,7 @@ private: auto&& localScv = this->localScv_(localScvIdx); auto&& globalScv = this->fvGeometry_().scv(localScv.globalIndex()); auto&& element = this->localElement_(localScvIdx); - auto D = makeTensor_(getTensor(element, this->elemVolVars_()[globalScv], globalScv)); - + auto D = makeTensor_(getTensor(this->problem_(), element, this->elemVolVars_()[globalScv], this->fvGeometry_(), globalScv)); // the local finite element basis const auto& localBasis = feCache_.get(localScv.geometry().type()).localBasis(); @@ -248,7 +248,7 @@ private: auto&& localScv = this->localScv_(localScvIdx); auto&& globalScv = this->fvGeometry_().scv(localScv.globalIndex()); auto&& element = this->localElement_(localScvIdx);; - auto D = makeTensor_(getTensor(element, this->elemVolVars_()[globalScv], globalScv)); + auto D = makeTensor_(getTensor(this->problem_(), element, this->elemVolVars_()[globalScv], this->fvGeometry_(), globalScv)); // the local finite element bases of the scvs const auto& localBasis = feCache_.get(localScv.geometry().type()).localBasis(); diff --git a/dumux/mixeddimension/CMakeLists.txt b/dumux/mixeddimension/CMakeLists.txt index a592084f9ace910eb119f7665f06888f92311a18..0eca574b98ea5f313643fe768fbd67060377f435 100644 --- a/dumux/mixeddimension/CMakeLists.txt +++ b/dumux/mixeddimension/CMakeLists.txt @@ -1,4 +1,5 @@ add_subdirectory("embedded") +add_subdirectory("facet") add_subdirectory("glue") install(FILES diff --git a/dumux/mixeddimension/facet/CMakeLists.txt b/dumux/mixeddimension/facet/CMakeLists.txt new file mode 100644 index 0000000000000000000000000000000000000000..a272c20bcc8d839debb534390f2768907e6dffa1 --- /dev/null +++ b/dumux/mixeddimension/facet/CMakeLists.txt @@ -0,0 +1,6 @@ +add_subdirectory("mpfa") + +install(FILES +gmshdualfacetgridcreator.hh +start.hh +DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/mixeddimension/facet) \ No newline at end of file diff --git a/dumux/mixeddimension/facet/gmshdualfacetgridcreator.hh b/dumux/mixeddimension/facet/gmshdualfacetgridcreator.hh new file mode 100644 index 0000000000000000000000000000000000000000..6f9617a2b678eaac84f5b71ffabcacd3f79445d1 --- /dev/null +++ b/dumux/mixeddimension/facet/gmshdualfacetgridcreator.hh @@ -0,0 +1,469 @@ +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * + * \brief Reads gmsh files where fractures are defined as lines in surfaces + * or surfaces in volumes and constructs a grid for the bulk part and a + * lower-dimensional grid for the lines/surfaces. + */ + +#ifndef DUMUX_GMSHDUALFACETGRIDCREATOR_HH +#define DUMUX_GMSHDUALFACETGRIDCREATOR_HH + +#include <algorithm> +#include <iostream> +#include <fstream> +#include <sstream> +#include <iomanip> + +#include <dune/common/version.hh> +#include <dune/grid/common/mcmgmapper.hh> +#include <dune/grid/common/gridfactory.hh> + +#include <dumux/common/math.hh> +#include <dumux/common/propertysystem.hh> +#include <dumux/common/parameters.hh> +#include <dumux/common/valgrind.hh> + +namespace Dumux +{ + +namespace Properties +{ +NEW_PROP_TAG(Scalar); +} + +/*! + * \brief Reads gmsh files where fractures are defined as lines in surfaces + * or surfaces in volumes and constructs a grid for the bulk part and a + * lower-dimensional grid for the lines/surfaces. + */ +template <class TypeTag> +class GmshDualFacetGridCreator +{ + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + + // obtain the type tags of the sub problems + using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); + using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); + + // obtain the grid types of the sub problems + using BulkGrid = typename GET_PROP_TYPE(BulkProblemTypeTag, Grid); + using LowDimGrid = typename GET_PROP_TYPE(LowDimProblemTypeTag, Grid); + using LowDimElement = typename LowDimGrid::template Codim<0>::Entity; + + // The Bulk Element Mapper + using BulkElementMapper = typename GET_PROP_TYPE(BulkProblemTypeTag, ElementMapper); + + static constexpr int bulkDim = BulkGrid::dimension; + static constexpr int lowDimDim = LowDimGrid::dimension; + static constexpr int dimWorld = BulkGrid::dimensionworld; + static constexpr int lowDimDimWorld = LowDimGrid::dimensionworld; + static_assert(dimWorld == lowDimDimWorld, "dimWorld cannot be different for the two sub-domains!"); + + static constexpr int invalidIndex = -5; + + using GlobalPosition = Dune::FieldVector<double, dimWorld>; + using BulkIndexType = typename BulkGrid::LeafGridView::IndexSet::IndexType; + using LowDimIndexType = typename LowDimGrid::LeafGridView::IndexSet::IndexType; + +public: + /*! + * \brief Create the Grid. + * Specialization for bulk dim = 2 and lowDim dim = 1 + */ + template<class T = TypeTag> + static typename std::enable_if<bulkDim == 2 && lowDimDim == 1>::type + makeGrid() + { + const std::string fileName = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Grid, File); + + // set up the grid factories + auto& bulkFactory = bulkFactory_(); + auto& lowDimFactory = lowDimFactory_(); + + // open the mesh file + std::cout << "Opening " << fileName << std::endl; + std::ifstream mshFile(fileName.c_str()); + if (mshFile.fail()) + DUNE_THROW(Dune::InvalidStateException, "Could not open the given .msh file. Make sure it exists"); + if (getFileExtension_(fileName) != "msh") + DUNE_THROW(Dune::InvalidStateException, "Please provide a .msh file for this grid creator"); + + // read file until we get to the list of nodes + std::string line; + std::getline(mshFile, line); + while (line.compare(0, 6, "$Nodes") != 0) + std::getline(mshFile, line); + + // get total number of nodes + std::getline(mshFile, line); + const auto numVertices = stringToNumber_(line); + + // read vertices line by line + std::getline(mshFile, line); + std::vector<GlobalPosition> bulkVertices(numVertices); + unsigned int vertexCounter = 0; + while (line.compare(0, 9, "$EndNodes") != 0) + { + // read the coordinates of the vertex + std::string buf; + std::stringstream stream(line); + + // drop first entry in line + stream >> buf; + std::vector<std::string> coords; + while (stream >> buf) + coords.push_back(buf); + + // "create" a vertex + GlobalPosition v; + for (int i = 0; i < dimWorld; ++i) + v[i] = stringToNumber_(coords[i]); + + // insert vertex into container and the bulk grid factory + bulkVertices[vertexCounter] = v; + bulkFactory.insertVertex(v); + std::getline(mshFile, line); + vertexCounter++; + } + + // we should always find as many vertices as the mesh file states + assert(vertexCounter == numVertices); + + // read file until we get to the list of elements + while(line.compare(0, 9, "$Elements") != 0) + std::getline(mshFile, line); + + // get total number of elements + std::getline(mshFile, line); + const auto numElements = stringToNumber_(line); + + // while inserting the low dim vertices, keep track of indices that have + // been inserted already and element vertex indices in "original" indexing + std::vector<GlobalPosition> lowDimVertices; + std::vector<LowDimIndexType> lowDimVertexIndices; + std::vector<std::vector<BulkIndexType>> lowDimElemVertices; + + lowDimVertices.reserve(numVertices); + lowDimVertexIndices.reserve(numVertices); + lowDimElemVertices.reserve(numElements); + + // the coupling data container lowDim -> bulk + auto& lowDimCouplingMap = lowDimCouplingElements_(); + + // read in the elements line by line + std::getline(mshFile, line); + BulkIndexType bulkElementCounter = 0; + LowDimIndexType lowDimElementCounter = 0; + while (line.compare(0, 12, "$EndElements") != 0) + { + // read the data of this element + std::string buf; + std::stringstream stream(line); + std::vector<unsigned int> elemData; + while (stream >> buf) + elemData.push_back(stringToNumber_(buf)); + + // get number of gmsh tags for this element + const auto noOfTags = elemData[2]; + + // get element type, make container of indexvertices and insert element + const auto elemType = elemData[1]; + + switch (elemType) + { + case 15: // points + { + // do nothing for points + break; + } + + case 1: // 2-node line + { + // the geometry type for lines + static const Dune::GeometryType gt = [] () { Dune::GeometryType t; t.makeLine(); return t; } (); + + // get the connected vertex indices + std::vector<LowDimIndexType> elemVertexIndices(2); + + const auto vIdx1 = elemData[3 + noOfTags]; + const auto vIdx2 = elemData[3 + noOfTags + 1]; + + elemVertexIndices[0] = findIndexInVector_(lowDimVertexIndices, vIdx1); + elemVertexIndices[1] = findIndexInVector_(lowDimVertexIndices, vIdx2); + + if (elemVertexIndices[0] == invalidIndex) + { + const auto v1 = bulkVertices[vIdx1-1]; + + lowDimVertices.push_back(v1); + lowDimVertexIndices.push_back(vIdx1); + lowDimFactory.insertVertex(v1); + + elemVertexIndices[0] = lowDimVertices.size()-1; + } + if (elemVertexIndices[1] == invalidIndex) + { + const auto v2 = bulkVertices[vIdx2-1]; + + lowDimVertices.push_back(v2); + lowDimVertexIndices.push_back(vIdx2); + lowDimFactory.insertVertex(v2); + + elemVertexIndices[1] = lowDimVertices.size()-1; + } + + // store the low dim elements' vertices + lowDimElemVertices.push_back(std::vector<BulkIndexType>({vIdx1, vIdx2})); + + // insert element into the factory + lowDimFactory.insertElement(gt, elemVertexIndices); + + // increase low dim element counter + lowDimElementCounter++; + break; + } + + case 2: // 3-node triangle + { + // the geometry type for triangles + static const Dune::GeometryType gt = Dune::GeometryType(Dune::GeometryType::simplex,2); + + // we know that the low dim elements have been read already + if (lowDimCouplingMap.empty()) + lowDimCouplingMap.resize(lowDimElementCounter); + + // get the vertex indices of this bulk element + std::vector<BulkIndexType> elemVertexIndices(3); + elemVertexIndices[0] = elemData[3 + noOfTags]; + elemVertexIndices[1] = elemData[3 + noOfTags + 1]; + elemVertexIndices[2] = elemData[3 + noOfTags + 2]; + + // get the insertion indices of the low dim elements connected to this element + const auto lowDimElemIndices = obtainLowDimConnections_(lowDimElemVertices, elemVertexIndices); + + // if we found some, insert the connections in the map + for (auto lowDimElemIdx : lowDimElemIndices) + lowDimCouplingMap[lowDimElemIdx].push_back(bulkElementCounter); + + // subtract 1 from the element indices (gmsh starts at index 1) + elemVertexIndices[0] -= 1; + elemVertexIndices[1] -= 1; + elemVertexIndices[2] -= 1; + + // insert bulk element into the factory + bulkFactory.insertElement(gt, elemVertexIndices); + + // increase bulk element counter + bulkElementCounter++; + break; + } + + default: + DUNE_THROW(Dune::NotImplemented, "GmshDualFacetGridCreator for given element type"); + } + + // get next line + std::getline(mshFile, line); + } + + std::cout << bulkElementCounter << " bulk elements and " + << lowDimElementCounter << " low dim elements have been created." << std::endl; + + + bulkGridPtr_() = std::shared_ptr<BulkGrid>(bulkFactory.createGrid()); + lowDimGridPtr_() = std::shared_ptr<LowDimGrid>(lowDimFactory.createGrid()); + + // set up the map from insertion to actual global indices for bulk elements + BulkElementMapper elementMapper(bulkGrid().leafGridView()); + auto& map = bulkInsertionToGlobalIdxMap_(); + map.resize(bulkElementCounter); + for (const auto& element : elements(bulkGrid().leafGridView())) + map[bulkFactory.insertionIndex(element)] = elementMapper.index(element); + } + + /*! + * \brief Returns a reference to the bulk grid. + */ + static BulkGrid& bulkGrid() + { return *bulkGridPtr_(); } + + /*! + * \brief Returns a reference to the lower dimensional facet grid. + */ + static LowDimGrid& lowDimGrid() + { return *lowDimGridPtr_(); } + + /*! + * \brief Distributes the grid on all processes of a parallel + * computation. + */ + static void loadBalance() + { + bulkGrid().loadBalance(); + lowDimGrid().loadBalance(); + } + + static std::vector<BulkIndexType> getCoupledBulkElementIndices(const LowDimElement& lowDimElement) + { + const auto& insertionIndices = lowDimCouplingElements_()[lowDimFactory_().insertionIndex(lowDimElement)]; + const auto& bulkInsertionToGlobalMap = bulkInsertionToGlobalIdxMap_(); + + const auto n = insertionIndices.size(); + std::vector<BulkIndexType> globalIndices(n); + for (unsigned int i = 0; i < n; ++i) + globalIndices[i] = bulkInsertionToGlobalMap[insertionIndices[i]]; + + return globalIndices; + } + +private: + + /*! + * \brief Returns a reference to the vector containing lists of bulk element indices + * that are connected to the low dim elements. Note that the access occurs + * with the insertion index of a low dim element. + */ + static std::vector<std::vector<BulkIndexType>>& lowDimCouplingElements_() + { + static std::vector<std::vector<BulkIndexType>> couplingMap_; + return couplingMap_; + } + + /*! + * \brief Returns a reference to the map mapping bulk element insertion indices + * to actual global indices + */ + static std::vector<BulkIndexType>& bulkInsertionToGlobalIdxMap_() + { + static std::vector<BulkIndexType> insertionIdxMap_; + return insertionIdxMap_; + } + + /*! + * \brief Returns a reference to the bulk grid pointer (std::shared_ptr<BulkGrid>) + */ + static std::shared_ptr<BulkGrid>& bulkGridPtr_() + { + static std::shared_ptr<BulkGrid> bulkGridPtr_; + return bulkGridPtr_; + } + + /*! + * \brief Returns a reference to the lowDim grid pointer (std::shared_ptr<LowDimGrid>) + */ + static std::shared_ptr<LowDimGrid>& lowDimGridPtr_() + { + static std::shared_ptr<LowDimGrid> lowDimGridPtr_; + return lowDimGridPtr_; + } + + static Dune::GridFactory<BulkGrid>& bulkFactory_() + { + static Dune::GridFactory<BulkGrid> bulkFactory_; + return bulkFactory_; + } + + static Dune::GridFactory<LowDimGrid>& lowDimFactory_() + { + static Dune::GridFactory<LowDimGrid> lowDimFactory_; + return lowDimFactory_; + } + + /*! + * \brief Returns a list of low dim elements that are connected to this bulk element + */ + static std::vector<LowDimIndexType> obtainLowDimConnections_(const std::vector<std::vector<LowDimIndexType>>& lowDimElemData, + const std::vector<BulkIndexType>& bulkElemVertices) + { + std::vector<LowDimIndexType> lowDimElemIndices = std::vector<LowDimIndexType>(); + + // check for each low dim element if it is contained + unsigned int lowDimElementIdx = 0; + for (const auto& lowDimElem : lowDimElemData) + { + const bool isContained = [&lowDimElem, &bulkElemVertices] () + { + for (auto idx : lowDimElem) + if (findIndexInVector_(bulkElemVertices, idx) == invalidIndex) + return false; + return true; + } (); + + // insert in list if low dim element is in bulk element + if (isContained) + lowDimElemIndices.push_back(lowDimElementIdx); + + // keep track of the low dim element insertion index + lowDimElementIdx++; + } + + return lowDimElemIndices; + } + + /*! + * \brief Returns the local index of a given value in a given vector + */ + template<typename IdxType1, typename IdxType2> + static int findIndexInVector_(const std::vector<IdxType1>& vector, const IdxType2 globalIdx) + { + auto it = std::find(vector.begin(), vector.end(), globalIdx); + + // we use the -5 here to detect whether or not an index exists already + if (it != vector.end()) + return std::distance(vector.begin(), it); + else + return invalidIndex; + } + + /*! + * \brief Returns the filename extension of a given filename + */ + static std::string getFileExtension_(const std::string& fileName) + { + std::size_t i = fileName.rfind('.', fileName.length()); + if (i != std::string::npos) + return(fileName.substr(i+1, fileName.length() - i)); + else + DUNE_THROW(Dune::IOError, "Please provide and extension for your grid file ('"<< fileName << "')!"); + } + + /*! + * \brief Turns a number in form of a string into a Scalar + */ + static Scalar stringToNumber_(const std::string& numberAsString) + { + Scalar value; + + std::stringstream stream(numberAsString); + stream >> value; + + if (stream.fail()) + { + std::runtime_error e(numberAsString); + throw e; + } + + return value; + } +}; + +} // end namespace + +#endif // DUMUX_GMSHDUALFACETGRIDCREATOR_HH diff --git a/dumux/mixeddimension/facet/mpfa/CMakeLists.txt b/dumux/mixeddimension/facet/mpfa/CMakeLists.txt new file mode 100644 index 0000000000000000000000000000000000000000..22c0ab9868fa789c48a0042e636e2d8bcb87cefe --- /dev/null +++ b/dumux/mixeddimension/facet/mpfa/CMakeLists.txt @@ -0,0 +1,10 @@ +install(FILES +couplingmanager.hh +couplingmapper.hh +darcyslaw.hh +fickslaw.hh +fourierslaw.hh +interactionvolume.hh +interiorboundarydata.hh +properties.hh +DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/mixeddimension/facet) \ No newline at end of file diff --git a/dumux/mixeddimension/facet/mpfa/couplingmanager.hh b/dumux/mixeddimension/facet/mpfa/couplingmanager.hh new file mode 100644 index 0000000000000000000000000000000000000000..6b6d65b0b0203f4ea1e902b47366a4659906ef3d --- /dev/null +++ b/dumux/mixeddimension/facet/mpfa/couplingmanager.hh @@ -0,0 +1,304 @@ +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * \ingroup FacetCoupling + * \brief Manages the coupling between bulk elements and lower dimensional elements on the element facets + */ + +#ifndef DUMUX_MIXEDDIMENSION_CCMPFA_FACET_COUPLINGMANAGER_HH +#define DUMUX_MIXEDDIMENSION_CCMPFA_FACET_COUPLINGMANAGER_HH + +#include <dumux/implicit/properties.hh> +#include <dumux/mixeddimension/facet/mpfa/couplingmapper.hh> + +namespace Dumux +{ + +/*! + * \ingroup FacetCoupling + * \brief Manages the interaction between the bulk and lower dimensional (facet) elements + */ +template<class TypeTag> +class CCMpfaFacetCouplingManager +{ + using Implementation = typename GET_PROP_TYPE(TypeTag, CouplingManager); + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using GlobalProblem = typename GET_PROP_TYPE(TypeTag, Problem); + using GridCreator = typename GET_PROP_TYPE(TypeTag, GridCreator); + + using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); + using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); + + using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); + using BulkElement = typename BulkGridView::template Codim<0>::Entity; + using BulkIntersection = typename BulkGridView::Intersection; + using BulkIndexType = typename BulkGridView::IndexSet::IndexType; + using BulkProblem = typename GET_PROP_TYPE(BulkProblemTypeTag, Problem); + using BulkMpfaHelper = typename GET_PROP_TYPE(BulkProblemTypeTag, MpfaHelper); + using BulkLocalResidual = typename GET_PROP_TYPE(BulkProblemTypeTag, LocalResidual); + using BulkPrimaryVariables = typename GET_PROP_TYPE(BulkProblemTypeTag, PrimaryVariables); + using BulkFVElementGeometry = typename GET_PROP_TYPE(BulkProblemTypeTag, FVElementGeometry); + using BulkSubControlVolumeFace = typename GET_PROP_TYPE(BulkProblemTypeTag, SubControlVolumeFace); + using BulkElementBoundaryTypes = typename GET_PROP_TYPE(BulkProblemTypeTag, ElementBoundaryTypes); + using BulkElementVolumeVariables = typename GET_PROP_TYPE(BulkProblemTypeTag, ElementVolumeVariables); + using BulkElementFluxVariablesCache = typename GET_PROP_TYPE(BulkProblemTypeTag, ElementFluxVariablesCache); + + using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); + using LowDimElement = typename LowDimGridView::template Codim<0>::Entity; + using LowDimIndexType = typename LowDimGridView::IndexSet::IndexType; + using LowDimProblem = typename GET_PROP_TYPE(LowDimProblemTypeTag, Problem); + using LowDimLocalResidual = typename GET_PROP_TYPE(LowDimProblemTypeTag, LocalResidual); + using LowDimPrimaryVariables = typename GET_PROP_TYPE(LowDimProblemTypeTag, PrimaryVariables); + using LowDimSubControlVolume = typename GET_PROP_TYPE(LowDimProblemTypeTag, SubControlVolume); + using LowDimFVElementGeometry = typename GET_PROP_TYPE(LowDimProblemTypeTag, FVElementGeometry); + using LowDimElementBoundaryTypes = typename GET_PROP_TYPE(LowDimProblemTypeTag, ElementBoundaryTypes); + using LowDimVolumeVariables = typename GET_PROP_TYPE(LowDimProblemTypeTag, VolumeVariables); + using LowDimElementVolumeVariables = typename GET_PROP_TYPE(LowDimProblemTypeTag, ElementVolumeVariables); + using LowDimElementFluxVariablesCache = typename GET_PROP_TYPE(LowDimProblemTypeTag, ElementFluxVariablesCache); + + static constexpr int dimWorld = BulkGridView::dimensionworld; + static constexpr int lowDimDimWorld = LowDimGridView::dimensionworld; + static_assert(dimWorld == lowDimDimWorld, "dimWorld cannot be different for the two sub-domains!"); + + using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; + +public: + + /*! + * \brief Constructor + */ + CCMpfaFacetCouplingManager(BulkProblem& bulkProblem, LowDimProblem& lowDimProblem) + : bulkProblemPtr_(&bulkProblem), + lowDimProblemPtr_(&lowDimProblem), + couplingMapper_(bulkProblem, lowDimProblem) + { + // initialize the local residuals + bulkLocalResidual_.init(bulkProblem); + lowDimLocalResidual_.init(lowDimProblem); + } + + void preInit() {} + + void postInit() + { + // abfrage ob no flow tip?? + couplingMapper_.init(); + } + + //! evaluates if an intersection is on an interior boundary + bool isInteriorBoundary(const BulkElement& element, const BulkIntersection& is) const + { + // TODO: Facet elements that are on the bulk domain boundary + if (is.boundary()) + return false; + + const auto insideIdx = bulkProblem().elementMapper().index(element); + const auto outsideIdx = bulkProblem().elementMapper().index(is.outside()); + return isInteriorBoundary_(insideIdx, outsideIdx); + } + + //! evaluates if an scvf is on an interior boundary + bool isInteriorBoundary(const BulkElement& element, const BulkSubControlVolumeFace& scvf) const + { + // TODO: Facet elements that are on the bulk domain boundary + if (scvf.boundary()) + return false; + + if (couplingMapper_.isInitialized()) + { + const auto& couplingData = couplingMapper_.getBulkCouplingData(element); + + // if the element is coupled, check if the scvf is so as well + if (!couplingData.isCoupled) + return false; + return couplingData.getScvfCouplingData(scvf).first; + } + + // If the mapper has not been initialized yet, use the private function + return isInteriorBoundary_(scvf.insideScvIdx(), scvf.outsideScvIdx()); + } + + const std::vector<LowDimIndexType>& couplingStencil(const BulkElement& element) + { return couplingMapper_.getBulkCouplingData(element).couplingStencil; } + + const std::vector<BulkIndexType>& couplingStencil(const LowDimElement& element) + { return couplingMapper_.getLowDimCouplingData(element).couplingStencil; } + + //! evaluate coupling residual for the derivative bulk DOF with respect to low dim DOF + //! we only need to evaluate the part of the residual that will be influence by the low dim DOF + BulkPrimaryVariables evalCouplingResidual(const BulkElement& element, + const BulkFVElementGeometry& fvGeometry, + const BulkElementVolumeVariables& curElemVolVars, + const BulkElementBoundaryTypes& elemBcTypes, + const BulkElementFluxVariablesCache& elemFluxVarsCache, + const LowDimElement& lowDimElement) + { + const auto& couplingData = couplingMapper_.getBulkCouplingData(element); + + if (!couplingData.isCoupled) + return BulkPrimaryVariables(0.0); + + // calculate the local residual of the bulk element + auto prevElemVolVars = localView(bulkProblem().model().prevGlobalVolVars()); + prevElemVolVars.bindElement(element, fvGeometry, bulkProblem().model().prevSol()); + bulkLocalResidual_.eval(element, fvGeometry, prevElemVolVars, curElemVolVars, elemBcTypes, elemFluxVarsCache); + return bulkLocalResidual_.residual(0); + } + + //! evaluate coupling residual for the derivative low dim DOF with respect to bulk DOF + //! we only need to evaluate the part of the residual that will be influence by the bulk DOF + LowDimPrimaryVariables evalCouplingResidual(const LowDimElement& element, + const LowDimFVElementGeometry& fvGeometry, + const LowDimElementVolumeVariables& curElemVolVars, + const LowDimElementBoundaryTypes& elemBcTypes, + const LowDimElementFluxVariablesCache& elemFluxVarsCache, + const BulkElement& bulkElement) + { + const auto& couplingData = couplingMapper_.getLowDimCouplingData(element); + + if (!couplingData.isCoupled) + return LowDimPrimaryVariables(0.0); + + // calculate the source term of the low dim element + const auto eIdx = lowDimProblem().elementMapper().index(element); + const auto& scv = fvGeometry.scv(eIdx); + + auto source = lowDimLocalResidual_.computeSource(element, fvGeometry, curElemVolVars, scv); + source *= -scv.volume()*curElemVolVars[scv].extrusionFactor(); + return source; + } + + //! evaluates the sources in the low dim domain coming from the bulk domain + //! i.e. the fluxes from the bulk domain into the given low dim element. We return bulk priVars here, + //! the low dim problem itself needs to transform that into suitable information + BulkPrimaryVariables evalSourcesFromBulk(const LowDimElement& element, + const LowDimFVElementGeometry& fvGeometry, + const LowDimElementVolumeVariables& curElemVolVars, + const LowDimSubControlVolume& scv) const + { + const auto& couplingData = couplingMapper_.getLowDimCouplingData(element); + + if (!couplingData.isCoupled) + return BulkPrimaryVariables(0.0); + + // evaluate the fluxes over each scvf in each bulk neighbor. Prepare the local views + // of the first element, the necessary quantities for all the scvfs will be in there, + // as the scvfs in the other elements are the "flipped" scvfs of the ones in the first element + const auto& firstPair = couplingData.elementScvfList[0]; + const auto firstBulkElement = bulkProblem().model().globalFvGeometry().element(firstPair.first); + + auto bulkFvGeometry = localView(bulkProblem().model().globalFvGeometry()); + bulkFvGeometry.bind(firstBulkElement); + + auto bulkElemVolVars = localView(bulkProblem().model().curGlobalVolVars()); + bulkElemVolVars.bind(firstBulkElement, bulkFvGeometry, bulkProblem().model().curSol()); + + auto bulkElemFluxVarsCache = localView(bulkProblem().model().globalFluxVarsCache()); + bulkElemFluxVarsCache.bind(firstBulkElement, bulkFvGeometry, bulkElemVolVars); + + BulkPrimaryVariables flux(0.0); + for (const auto& pair : couplingData.elementScvfList) + { + const auto bulkElement = bulkProblem().model().globalFvGeometry().element(pair.first); + for (auto scvfIdx : pair.second) + flux += bulkLocalResidual_.computeFlux(bulkElement, + bulkFvGeometry, + bulkElemVolVars, + bulkFvGeometry.scvf(scvfIdx), + bulkElemFluxVarsCache); + } + + // The source has to be formulated per volume + flux /= scv.volume()*curElemVolVars[scv].extrusionFactor(); + return flux; + } + + //! Compute lowDim volume variables for given bulk element and scvf + LowDimVolumeVariables lowDimVolVars(const BulkElement& element, + const BulkFVElementGeometry& fvGeometry, + const BulkSubControlVolumeFace& scvf) const + { + const auto& scvfCouplingData = couplingMapper_.getBulkCouplingData(element).getScvfCouplingData(scvf); + + assert(scvfCouplingData.first && "no coupled facet element found for given scvf!"); + const auto lowDimElement = lowDimProblem().model().globalFvGeometry().element(scvfCouplingData.second); + auto lowDimFvGeometry = localView(lowDimProblem().model().globalFvGeometry()); + lowDimFvGeometry.bindElement(lowDimElement); + + const auto& lowDimCurSol = lowDimProblem().model().curSol(); + LowDimVolumeVariables lowDimVolVars; + lowDimVolVars.update(lowDimProblem().model().elementSolution(lowDimElement, lowDimCurSol), + lowDimProblem(), + lowDimElement, + lowDimFvGeometry.scv(scvfCouplingData.second)); + return lowDimVolVars; + } + + const BulkProblem& bulkProblem() const + { return *bulkProblemPtr_; } + + const LowDimProblem& lowDimProblem() const + { return *lowDimProblemPtr_; } + + const CCMpfaFacetCouplingMapper<TypeTag>& couplingMapper() const + { return couplingMapper_; } + +private: + + //! evaluates if there is an interior boundary between two bulk elements + bool isInteriorBoundary_(BulkIndexType eIdxInside, BulkIndexType eIdxOutside) const + { + for (const auto& lowDimElement : elements(lowDimProblem().gridView())) + { + // The indices of bulk elements in which the actual low dim element is a facet + const auto& bulkElementIndices = GridCreator::getCoupledBulkElementIndices(lowDimElement); + + // if inside & outside element are contained in them, this is a "coupling" intersection + if (BulkMpfaHelper::contains(bulkElementIndices, eIdxInside) && BulkMpfaHelper::contains(bulkElementIndices, eIdxOutside)) + return true; + } + + return false; + } + + BulkProblem& bulkProblem() + { return *bulkProblemPtr_; } + + LowDimProblem& lowDimProblem() + { return *lowDimProblemPtr_; } + + //! Returns the implementation of the problem (i.e. static polymorphism) + Implementation &asImp_() + { return *static_cast<Implementation *>(this); } + + //! \copydoc asImp_() + const Implementation &asImp_() const + { return *static_cast<const Implementation *>(this); } + + BulkProblem *bulkProblemPtr_; + LowDimProblem *lowDimProblemPtr_; + + mutable BulkLocalResidual bulkLocalResidual_; + mutable LowDimLocalResidual lowDimLocalResidual_; + + CCMpfaFacetCouplingMapper<TypeTag> couplingMapper_; +}; + +} // end namespace + +#endif // DUMUX_FACETCOUPLINGMANAGER_HH diff --git a/dumux/mixeddimension/facet/mpfa/couplingmapper.hh b/dumux/mixeddimension/facet/mpfa/couplingmapper.hh new file mode 100644 index 0000000000000000000000000000000000000000..83168983a741f74feea4fe70303a0fc4c98d953e --- /dev/null +++ b/dumux/mixeddimension/facet/mpfa/couplingmapper.hh @@ -0,0 +1,257 @@ +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * \ingroup Facet + * \brief Creates mappings of the entities from the bulk and the facet subdomain + */ + +#ifndef DUMUX_MIXEDDIMENSION_CCMPFA_FACET_COUPLINGMAPPER_HH +#define DUMUX_MIXEDDIMENSION_CCMPFA_FACET_COUPLINGMAPPER_HH + +#include <dune/common/version.hh> +#include <dune/grid/common/mcmgmapper.hh> +#include <dune/grid/common/gridfactory.hh> + +#include <dumux/common/math.hh> +#include <dumux/common/propertysystem.hh> +#include <dumux/common/parameters.hh> +#include <dumux/common/valgrind.hh> + +namespace Dumux +{ + +namespace Properties +{ +NEW_PROP_TAG(Scalar); +NEW_PROP_TAG(BulkProblemTypeTag); +NEW_PROP_TAG(LowDimProblemTypeTag); +} + +/*! + * \ingroup FacetCoupling + * \brief Creates mappings of the entities from the bulk and the facet subdomain + */ +template<class TypeTag> +class CCMpfaFacetCouplingMapper +{ + using GridCreator = typename GET_PROP_TYPE(TypeTag, GridCreator); + + using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); + using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); + + using BulkProblem = typename GET_PROP_TYPE(BulkProblemTypeTag, Problem); + using LowDimProblem = typename GET_PROP_TYPE(LowDimProblemTypeTag, Problem); + + using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); + using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); + + using BulkIndexType = typename BulkGridView::IndexSet::IndexType; + using LowDimIndexType = typename LowDimGridView::IndexSet::IndexType; + + using BulkElement = typename BulkGridView::template Codim<0>::Entity; + using LowDimElement = typename LowDimGridView::template Codim<0>::Entity; + + using BulkSubControlVolumeFace = typename GET_PROP_TYPE(BulkProblemTypeTag, SubControlVolumeFace); + using BulkMpfaHelper = typename GET_PROP_TYPE(BulkProblemTypeTag, MpfaHelper); + + static constexpr int lowDimDim = LowDimGridView::dimension; + +public: + + struct BulkDataInLowDim + { + // indicates whether or not this element is coupled + bool isCoupled; + + // The list of bulk element indices connected to a low dim element + std::vector<BulkIndexType> couplingStencil; + + // We store for each directly connected element a list of + // global scvf indices over which the two domains are coupled + std::vector<std::pair<BulkIndexType, std::vector<BulkIndexType>>> elementScvfList; + + // The constructor + BulkDataInLowDim() : isCoupled(false) {} + }; + + struct LowDimDataInBulk + { + // indicates whether or not this element is coupled + bool isCoupled; + + // The list of low dim elements with influence on this bulk element + std::vector<LowDimIndexType> couplingStencil; + + // to each scvf of the bulk element we store + // the low dim element index that it is connected to + std::vector<std::pair<BulkIndexType, LowDimIndexType>> scvfToLowDimData; + + // The constructor + LowDimDataInBulk() : isCoupled(false) {} + + // For a given scvf of the element this method returns a pair of a bool and an index. The boolean + // indicates if this scvf does couple to a low dim element, the index is the low dim element index + std::pair<bool, LowDimIndexType> getScvfCouplingData(const BulkSubControlVolumeFace& scvf) const + { return getScvfCouplingData(scvf.index()); } + + std::pair<bool, LowDimIndexType> getScvfCouplingData(BulkIndexType scvfIdx) const + { + for (const auto& pair : scvfToLowDimData) + if (pair.first == scvfIdx) + return std::make_pair(true, pair.second); + return std::make_pair(false, 0); + } + }; + + //! The constructor + CCMpfaFacetCouplingMapper(BulkProblem &bulkProblem, LowDimProblem &lowDimProblem) + : isInitialized_(false), + bulkProblemPtr_(&bulkProblem), + lowDimProblemPtr_(&lowDimProblem) + {} + + /*! + * \brief initializes the maps + * + * \param bulkProblem The bulk sub problem + * \param lowDimProblem The lower-dimensional sub problem + */ + void init() + { + const auto& bulkGridView = bulkProblem_().gridView(); + const auto& lowDimGridView = lowDimProblem_().gridView(); + + lowDimCouplingData_.resize(lowDimGridView.size(0)); + bulkCouplingData_.resize(bulkGridView.size(0)); + + for (const auto& lowDimElement : elements(lowDimGridView)) + { + const auto lowDimElementGlobalIdx = lowDimProblem_().elementMapper().index(lowDimElement); + + // The indices of bulk elements in which the actual low dim element is a facet + const auto& bulkElementIndices = GridCreator::getCoupledBulkElementIndices(lowDimElement); + if (bulkElementIndices.size() > 1) + { + lowDimCouplingData_[lowDimElementGlobalIdx].isCoupled = true; + + for (auto bulkElementIdx : bulkElementIndices) + { + bulkCouplingData_[bulkElementIdx].isCoupled = true; + + const auto bulkElement = bulkProblem_().model().globalFvGeometry().element(bulkElementIdx); + auto bulkFvGeometry = localView(bulkProblem_().model().globalFvGeometry()); + bulkFvGeometry.bindElement(bulkElement); + + // find the scvfs in the bulk element that "touch" the facet element + std::vector<BulkIndexType> scvfIndices; + for (const auto& scvf : scvfs(bulkFvGeometry)) + { + if (scvf.boundary()) + continue; + + const auto anyOtherIdx = bulkElementIndices[0] == bulkElementIdx ? + bulkElementIndices[1] : + bulkElementIndices[0]; + + // check if any of the other bulk indices is in the outside indices of the scvf + if (BulkMpfaHelper::contains(scvf.outsideScvIndices(), anyOtherIdx)) + { + scvfIndices.push_back(scvf.index()); + + // add data to the bulk data map + bulkCouplingData_[bulkElementIdx].scvfToLowDimData.emplace_back(std::make_pair(scvf.index(), lowDimElementGlobalIdx)); + + // also, insert scvf stencil to the coupling stencil of the low dim element + const auto scvfStencil = [&] () + { + if (bulkProblem_().model().globalFvGeometry().isInBoundaryInteractionVolume(scvf)) + return bulkProblem_().model().globalFvGeometry().boundaryInteractionVolumeSeed(scvf).globalScvIndices(); + else + return bulkProblem_().model().globalFvGeometry().interactionVolumeSeed(scvf).globalScvIndices(); + } (); + + auto& lowDimCouplingStencil = lowDimCouplingData_[lowDimElementGlobalIdx].couplingStencil; + lowDimCouplingStencil.insert(lowDimCouplingStencil.end(), scvfStencil.begin(), scvfStencil.end()); + + // also, all the bulk elements in the scvf stencil will be coupled to the actual low dim element + for (auto bulkIdx : scvfStencil) + { + bulkCouplingData_[bulkIdx].isCoupled = true; + bulkCouplingData_[bulkIdx].couplingStencil.push_back(lowDimElementGlobalIdx); + } + } + } + + // insert data into the low dim map + lowDimCouplingData_[lowDimElementGlobalIdx].elementScvfList.emplace_back(std::make_pair(bulkElementIdx, std::move(scvfIndices))); + } + } + else if (bulkElementIndices.size() == 1) + DUNE_THROW(Dune::NotImplemented, "Coupled facet elements on the bulk boundary"); + + // make the coupling stencil of the low dim element unique + auto& stencil = lowDimCouplingData_[lowDimElementGlobalIdx].couplingStencil; + std::sort(stencil.begin(), stencil.end()); + stencil.erase(std::unique(stencil.begin(), stencil.end()), stencil.end()); + } + + // make the coupling stencils in the bulk map unique + for (auto& data : bulkCouplingData_) + { + auto& stencil = data.couplingStencil; + std::sort(stencil.begin(), stencil.end()); + stencil.erase(std::unique(stencil.begin(), stencil.end()), stencil.end()); + } + + // state the initialization status + isInitialized_ = true; + } + + const LowDimDataInBulk& getBulkCouplingData(const BulkElement& bulkElement) const + { return getBulkCouplingData(bulkProblem_().elementMapper().index(bulkElement)); } + + const LowDimDataInBulk& getBulkCouplingData(BulkIndexType bulkElementIdx) const + { return bulkCouplingData_[bulkElementIdx]; } + + const BulkDataInLowDim& getLowDimCouplingData(const LowDimElement& lowDimElement) const + { return getLowDimCouplingData(lowDimProblem_().elementMapper().index(lowDimElement)); } + + const BulkDataInLowDim& getLowDimCouplingData(LowDimIndexType lowDimElementIdx) const + { return lowDimCouplingData_[lowDimElementIdx]; } + + bool isInitialized() const + { return isInitialized_; } + +private: + const BulkProblem& bulkProblem_() const + { return *bulkProblemPtr_; } + + const LowDimProblem& lowDimProblem_() const + { return *lowDimProblemPtr_; } + + bool isInitialized_; + const BulkProblem* bulkProblemPtr_; + const LowDimProblem* lowDimProblemPtr_; + + std::vector<LowDimDataInBulk> bulkCouplingData_; + std::vector<BulkDataInLowDim> lowDimCouplingData_; +}; + +} // end namespace + +#endif // DUMUX_FACETCOUPLINGMAPPER_HH diff --git a/dumux/mixeddimension/facet/mpfa/darcyslaw.hh b/dumux/mixeddimension/facet/mpfa/darcyslaw.hh new file mode 100644 index 0000000000000000000000000000000000000000..e8c4a64218aef387d9bdc519bf80934e9072cced --- /dev/null +++ b/dumux/mixeddimension/facet/mpfa/darcyslaw.hh @@ -0,0 +1,288 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * \brief This file contains the data which is required to calculate volume and mass fluxes of + * fluid phases over a face of a finite volume by means of the Darcy approximation in the + * presence of lower dimensional (coupled) elements living on the this domain's element facets. + */ +#ifndef DUMUX_DISCRETIZATION_CC_MPFA_FACET_DARCYS_LAW_HH +#define DUMUX_DISCRETIZATION_CC_MPFA_FACET_DARCYS_LAW_HH + +#include <dumux/discretization/cellcentered/mpfa/darcyslaw.hh> +#include <dumux/discretization/cellcentered/mpfa/facetypes.hh> + +namespace Dumux +{ + +/*! + * \ingroup DarcysLaw + * \brief Specialization of Darcy's Law for the CCMpfa method with lower dimensional + * elements living on the bulk elements' facets. + */ +template <class TypeTag> +class CCMpfaFacetCouplingDarcysLaw : public DarcysLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> +{ + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Element = typename GridView::template Codim<0>::Entity; + using MpfaHelper = typename GET_PROP_TYPE(TypeTag, MpfaHelper); + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); + using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); + using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables); + using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); + using ElementFluxVariablesCache = typename GET_PROP_TYPE(TypeTag, ElementFluxVariablesCache); + using FluxVariablesCache = typename GET_PROP_TYPE(TypeTag, FluxVariablesCache); + using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); + + // Always use the dynamic type for vectors (compatibility with the boundary) + using BoundaryInteractionVolume = typename GET_PROP_TYPE(TypeTag, BoundaryInteractionVolume); + using CoefficientVector = typename BoundaryInteractionVolume::Vector; + + static constexpr int numPhases = GET_PROP_VALUE(TypeTag, NumPhases); + static constexpr bool useTpfaBoundary = GET_PROP_VALUE(TypeTag, UseTpfaBoundary); + static constexpr bool enableInteriorBoundaries = GET_PROP_VALUE(TypeTag, EnableInteriorBoundaries); + + //! The cache used in conjunction with the mpfa Darcy's Law + class MpfaFacetCouplingDarcysLawCache + { + // We always use the dynamic types here to be compatible on the boundary + using Stencil = typename BoundaryInteractionVolume::GlobalIndexSet; + using PositionVector = typename BoundaryInteractionVolume::PositionVector; + + public: + //! update cached objects + template<class InteractionVolume> + void updateAdvection(const InteractionVolume& iv, const SubControlVolumeFace &scvf) + { + const auto& localFaceData = iv.getLocalFaceData(scvf); + // update the quantities that are equal for all phases + advectionVolVarsStencil_ = iv.volVarsStencil(); + advectionVolVarsPositions_ = iv.volVarsPositions(); + advectionTij_ = iv.getTransmissibilities(localFaceData); + + // we will need the neumann flux transformation on interior Neumann boundaries + advectionCij_ = iv.getNeumannFluxTransformationCoefficients(localFaceData); + + // The neumann fluxes always have to be set per phase + for (unsigned int phaseIdx = 0; phaseIdx < numPhases; ++phaseIdx) + phaseNeumannFluxes_[phaseIdx] = iv.getNeumannFlux(localFaceData, phaseIdx); + } + + //! Returns the volume variables indices necessary for flux computation + //! This includes all participating boundary volume variables. Since we + //! do not allow mixed BC for the mpfa this is the same for all phases. + const Stencil& advectionVolVarsStencil() const + { return advectionVolVarsStencil_; } + + //! Returns the position on which the volume variables live. This is + //! necessary as we need to evaluate gravity also for the boundary volvars + const PositionVector& advectionVolVarsPositions() const + { return advectionVolVarsPositions_; } + + //! Returns the transmissibilities associated with the volume variables + //! All phases flow through the same rock, thus, tij are equal for all phases + const CoefficientVector& advectionTij() const + { return advectionTij_; } + + //! Returns the vector of coefficients with which the vector of neumann boundary conditions + //! has to be multiplied in order to transform them on the scvf this cache belongs to + const CoefficientVector& advectionCij() const + { return advectionCij_; } + + //! If the useTpfaBoundary property is set to false, the boundary conditions + //! are put into the local systems leading to possible contributions on all faces + Scalar advectionNeumannFlux(unsigned int phaseIdx) const + { return phaseNeumannFluxes_[phaseIdx]; } + + private: + // Quantities associated with advection + Stencil advectionVolVarsStencil_; + PositionVector advectionVolVarsPositions_; + CoefficientVector advectionTij_; + CoefficientVector advectionCij_; + std::array<Scalar, numPhases> phaseNeumannFluxes_; + }; + +public: + // state the discretization method this implementation belongs to + static const DiscretizationMethods myDiscretizationMethod = DiscretizationMethods::CCMpfa; + + // state the new type for the corresponding cache + using Cache = MpfaFacetCouplingDarcysLawCache; + + static Scalar flux(const Problem& problem, + const Element& element, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolumeFace& scvf, + const unsigned int phaseIdx, + const ElementFluxVariablesCache& elemFluxVarsCache) + { + static const bool gravity = GET_PARAM_FROM_GROUP(TypeTag, bool, Problem, EnableGravity); + + const auto& fluxVarsCache = elemFluxVarsCache[scvf]; + const auto& volVarsStencil = fluxVarsCache.advectionVolVarsStencil(); + const auto& volVarsPositions = fluxVarsCache.advectionVolVarsPositions(); + const auto& tij = fluxVarsCache.advectionTij(); + + const bool isInteriorBoundary = enableInteriorBoundaries && fluxVarsCache.isInteriorBoundary(); + + // Calculate the interface density for gravity evaluation + const auto rho = interpolateDensity(fvGeometry, elemVolVars, scvf, fluxVarsCache, phaseIdx, isInteriorBoundary); + + // calculate Tij*pj + Scalar flux(0.0); + unsigned int localIdx = 0; + for (const auto volVarIdx : volVarsStencil) + { + const auto& volVars = elemVolVars[volVarIdx]; + Scalar h = volVars.pressure(phaseIdx); + + // if gravity is enabled, add gravitational acceleration + if (gravity) + { + // gravitational acceleration in the center of the actual element + const auto x = volVarsPositions[localIdx]; + const auto g = problem.gravityAtPos(x); + + h -= rho*(g*x); + } + + flux += tij[localIdx++]*h; + } + + // if no interior boundaries are present, return the flux + if (!enableInteriorBoundaries) + return useTpfaBoundary ? flux : flux + fluxVarsCache.advectionNeumannFlux(phaseIdx); + + // Handle interior boundaries + flux += computeInteriorBoundaryContribution(problem, fvGeometry, elemVolVars, fluxVarsCache, phaseIdx, rho); + + // return overall resulting flux + return useTpfaBoundary ? flux : flux + fluxVarsCache.advectionNeumannFlux(phaseIdx); + } + + static Scalar interpolateDensity(const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolumeFace& scvf, + const FluxVariablesCache& fluxVarsCache, + const unsigned int phaseIdx, + const bool isInteriorBoundary) + { + static const bool gravity = GET_PARAM_FROM_GROUP(TypeTag, bool, Problem, EnableGravity); + + if (!gravity) + return Scalar(0.0); + else + { + // Return facet density on interior boundaries + if (isInteriorBoundary) + return fluxVarsCache.interiorBoundaryDataSelf().facetVolVars(fvGeometry).density(phaseIdx); + + // use arithmetic mean of the densities around the scvf + if (!scvf.boundary()) + { + Scalar rho = elemVolVars[scvf.insideScvIdx()].density(phaseIdx); + for (auto outsideIdx : scvf.outsideScvIndices()) + rho += elemVolVars[outsideIdx].density(phaseIdx); + return rho/(scvf.outsideScvIndices().size()+1); + } + else + return elemVolVars[scvf.outsideScvIdx()].density(phaseIdx); + } + } + + static Scalar computeInteriorBoundaryContribution(const Problem& problem, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const FluxVariablesCache& fluxVarsCache, + unsigned int phaseIdx, Scalar rho) + { + static const bool gravity = GET_PARAM_FROM_GROUP(TypeTag, bool, Problem, EnableGravity); + + // obtain the transmissibilites associated with all pressures + const auto& tij = fluxVarsCache.advectionTij(); + + // the interior dirichlet boundaries local indices start after + // the cell and the domain Dirichlet boundary pressures + const auto startIdx = fluxVarsCache.advectionVolVarsStencil().size(); + + // The vector of interior neumann fluxes + const auto& cij = fluxVarsCache.advectionCij(); + CoefficientVector facetCouplingFluxes(cij.size(), 0.0); + + // add interior Dirichlet boundary contributions + Scalar flux = 0.0; + for (auto&& data : fluxVarsCache.interiorBoundaryData()) + { + // Add additional Dirichlet fluxes for interior Dirichlet faces + if (data.faceType() == MpfaFaceTypes::interiorDirichlet) + { + Scalar h = data.facetVolVars(fvGeometry).pressure(phaseIdx); + + if (gravity) + { + const auto x = fvGeometry.scvf(data.scvfIndex()).ipGlobal(); + const auto g = problem.gravityAtPos(x); + + h -= rho*(g*x); + } + + flux += tij[startIdx + data.localIndexInInteractionVolume()]*h; + } + + // add neumann contributions + if (data.faceType() == MpfaFaceTypes::interiorNeumann) + { + // get the scvf corresponding to actual interior neumann face + const auto& curScvf = fvGeometry.scvf(data.scvfIndex()); + + // get the volvars of the actual interior neumann face + const auto facetVolVars = data.facetVolVars(fvGeometry, curScvf); + + // calculate "leakage factor" + const auto n = curScvf.unitOuterNormal(); + const auto v = [&] () + { + auto res = n; + res *= -0.5*facetVolVars.extrusionFactor(); + res += curScvf.ipGlobal(); + res -= curScvf.facetCorner(); + res /= res.two_norm2(); + return res; + } (); + + // add value to vector of interior neumann fluxes + facetCouplingFluxes[data.localIndexInInteractionVolume()] += facetVolVars.pressure(phaseIdx)* + curScvf.area()* + elemVolVars[curScvf.insideScvIdx()].extrusionFactor()* + MpfaHelper::nT_M_v(n, facetVolVars.permeability(), v); + } + } + + return flux + cij*facetCouplingFluxes; + } +}; + +} // end namespace + +#endif diff --git a/dumux/mixeddimension/facet/mpfa/fickslaw.hh b/dumux/mixeddimension/facet/mpfa/fickslaw.hh new file mode 100644 index 0000000000000000000000000000000000000000..7a10ff2cd1075e09d8121fe8b1b5269e476d9c1e --- /dev/null +++ b/dumux/mixeddimension/facet/mpfa/fickslaw.hh @@ -0,0 +1,333 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * \brief This file contains the data which is required to calculate + * molar and mass fluxes of a component in a fluid phase over a face of a finite volume by means + * of Fick's Law for cell-centered MPFA models in the presence of lower dimensional (coupled) elements + * living on the this domain's element facets. + */ +#ifndef DUMUX_DISCRETIZATION_CC_MPFA_FACET_FICKS_LAW_HH +#define DUMUX_DISCRETIZATION_CC_MPFA_FACET_FICKS_LAW_HH + +#include <dumux/discretization/cellcentered/mpfa/fickslaw.hh> +#include <dumux/discretization/cellcentered/mpfa/facetypes.hh> + +namespace Dumux +{ +/*! + * \ingroup CCMpfaFicksLaw + * \brief Specialization of Fick's Law for the CCMpfa method with lower dimensional + * elements living on the bulk elements' facets. + */ +template <class TypeTag> +class CCMpfaFacetCouplingFicksLaw : public FicksLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> +{ + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using MpfaHelper = typename GET_PROP_TYPE(TypeTag, MpfaHelper); + using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables); + using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using EffDiffModel = typename GET_PROP_TYPE(TypeTag, EffectiveDiffusivityModel); + using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); + using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); + using ElementFluxVariablesCache = typename GET_PROP_TYPE(TypeTag, ElementFluxVariablesCache); + using FluxVariablesCache = typename GET_PROP_TYPE(TypeTag, FluxVariablesCache); + + // Always use the dynamic type for vectors (compatibility with the boundary) + using BoundaryInteractionVolume = typename GET_PROP_TYPE(TypeTag, BoundaryInteractionVolume); + using CoefficientVector = typename BoundaryInteractionVolume::Vector; + + using Element = typename GridView::template Codim<0>::Entity; + using IndexType = typename GridView::IndexSet::IndexType; + + static constexpr int numPhases = GET_PROP_VALUE(TypeTag, NumPhases); + static constexpr bool useTpfaBoundary = GET_PROP_VALUE(TypeTag, UseTpfaBoundary); + static constexpr bool enableInteriorBoundaries = GET_PROP_VALUE(TypeTag, EnableInteriorBoundaries); + + //! The cache used in conjunction with the mpfa Fick's Law + class MpfaFacetCouplingFicksLawCache + { + static const int numComponents = GET_PROP_VALUE(TypeTag, NumComponents); + + // We always use the dynamic types here to be compatible on the boundary + using Stencil = typename BoundaryInteractionVolume::GlobalIndexSet; + using PositionVector = typename BoundaryInteractionVolume::PositionVector; + + public: + //! The constructor. Initializes the Neumann flux to zero + MpfaFacetCouplingFicksLawCache() { componentNeumannFluxes_.fill(0.0); } + + // update cached objects for the diffusive fluxes + template<typename InteractionVolume> + void updateDiffusion(const InteractionVolume& iv, const SubControlVolumeFace &scvf, + unsigned int phaseIdx, unsigned int compIdx) + { + const auto& localFaceData = iv.getLocalFaceData(scvf); + diffusionTij_[phaseIdx][compIdx] = iv.getTransmissibilities(localFaceData); + // get the stencil only for the first call + if (phaseIdx == 0 && compIdx == 0) + diffusionVolVarsStencil_ = iv.volVarsStencil(); + + // we will need the neumann flux transformation on interior Neumann boundaries + diffusionCij_[phaseIdx][compIdx] = iv.getNeumannFluxTransformationCoefficients(localFaceData); + + //! For compositional models, we associate neumann fluxes with the phases (main components) + //! This is done in the AdvectionCache. However, in single-phasic models we solve the phase AND + //! the component mass balance equations. Thus, in this case we have diffusive neumann contributions. + //! we assume compIdx = eqIdx + if (numPhases == 1 && phaseIdx != compIdx) + componentNeumannFluxes_[compIdx] = iv.getNeumannFlux(localFaceData, compIdx); + + } + + //! Returns the volume variables indices necessary for diffusive flux + //! computation. This includes all participating boundary volume variables + //! and it can be different for the phases & components. + const Stencil& diffusionVolVarsStencil(unsigned int phaseIdx, unsigned int compIdx) const + { return diffusionVolVarsStencil_; } + + //! Returns the transmissibilities associated with the volume variables + //! This can be different for the phases & components. + const CoefficientVector& diffusionTij(unsigned int phaseIdx, unsigned int compIdx) const + { return diffusionTij_[phaseIdx][compIdx]; } + + //! Returns the vector of coefficients with which the vector of neumann boundary conditions + //! has to be multiplied in order to transform them on the scvf this cache belongs to + const CoefficientVector& diffusionCij(unsigned int phaseIdx, unsigned int compIdx) const + { return diffusionCij_[phaseIdx][compIdx]; } + + //! If the useTpfaBoundary property is set to false, the boundary conditions + //! are put into the local systems leading to possible contributions on all faces + Scalar componentNeumannFlux(unsigned int compIdx) const + { + assert(numPhases == 1); + return componentNeumannFluxes_[compIdx]; + } + + private: + // Quantities associated with molecular diffusion + Stencil diffusionVolVarsStencil_; + std::array< std::array<CoefficientVector, numComponents>, numPhases> diffusionTij_; + std::array< std::array<CoefficientVector, numComponents>, numPhases> diffusionCij_; + + // diffusive neumann flux for single-phasic models + std::array<Scalar, numComponents> componentNeumannFluxes_; + }; + +public: + // state the discretization method this implementation belongs to + static const DiscretizationMethods myDiscretizationMethod = DiscretizationMethods::CCMpfa; + + // state the new type for the corresponding cache + using Cache = MpfaFacetCouplingFicksLawCache; + + static Scalar flux(const Problem& problem, + const Element& element, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolumeFace& scvf, + int phaseIdx, int compIdx, + const ElementFluxVariablesCache& elemFluxVarsCache, + bool useMoles = true) + { + const auto& fluxVarsCache = elemFluxVarsCache[scvf]; + const auto& volVarsStencil = fluxVarsCache.diffusionVolVarsStencil(phaseIdx, compIdx); + const auto& tij = fluxVarsCache.diffusionTij(phaseIdx, compIdx); + + const bool isInteriorBoundary = enableInteriorBoundaries && fluxVarsCache.isInteriorBoundary(); + + // get the scaling factor for the effective diffusive fluxes + const auto effFactor = computeEffectivityFactor(fvGeometry, elemVolVars, scvf, fluxVarsCache, phaseIdx, isInteriorBoundary); + + // if factor is zero, the flux will end up zero anyway + if (effFactor == 0.0) + return 0.0; + + // lambda functions depending on if we use mole or mass fractions + auto getX = [useMoles, phaseIdx, compIdx] (const auto& volVars) + { return useMoles ? volVars.moleFraction(phaseIdx, compIdx) : volVars.massFraction(phaseIdx, compIdx); }; + + auto getRho = [useMoles, phaseIdx] (const auto& volVars) + { return useMoles ? volVars.molarDensity(phaseIdx) : volVars.density(phaseIdx); }; + + // calculate the density at the interface + const auto rho = interpolateDensity(fvGeometry, elemVolVars, scvf, fluxVarsCache, getRho, isInteriorBoundary); + + // calculate Tij*xj + Scalar flux(0.0); + unsigned int localIdx = 0; + for (const auto volVarIdx : volVarsStencil) + flux += tij[localIdx++]*getX(elemVolVars[volVarIdx]); + + // if no interior boundaries are present, return effective mass flux + if (!enableInteriorBoundaries) + return useTpfaBoundary ? flux*rho*effFactor : flux*rho*effFactor + fluxVarsCache.componentNeumannFlux(compIdx); + + // Handle interior boundaries + flux += computeInteriorBoundaryContribution(fvGeometry, elemVolVars, fluxVarsCache, getX, phaseIdx, compIdx); + + // return overall resulting flux + return useTpfaBoundary ? flux*rho*effFactor : flux*rho*effFactor + fluxVarsCache.componentNeumannFlux(compIdx); + } + + template<typename GetRhoFunction> + static Scalar interpolateDensity(const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolumeFace& scvf, + const FluxVariablesCache& fluxVarsCache, + const GetRhoFunction& getRho, + const bool isInteriorBoundary) + { + + // maybe use the density of the interior BC on the facet + if (isInteriorBoundary) + return getRho(fluxVarsCache.interiorBoundaryDataSelf().facetVolVars(fvGeometry)); + + // use arithmetic mean of the densities around the scvf + if (!scvf.boundary()) + { + Scalar rho = getRho(elemVolVars[scvf.insideScvIdx()]); + for (auto outsideIdx : scvf.outsideScvIndices()) + rho += getRho(elemVolVars[outsideIdx]); + return rho/(scvf.outsideScvIndices().size()+1); + } + else + return getRho(elemVolVars[scvf.outsideScvIdx()]); + } + + //! Here we want to calculate the factors with which the diffusion coefficient has to be + //! scaled to get the effective diffusivity. For this we use the effective diffusivity with + //! a diffusion coefficient of 1.0 as input. Then we scale the transmissibilites during flux + //! calculation (above) with the harmonic average of the two factors + static Scalar computeEffectivityFactor(const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolumeFace& scvf, + const FluxVariablesCache& fluxVarsCache, + const unsigned int phaseIdx, + const bool isInteriorBoundary) + { + if (isInteriorBoundary) + { + // use harmonic mean between the interior and the facet volvars + const auto& data = fluxVarsCache.interiorBoundaryDataSelf(); + + const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; + const auto factor = EffDiffModel::effectiveDiffusivity(insideVolVars.porosity(), + insideVolVars.saturation(phaseIdx), + /*Diffusion coefficient*/ 1.0); + + const auto facetVolVars = data.facetVolVars(fvGeometry); + const auto outsideFactor = EffDiffModel::effectiveDiffusivity(facetVolVars.porosity(), + facetVolVars.saturation(phaseIdx), + /*Diffusion coefficient*/ 1.0); + + return harmonicMean(factor, outsideFactor); + } + + // use the harmonic mean between inside and outside + const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; + const auto factor = EffDiffModel::effectiveDiffusivity(insideVolVars.porosity(), + insideVolVars.saturation(phaseIdx), + /*Diffusion coefficient*/ 1.0); + + if (!scvf.boundary()) + { + // interpret outside factor as arithmetic mean + Scalar outsideFactor = 0.0; + for (auto outsideIdx : scvf.outsideScvIndices()) + { + const auto& outsideVolVars = elemVolVars[outsideIdx]; + outsideFactor += EffDiffModel::effectiveDiffusivity(outsideVolVars.porosity(), + outsideVolVars.saturation(phaseIdx), + /*Diffusion coefficient*/ 1.0); + } + outsideFactor /= scvf.outsideScvIndices().size(); + + // use the harmonic mean of the two + return harmonicMean(factor, outsideFactor); + } + + return factor; + } + + template<typename GetXFunction> + static Scalar computeInteriorBoundaryContribution(const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const FluxVariablesCache& fluxVarsCache, + const GetXFunction& getX, + unsigned int phaseIdx, unsigned int compIdx) + { + // obtain the transmissibilites associated with all pressures + const auto& tij = fluxVarsCache.diffusionTij(phaseIdx, compIdx); + + // the interior dirichlet boundaries local indices start after + // the cell and the domain Dirichlet boundary pressures + const auto startIdx = fluxVarsCache.diffusionVolVarsStencil(phaseIdx, compIdx).size(); + + // The vector of interior neumann fluxes + const auto& cij = fluxVarsCache.diffusionCij(phaseIdx, compIdx); + CoefficientVector facetCouplingFluxes(cij.size(), 0.0); + + // add interior Dirichlet boundary contributions + Scalar flux = 0.0; + for (auto&& data : fluxVarsCache.interiorBoundaryData()) + { + // Add additional Dirichlet fluxes for interior Dirichlet faces + if (data.faceType() == MpfaFaceTypes::interiorDirichlet) + flux += tij[startIdx + data.localIndexInInteractionVolume()]*getX(data.facetVolVars(fvGeometry)); + + // add neumann contributions + if (data.faceType() == MpfaFaceTypes::interiorNeumann) + { + // get the scvf corresponding to actual interior neumann face + const auto& curScvf = fvGeometry.scvf(data.scvfIndex()); + + // get the volvars of the actual interior neumann face + const auto facetVolVars = data.facetVolVars(fvGeometry, curScvf); + + // calculate "leakage factor" + const auto n = curScvf.unitOuterNormal(); + const auto v = [&] () + { + auto res = n; + res *= -0.5*facetVolVars.extrusionFactor(); + res += curScvf.ipGlobal(); + res -= curScvf.facetCorner(); + res /= res.two_norm2(); + return res; + } (); + + // add value to vector of interior neumann fluxes + facetCouplingFluxes[data.localIndexInInteractionVolume()] += getX(facetVolVars)* + curScvf.area()* + elemVolVars[curScvf.insideScvIdx()].extrusionFactor()* + MpfaHelper::nT_M_v(n, facetVolVars.diffusionCoefficient(phaseIdx, compIdx), v); + } + } + + return flux + cij*facetCouplingFluxes; + } +}; + +} // end namespace + +#endif diff --git a/dumux/mixeddimension/facet/mpfa/fourierslaw.hh b/dumux/mixeddimension/facet/mpfa/fourierslaw.hh new file mode 100644 index 0000000000000000000000000000000000000000..402ad57c4274b803a76c2a0d7f3d2422631ce33e --- /dev/null +++ b/dumux/mixeddimension/facet/mpfa/fourierslaw.hh @@ -0,0 +1,210 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * \brief This file contains the data which is required to calculate + * heat conduction fluxes with Fourier's law for cell-centered MPFA models + * in the presence of lower dimensional (coupled) elements living on this + * domain's element facets. + */ +#ifndef DUMUX_DISCRETIZATION_CC_MPFA_FACET_FOURIERS_LAW_HH +#define DUMUX_DISCRETIZATION_CC_MPFA_FACET_FOURIERS_LAW_HH + +#include <dumux/discretization/cellcentered/mpfa/fourierslaw.hh> +#include <dumux/discretization/cellcentered/mpfa/facetypes.hh> + +namespace Dumux +{ + +/*! + * \ingroup FouriersLaw + * \brief Specialization of Fourier's Law for the CCMpfa method with lower dimensional + * elements living on the bulk elements' facets. + */ +template <class TypeTag> +class CCMpfaFacetCouplingFouriersLaw : public FouriersLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> +{ + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using MpfaHelper = typename GET_PROP_TYPE(TypeTag, MpfaHelper); + using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); + using ElementFluxVarsCache = typename GET_PROP_TYPE(TypeTag, ElementFluxVariablesCache); + using FluxVariablesCache = typename GET_PROP_TYPE(TypeTag, FluxVariablesCache); + using ThermalConductivityModel = typename GET_PROP_TYPE(TypeTag, ThermalConductivityModel); + + // Always use the dynamic type for vectors (compatibility with the boundary) + using BoundaryInteractionVolume = typename GET_PROP_TYPE(TypeTag, BoundaryInteractionVolume); + using CoefficientVector = typename BoundaryInteractionVolume::Vector; + + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Element = typename GridView::template Codim<0>::Entity; + using IndexType = typename GridView::IndexSet::IndexType; + + static constexpr bool useTpfaBoundary = GET_PROP_VALUE(TypeTag, UseTpfaBoundary); + static constexpr bool enableInteriorBoundaries = GET_PROP_VALUE(TypeTag, EnableInteriorBoundaries); + + static constexpr int energyEqIdx = GET_PROP_TYPE(TypeTag, Indices)::energyEqIdx; + + //! The cache used in conjunction with the mpfa Fourier's Law + class MpfaFacetCouplingFouriersLawCache + { + using Stencil = typename BoundaryInteractionVolume::GlobalIndexSet; + public: + // update cached objects for heat conduction + template<typename InteractionVolume> + void updateHeatConduction(const InteractionVolume& iv, const SubControlVolumeFace &scvf) + { + const auto& localFaceData = iv.getLocalFaceData(scvf); + heatConductionVolVarsStencil_ = iv.volVarsStencil(); + heatConductionTij_ = iv.getTransmissibilities(localFaceData); + heatNeumannFlux_ = iv.getNeumannFlux(localFaceData, energyEqIdx); + heatConductionCij_ = iv.getNeumannFluxTransformationCoefficients(localFaceData); + } + + //! Returns the volume variables indices necessary for heat conduction flux + //! computation. This includes all participating boundary volume variables + //! and it can be different for the phases & components. + const Stencil& heatConductionVolVarsStencil() const + { return heatConductionVolVarsStencil_; } + + //! Returns the transmissibilities associated with the volume variables + //! This can be different for the phases & components. + const CoefficientVector& heatConductionTij() const + { return heatConductionTij_; } + + //! Returns the vector of coefficients with which the vector of neumann boundary conditions + //! has to be multiplied in order to transform them on the scvf this cache belongs to + const CoefficientVector& heatConductionCij() const + { return heatConductionCij_; } + + //! If the useTpfaBoundary property is set to false, the boundary conditions + //! are put into the local systems leading to possible contributions on all faces + Scalar heatNeumannFlux() const + { return heatNeumannFlux_; } + + private: + // Quantities associated with heat conduction + Stencil heatConductionVolVarsStencil_; + CoefficientVector heatConductionTij_; + CoefficientVector heatConductionCij_; + Scalar heatNeumannFlux_; + }; + +public: + // state the discretization method this implementation belongs to + static const DiscretizationMethods myDiscretizationMethod = DiscretizationMethods::CCMpfa; + + // state the new type for the corresponding cache + using Cache = MpfaFacetCouplingFouriersLawCache; + + static Scalar flux(const Problem& problem, + const Element& element, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolumeFace& scvf, + const ElementFluxVarsCache& elemFluxVarsCache) + { + const auto& fluxVarsCache = elemFluxVarsCache[scvf]; + const auto& volVarsStencil = fluxVarsCache.heatConductionVolVarsStencil(); + const auto& tij = fluxVarsCache.heatConductionTij(); + + // calculate Tij*tj + Scalar flux(0.0); + unsigned int localIdx = 0; + for (const auto volVarIdx : volVarsStencil) + flux += tij[localIdx++]*elemVolVars[volVarIdx].temperature(); + + // if no interior boundaries are present, return heat conduction flux + if (!enableInteriorBoundaries) + return useTpfaBoundary ? flux : flux + fluxVarsCache.heatNeumannFlux(); + + // Handle interior boundaries + flux += computeInteriorBoundaryContribution(fvGeometry, elemVolVars, fluxVarsCache); + + // return overall resulting flux + return useTpfaBoundary ? flux : flux + fluxVarsCache.heatNeumannFlux(); + } + + static Scalar computeInteriorBoundaryContribution(const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const FluxVariablesCache& fluxVarsCache) + { + // obtain the transmissibilites associated with all pressures + const auto& tij = fluxVarsCache.heatConductionTij(); + + // the interior dirichlet boundaries local indices start after + // the cell and the domain Dirichlet boundary pressures + const auto startIdx = fluxVarsCache.heatConductionVolVarsStencil().size(); + + // The vector of interior neumann fluxes + const auto& cij = fluxVarsCache.heatConductionCij(); + CoefficientVector facetCouplingFluxes(cij.size(), 0.0); + + // add interior Dirichlet boundary contributions + Scalar flux = 0.0; + for (auto&& data : fluxVarsCache.interiorBoundaryData()) + { + // Add additional Dirichlet fluxes for interior Dirichlet faces + if (data.faceType() == MpfaFaceTypes::interiorDirichlet) + flux += tij[startIdx + data.localIndexInInteractionVolume()]*data.facetVolVars(fvGeometry).temperature(); + + // add neumann contributions + if (data.faceType() == MpfaFaceTypes::interiorNeumann) + { + // get the scvf corresponding to actual interior neumann face + const auto& curScvf = fvGeometry.scvf(data.scvfIndex()); + + // get the volvars of the actual interior neumann face + const auto completeFacetData = data.completeCoupledFacetData(fvGeometry); + + // calculate "leakage factor" + const auto n = curScvf.unitOuterNormal(); + const auto v = [&] () + { + auto res = n; + res *= -0.5*completeFacetData.volVars().extrusionFactor(); + res += curScvf.ipGlobal(); + res -= curScvf.facetCorner(); + res /= res.two_norm2(); + return res; + } (); + + // get the thermal conductivity in the facet element + const auto facetLambda = ThermalConductivityModel::effectiveThermalConductivity(completeFacetData.volVars(), + completeFacetData.spatialParams(), + completeFacetData.element(), + completeFacetData.fvGeometry(), + completeFacetData.scv()); + // add value to vector of interior neumann fluxes + facetCouplingFluxes[data.localIndexInInteractionVolume()] += completeFacetData.volVars().temperature()* + curScvf.area()* + elemVolVars[curScvf.insideScvIdx()].extrusionFactor()* + MpfaHelper::nT_M_v(n, facetLambda, v); + } + } + + return flux + cij*facetCouplingFluxes; + } +}; + +} // end namespace Dumux + +#endif diff --git a/dumux/mixeddimension/facet/mpfa/interactionvolume.hh b/dumux/mixeddimension/facet/mpfa/interactionvolume.hh new file mode 100644 index 0000000000000000000000000000000000000000..a0831c8a92a69113433480d9861103dc26d9a062 --- /dev/null +++ b/dumux/mixeddimension/facet/mpfa/interactionvolume.hh @@ -0,0 +1,148 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * \brief Base classes for interaction volumes of mpfa models with active coupling over the element facets. + */ +#ifndef DUMUX_MIXEDDIMENSION_FACET_MPFA_O_INTERACTIONVOLUME_HH +#define DUMUX_MIXEDDIMENSION_FACET_MPFA_O_INTERACTIONVOLUME_HH + +#include <dumux/discretization/cellcentered/mpfa/interactionvolume.hh> +#include <dumux/discretization/cellcentered/mpfa/facetypes.hh> +#include <dumux/discretization/cellcentered/mpfa/methods.hh> + +namespace Dumux +{ +//! Forward declaration +template<class TypeTag> class CCMpfaOFacetCouplingInteractionVolume; + +//! Specialization of the interaction volume traits class for the o-method in coupled models +template<class TypeTag> +class CCMpfaOFacetCouplingInteractionVolumeTraits : public CCMpfaOInteractionVolumeTraits<TypeTag> +{ +public: + using BoundaryInteractionVolume = CCMpfaOFacetCouplingInteractionVolume<TypeTag>; +}; + +// the o-method interaction volume is substituted by the one including data on the facet element's +// tensorial quantities into the local system to be solved. +template<class TypeTag> +class CCMpfaOFacetCouplingInteractionVolume : public CCMpfaOInteractionVolume<TypeTag, + CCMpfaOFacetCouplingInteractionVolumeTraits<TypeTag>, + CCMpfaOFacetCouplingInteractionVolume<TypeTag>> +{ + using Traits = CCMpfaOFacetCouplingInteractionVolumeTraits<TypeTag>; + using ThisType = CCMpfaOFacetCouplingInteractionVolume<TypeTag>; + using ParentType = CCMpfaOInteractionVolume<TypeTag, Traits, ThisType>; + + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Element = typename GridView::template Codim<0>::Entity; + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using MpfaHelper = typename GET_PROP_TYPE(TypeTag, MpfaHelper); + using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); + using InteriorBoundaryData = typename GET_PROP_TYPE(TypeTag, InteriorBoundaryData); + using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); + + using LocalScvfType = typename Traits::LocalScvfType; + + static constexpr bool useTpfaBoundary = GET_PROP_VALUE(TypeTag, UseTpfaBoundary); + +public: + using typename ParentType::LocalIndexType; + using typename ParentType::Seed; + + CCMpfaOFacetCouplingInteractionVolume(const Seed& seed, + const Problem& problem, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars) + : ParentType(seed, problem, fvGeometry, elemVolVars) + {} + +public: + // We include data on the tensorial quantities of the facet elements here + template<typename GetTensorFunction> + Scalar interiorNeumannTerm(const GetTensorFunction& getTensor, + const Element& element, + const LocalScvfType& localScvf, + const InteriorBoundaryData& data) const + { + // obtain the complete data on the facet element + const auto completeFacetData = data.completeCoupledFacetData(this->fvGeometry_()); + + // calculate "leakage factor" + const auto n = localScvf.unitOuterNormal(); + const auto v = [&] () + { + auto res = n; + res *= -0.5*completeFacetData.volVars().extrusionFactor(); + res += localScvf.ip(); + res -= localScvf.globalScvf().facetCorner(); + res /= res.two_norm2(); + return res; + } (); + + // substract (n*T*v)*Area from diagonal matrix entry + const auto facetTensor = getTensor(completeFacetData.problem(), + completeFacetData.element(), + completeFacetData.volVars(), + completeFacetData.fvGeometry(), + completeFacetData.scv()); + + return localScvf.area()* + this->elemVolVars_()[localScvf.insideGlobalScvIndex()].extrusionFactor()* + MpfaHelper::nT_M_v(n, facetTensor, v); + } + + void assembleNeumannFluxVector() + { + // initialize the neumann fluxes vector to zero + this->neumannFluxes_.resize(this->fluxFaceIndexSet_.size(), PrimaryVariables(0.0)); + + if (!this->onDomainOrInteriorBoundary() || useTpfaBoundary) + return; + + LocalIndexType fluxFaceIdx = 0; + for (auto localFluxFaceIdx : this->fluxFaceIndexSet_) + { + const auto& localScvf = this->localScvf_(localFluxFaceIdx); + const auto faceType = localScvf.faceType(); + + if (faceType == MpfaFaceTypes::neumann) + { + const auto& element = this->localElement_(localScvf.insideLocalScvIndex()); + const auto& globalScvf = this->fvGeometry_().scvf(localScvf.insideGlobalScvfIndex()); + auto neumannFlux = this->problem_().neumann(element, this->fvGeometry_(), this->elemVolVars_(), globalScvf); + neumannFlux *= globalScvf.area(); + neumannFlux *= this->elemVolVars_()[globalScvf.insideScvIdx()].extrusionFactor(); + + // The flux is assumed to be prescribed in the form of -D*gradU + this->neumannFluxes_[fluxFaceIdx] = neumannFlux; + } + + fluxFaceIdx++; + } + } +}; + +} // end namespace + +#endif diff --git a/dumux/mixeddimension/facet/mpfa/interiorboundarydata.hh b/dumux/mixeddimension/facet/mpfa/interiorboundarydata.hh new file mode 100644 index 0000000000000000000000000000000000000000..6a0fe64c233a5aa1076e1d356ee28c20397c3ef0 --- /dev/null +++ b/dumux/mixeddimension/facet/mpfa/interiorboundarydata.hh @@ -0,0 +1,201 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * \brief A class to store info on interior boundaries + */ +#ifndef DUMUX_DISCRETIZATION_CC_MPFA_FACET_INTERIORBOUNDARYDATA_HH +#define DUMUX_DISCRETIZATION_CC_MPFA_FACET_INTERIORBOUNDARYDATA_HH + +#include <dumux/discretization/cellcentered/mpfa/facetypes.hh> +#include <dumux/mixeddimension/properties.hh> + +namespace Dumux +{ + +template<class TypeTag> +class CCMpfaFacetCouplingInteriorBoundaryData +{ + // types associated with the low dim domain + using GlobalProblemTypeTag = typename GET_PROP_TYPE(TypeTag, GlobalProblemTypeTag); + using LowDimProblemTypeTag = typename GET_PROP_TYPE(GlobalProblemTypeTag, LowDimProblemTypeTag); + + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Element = typename GridView::template Codim<0>::Entity; + using SpatialParams = typename GET_PROP_TYPE(TypeTag, SpatialParams); + using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables); + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); + using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); + using BoundaryInteractionVolume = typename GET_PROP_TYPE(TypeTag, BoundaryInteractionVolume); + + using IndexType = typename GridView::IndexSet::IndexType; + using LocalIndexType = typename BoundaryInteractionVolume::LocalIndexType; + + using LowDimProblem = typename GET_PROP_TYPE(LowDimProblemTypeTag, Problem); + using LowDimSpatialParams = typename GET_PROP_TYPE(LowDimProblemTypeTag, SpatialParams); + using LowDimVolumeVariables = typename GET_PROP_TYPE(LowDimProblemTypeTag, VolumeVariables); + using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); + using LowDimElement = typename LowDimGridView::template Codim<0>::Entity; + using LowDimFVElementGeometry = typename GET_PROP_TYPE(LowDimProblemTypeTag, FVElementGeometry); + using LowDimSubControlVolume = typename GET_PROP_TYPE(LowDimProblemTypeTag, SubControlVolume); + + //! Dummy type for the CompleteCoupledFacetData struct. + //! Implementations need to have at least the provided interfaces. + //! Note that the return types are also "wrong" (Here just to satisfy the compiler) + struct CompleteCoupledFacetData + { + const LowDimProblem& problem() const + { return *lowDimProblemPtr_; } + + const LowDimSpatialParams& spatialParams() const + { return *lowDimSpatialParamsPtr_; } + + const LowDimVolumeVariables& volVars() const + { return lowDimVolVars_; } + + const LowDimElement& element() const + { return lowDimElement_;} + + const LowDimFVElementGeometry& fvGeometry() const + { return lowDimFvGeometry_; } + + const LowDimSubControlVolume& scv() const + { return lowDimScv_; } + + CompleteCoupledFacetData(const LowDimProblem& problem, + const IndexType elementIndex, + LowDimElement&& element, + LowDimFVElementGeometry&& fvGeometry, + LowDimVolumeVariables&& volVars) + : lowDimProblemPtr_(&problem), + lowDimSpatialParamsPtr_(&problem.spatialParams()), + lowDimElement_(std::move(element)), + lowDimFvGeometry_(std::move(fvGeometry)), + lowDimVolVars_(std::move(volVars)), + lowDimScv_(lowDimFvGeometry_.scv(elementIndex)) + {} + + private: + const LowDimProblem* lowDimProblemPtr_; + const LowDimSpatialParams* lowDimSpatialParamsPtr_; + + LowDimElement lowDimElement_; + LowDimFVElementGeometry lowDimFvGeometry_; + LowDimVolumeVariables lowDimVolVars_; + const LowDimSubControlVolume& lowDimScv_; + }; + +public: + //! the constructor + CCMpfaFacetCouplingInteriorBoundaryData(const Problem& problem, + IndexType elementIndex, + IndexType scvfIndex, + LocalIndexType localIndex, + MpfaFaceTypes faceType) + : problemPtr_(&problem), + elementIndex_(elementIndex), + scvfIndex_(scvfIndex), + localIndex_(localIndex), + faceType_(faceType) + {} + + //! returns the global index of the element/scv connected to the interior boundary + IndexType elementIndex() const + { return elementIndex_; } + + //! returns the global index of the scvf connected to the interior boundary + IndexType scvfIndex() const + { return scvfIndex_; } + + //! returns the local index i of the scvf within the interaction volume. + //! This is either: + //! - the i-th flux face index (interior neumann boundaries) + //! - the i-th interior dirichlet face (interior dirichlet boundaries) + LocalIndexType localIndexInInteractionVolume() const + { return localIndex_; } + + //! returns the face type of this scvf + MpfaFaceTypes faceType() const + { return faceType_; } + + //! returns the volume variables for interior dirichlet boundaries + LowDimVolumeVariables facetVolVars(const FVElementGeometry& fvGeometry) const + { + return problem_().couplingManager().lowDimVolVars(problem_().model().globalFvGeometry().element(elementIndex()), + fvGeometry, + fvGeometry.scvf(scvfIndex())); + } + + //! returns the volume variables for interior dirichlet boundaries + LowDimVolumeVariables facetVolVars(const FVElementGeometry& fvGeometry, const SubControlVolumeFace& scvf) const + { + assert(scvf.index() == scvfIndex() && "calling facet volume variables for an scvf other than the bound one"); + return problem_().couplingManager().lowDimVolVars(problem_().model().globalFvGeometry().element(elementIndex()), + fvGeometry, + scvf); + } + + //! The following interface is here for compatibility reasonsto be overloaded for problems using facet coupling. + //! prepares all the necessary variables of the other domain. + //! Note that also an implementation of the CompleteFacetData structure has to be provided. + CompleteCoupledFacetData completeCoupledFacetData(const FVElementGeometry& fvGeometry) const + { + const auto& couplingMapper = problem_().couplingManager().couplingMapper(); + + // get coupling data for this scvf + const auto element = problem_().model().globalFvGeometry().element(elementIndex()); + const auto& scvfCouplingData = couplingMapper.getBulkCouplingData(element).getScvfCouplingData(fvGeometry.scvf(scvfIndex())); + + // obtain data necessary to fully instantiate the complete coupled facet data + assert(!scvfCouplingData.first && "no coupled facet element found for given scvf!"); + const auto& lowDimProblem = problem_().couplingManager().lowDimProblem(); + + auto lowDimElement = lowDimProblem.model().globalFvGeometry().element(scvfCouplingData.second); + auto lowDimFvGeometry = localView(lowDimProblem.model().globalFvGeometry()); + lowDimFvGeometry.bindElement(lowDimElement); + + LowDimVolumeVariables lowDimVolVars; + lowDimVolVars.update(lowDimProblem.model().elementSolution(lowDimElement, lowDimProblem.model().curSol()), + lowDimProblem, + lowDimElement, + lowDimFvGeometry.scv(scvfCouplingData.second)); + + return CompleteCoupledFacetData(lowDimProblem, + scvfCouplingData.second, + std::move(lowDimElement), + std::move(lowDimFvGeometry), + std::move(lowDimVolVars)); + } + +private: + const Problem& problem_() const + { return *problemPtr_; } + + const Problem* problemPtr_; + + IndexType elementIndex_; + IndexType scvfIndex_; + LocalIndexType localIndex_; + MpfaFaceTypes faceType_; +}; +} // end namespace + +#endif diff --git a/dumux/mixeddimension/facet/mpfa/properties.hh b/dumux/mixeddimension/facet/mpfa/properties.hh new file mode 100644 index 0000000000000000000000000000000000000000..5b8104083a17a29b35ebd3d6c589730655635b99 --- /dev/null +++ b/dumux/mixeddimension/facet/mpfa/properties.hh @@ -0,0 +1,70 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * \ingroup MixedDimension + * \brief Base properties for the bulk problems in mixed dimensional models + * with a lower dimensional model living on the element facets. + */ + +#ifndef DUMUX_FACET_MIXEDDIMENSION_PROPERTIES_HH +#define DUMUX_FACET_MIXEDDIMENSION_PROPERTIES_HH + +#include <dumux/implicit/cellcentered/mpfa/properties.hh> + +#include <dumux/mixeddimension/subproblemproperties.hh> +#include <dumux/mixeddimension/facet/mpfa/interactionvolume.hh> +#include <dumux/mixeddimension/facet/mpfa/interiorboundarydata.hh> +#include <dumux/mixeddimension/facet/mpfa/darcyslaw.hh> +#include <dumux/mixeddimension/facet/mpfa/fickslaw.hh> +#include <dumux/mixeddimension/facet/mpfa/fourierslaw.hh> + +namespace Dumux +{ + +namespace Properties +{ +NEW_TYPE_TAG(FacetCouplingBulkMpfaModel, INHERITS_FROM(CCMpfaModel)); + +//! The boundary interaction volume class (we use the facet coupling specialized o-method interaction volume) +SET_TYPE_PROP(FacetCouplingBulkMpfaModel, BoundaryInteractionVolume, CCMpfaOFacetCouplingInteractionVolume<TypeTag>); + +//! The interior boundary data class +SET_TYPE_PROP(FacetCouplingBulkMpfaModel, InteriorBoundaryData, CCMpfaFacetCouplingInteriorBoundaryData<TypeTag>); + +//! Ẃe always enable interior boundaries +SET_BOOL_PROP(FacetCouplingBulkMpfaModel, EnableInteriorBoundaries, true); + +//! Facet coupling is always true here +SET_BOOL_PROP(FacetCouplingBulkMpfaModel, MpfaFacetCoupling, true); + +//! Darcy's Law +SET_TYPE_PROP(FacetCouplingBulkMpfaModel, AdvectionType, CCMpfaFacetCouplingDarcysLaw<TypeTag>); + +//! Ficks's Law +SET_TYPE_PROP(FacetCouplingBulkMpfaModel, MolecularDiffusionType, CCMpfaFacetCouplingFicksLaw<TypeTag>); + +//! Fourier's Law +SET_TYPE_PROP(FacetCouplingBulkMpfaModel, HeatConductionType, CCMpfaFacetCouplingFouriersLaw<TypeTag>); + +}//end namespace Properties + +}//end namespace Dumux + +#endif diff --git a/dumux/mixeddimension/facet/start.hh b/dumux/mixeddimension/facet/start.hh new file mode 100644 index 0000000000000000000000000000000000000000..bd59fe1673e6152fd092edb48fc5339d56cbcb90 --- /dev/null +++ b/dumux/mixeddimension/facet/start.hh @@ -0,0 +1,203 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * \brief Provides a few default main functions for convenience. + */ +#ifndef DUMUX_MIXEDDIMENSION_FACET_START_HH +#define DUMUX_MIXEDDIMENSION_FACET_START_HH + +#include <ctime> +#include <iostream> + +#include <dune/common/parallel/mpihelper.hh> +#include <dune/grid/io/file/dgfparser/dgfexception.hh> + +#include <dumux/common/propertysystem.hh> +#include <dumux/common/parameters.hh> +#include <dumux/common/valgrind.hh> +#include <dumux/common/dumuxmessage.hh> +#include <dumux/common/defaultusagemessage.hh> +#include <dumux/common/parameterparser.hh> + +namespace Dumux +{ +// forward declaration of property tags +namespace Properties +{ +NEW_PROP_TAG(Scalar); +NEW_PROP_TAG(GridCreator); +NEW_PROP_TAG(Problem); +NEW_PROP_TAG(TimeManager); +} + +/*! + * \ingroup Start + * + * \brief Provides a main function which reads in parameters from the + * command line and a parameter file. + * + * \tparam TypeTag The type tag of the problem which needs to be solved + * + * \param argc The 'argc' argument of the main function: count of arguments (1 if there are no arguments) + * \param argv The 'argv' argument of the main function: array of pointers to the argument strings + * \param usage Callback function for printing the usage message + */ +template <class TypeTag> +int start_(int argc, + char **argv, + void (*usage)(const char *, const std::string &)) +{ + // some aliases for better readability + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using GridCreator = typename GET_PROP_TYPE(TypeTag, GridCreator); + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); + using ParameterTree = typename GET_PROP(TypeTag, ParameterTree); + + // initialize MPI, finalize is done automatically on exit + const auto& mpiHelper = Dune::MPIHelper::instance(argc, argv); + + // print dumux start message + if (mpiHelper.rank() == 0) + DumuxMessage::print(/*firstCall=*/true); + + //////////////////////////////////////////////////////////// + // parse the command line arguments and input file + //////////////////////////////////////////////////////////// + + // if the user just wanted to see the help / usage message show usage and stop program + if(!ParameterParser::parseCommandLineArguments(argc, argv, ParameterTree::tree(), usage)) + { + usage(argv[0], defaultUsageMessage(argv[0])); + return 0; + } + // parse the input file into the parameter tree + // check first if the user provided an input file through the command line, if not use the default + const auto parameterFileName = ParameterTree::tree().hasKey("ParameterFile") ? GET_RUNTIME_PARAM(TypeTag, std::string, ParameterFile) : ""; + ParameterParser::parseInputFile(argc, argv, ParameterTree::tree(), parameterFileName, usage); + + //////////////////////////////////////////////////////////// + // check for some user debugging parameters + //////////////////////////////////////////////////////////// + + bool printProps = false; // per default don't print all properties + if (ParameterTree::tree().hasKey("PrintProperties") || ParameterTree::tree().hasKey("TimeManager.PrintProperties")) + printProps = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, bool, TimeManager, PrintProperties); + + if (printProps && mpiHelper.rank() == 0) + Properties::print<TypeTag>(); + + bool printParams = true; // per default print all properties + if (ParameterTree::tree().hasKey("PrintParameters") || ParameterTree::tree().hasKey("TimeManager.PrintParameters")) + printParams = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, bool, TimeManager, PrintParameters); + + ////////////////////////////////////////////////////////////////////// + // try to create a grid (from the given grid file or the input file) + ///////////////////////////////////////////////////////////////////// + + try { GridCreator::makeGrid(); } + catch (...) { + std::string usageMessage = "\n\t -> Creation of the grid failed! <- \n\n"; + usageMessage += defaultUsageMessage(argv[0]); + usage(argv[0], usageMessage); + throw; + } + GridCreator::loadBalance(); + + ////////////////////////////////////////////////////////////////////// + // run the simulation + ///////////////////////////////////////////////////////////////////// + + // read the initial time step and the end time (mandatory parameters) + auto tEnd = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, TimeManager, TEnd); + auto dt = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, TimeManager, DtInitial); + + // check if we are about to restart a previously interrupted simulation + bool restart = false; + Scalar restartTime = 0; + if (ParameterTree::tree().hasKey("Restart") || ParameterTree::tree().hasKey("TimeManager.Restart")) + { + restart = true; + restartTime = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, TimeManager, Restart); + } + + // instantiate and run the problem + TimeManager timeManager; + Problem problem(timeManager, GridCreator::bulkGrid().leafGridView(), GridCreator::lowDimGrid().leafGridView()); + timeManager.init(problem, restartTime, dt, tEnd, restart); + timeManager.run(); + + // print dumux end message and maybe the parameters for debugging + if (mpiHelper.rank() == 0) + { + DumuxMessage::print(/*firstCall=*/false); + + if (printParams) + Parameters::print<TypeTag>(); + } + + return 0; +} + +/*! + * \ingroup Start + * + * \brief Provides a main function with error handling + * + * \tparam TypeTag The type tag of the problem which needs to be solved + * + * \param argc The number of command line arguments of the program + * \param argv The contents of the command line arguments of the program + * \param usage Callback function for printing the usage message + */ +template <class TypeTag> +int start(int argc, + char **argv, + void (*usage)(const char *, const std::string &)) +{ + try { + return start_<TypeTag>(argc, argv, usage); + } + catch (ParameterException &e) { + Parameters::print<TypeTag>(); + std::cerr << std::endl << e << ". Abort!" << std::endl; + return 1; + } + catch (Dune::DGFException & e) { + std::cerr << "DGF exception thrown (" << e << + "). Most likely, the DGF file name is wrong " + "or the DGF file is corrupted, " + "e.g. missing hash at end of file or wrong number (dimensions) of entries." + << std::endl; + return 2; + } + catch (Dune::Exception &e) { + std::cerr << "Dune reported error: " << e << std::endl; + return 3; + } + catch (...) { + std::cerr << "Unknown exception thrown!\n"; + return 4; + } +} + +} // end namespace Dumux + +#endif diff --git a/dumux/porousmediumflow/compositional/localresidual.hh b/dumux/porousmediumflow/compositional/localresidual.hh index 01ff8dd50d0f9d3c9b4d9f5ee7abe717dd49320f..6c6c7ce5904bba69832a12dbe4d10d89129d0d9b 100644 --- a/dumux/porousmediumflow/compositional/localresidual.hh +++ b/dumux/porousmediumflow/compositional/localresidual.hh @@ -182,7 +182,7 @@ public: auto eqIdx = conti0EqIdx + compIdx; // the physical quantities for which we perform upwinding - auto upwindTerm = [phaseIdx, compIdx](const VolumeVariables& volVars) + auto upwindTerm = [phaseIdx, compIdx](const auto& volVars) { return volVars.molarDensity(phaseIdx)*volVars.moleFraction(phaseIdx, compIdx)*volVars.mobility(phaseIdx); }; const auto advFlux = fluxVars.advectiveFlux(phaseIdx, upwindTerm); @@ -224,7 +224,7 @@ public: auto eqIdx = conti0EqIdx + compIdx; // the physical quantities for which we perform upwinding - auto upwindTerm = [phaseIdx, compIdx](const VolumeVariables& volVars) + auto upwindTerm = [phaseIdx, compIdx](const auto& volVars) { return volVars.density(phaseIdx)*volVars.massFraction(phaseIdx, compIdx)*volVars.mobility(phaseIdx); }; const auto advFlux = fluxVars.advectiveFlux(phaseIdx, upwindTerm); diff --git a/dumux/porousmediumflow/immiscible/localresidual.hh b/dumux/porousmediumflow/immiscible/localresidual.hh index a7562d94db0f0d993803193b3e9536c5e8f7d90e..c8f4361b3d4dba4d9de8804dc9fdc4676a6cd444 100644 --- a/dumux/porousmediumflow/immiscible/localresidual.hh +++ b/dumux/porousmediumflow/immiscible/localresidual.hh @@ -109,7 +109,7 @@ public: for (int phaseIdx = 0; phaseIdx < numPhases; ++phaseIdx) { // the physical quantities for which we perform upwinding - auto upwindTerm = [phaseIdx](const VolumeVariables& volVars) + auto upwindTerm = [phaseIdx](const auto& volVars) { return volVars.density(phaseIdx)*volVars.mobility(phaseIdx); }; auto eqIdx = conti0EqIdx + phaseIdx; diff --git a/dumux/porousmediumflow/implicit/fluxvariablescache.hh b/dumux/porousmediumflow/implicit/fluxvariablescache.hh index 558d8831545b83cc2f068abf3f317498fc0fa840..a7c02b5ac28fb8029dd46015d9b6e0afe9af63c4 100644 --- a/dumux/porousmediumflow/implicit/fluxvariablescache.hh +++ b/dumux/porousmediumflow/implicit/fluxvariablescache.hh @@ -24,7 +24,6 @@ #define DUMUX_POROUSMEDIUM_IMPLICIT_FLUXVARIABLESCACHE_HH #include <dumux/implicit/properties.hh> -#include <dumux/implicit/cellcentered/mpfa/properties.hh> #include <dune/localfunctions/lagrange/pqkfactory.hh> #include <dumux/discretization/methods.hh> @@ -38,6 +37,7 @@ namespace Properties { // forward declaration NEW_PROP_TAG(NumPhases); +NEW_PROP_TAG(InteriorBoundaryData); } /////////////////////////////////////////////////////////////////////////////////////////////////////////////// diff --git a/dumux/porousmediumflow/implicit/velocityoutput.hh b/dumux/porousmediumflow/implicit/velocityoutput.hh index 6259938be45f1f04b3a2d126fadc88e858ec24e8..6d7abb4f0d181c3f4e8b8feff1538a924fb6724f 100644 --- a/dumux/porousmediumflow/implicit/velocityoutput.hh +++ b/dumux/porousmediumflow/implicit/velocityoutput.hh @@ -147,7 +147,7 @@ public: elemFluxVarsCache.bind(element, fvGeometry, elemVolVars); // the upwind term to be used for the volume flux evaluation - auto upwindTerm = [phaseIdx](const VolumeVariables& volVars) { return volVars.mobility(phaseIdx); }; + auto upwindTerm = [phaseIdx](const auto& volVars) { return volVars.mobility(phaseIdx); }; if (isBox) { diff --git a/dumux/porousmediumflow/nonisothermal/implicit/localresidual.hh b/dumux/porousmediumflow/nonisothermal/implicit/localresidual.hh index 30f8e53a2b6a1152590bc3cbbbe0c7f1de759d99..9f2d08cce5a646b7348410f6f3ff5be875ae548d 100644 --- a/dumux/porousmediumflow/nonisothermal/implicit/localresidual.hh +++ b/dumux/porousmediumflow/nonisothermal/implicit/localresidual.hh @@ -125,7 +125,7 @@ public: FluxVariables& fluxVars, int phaseIdx) { - auto upwindTerm = [phaseIdx](const VolumeVariables& volVars) + auto upwindTerm = [phaseIdx](const auto& volVars) { return volVars.density(phaseIdx)*volVars.mobility(phaseIdx)*volVars.enthalpy(phaseIdx); }; flux[energyEqIdx] += fluxVars.advectiveFlux(phaseIdx, upwindTerm); diff --git a/test/mixeddimension/CMakeLists.txt b/test/mixeddimension/CMakeLists.txt index 4137ed5f234e80231fe3bf67abd88be5c903361c..bd0d2f725097fe48de0a6c529f56d016bd5597a9 100644 --- a/test/mixeddimension/CMakeLists.txt +++ b/test/mixeddimension/CMakeLists.txt @@ -1 +1,2 @@ add_subdirectory("embedded") +add_subdirectory("facet") diff --git a/test/mixeddimension/embedded/1p_1p/bloodflowproblem.hh b/test/mixeddimension/embedded/1p_1p/bloodflowproblem.hh index 17c49ef655a653ffad5013ff2a219bed03f19cb7..4dc05791b06f169dc19bd30025e74fb0ce0490fc 100644 --- a/test/mixeddimension/embedded/1p_1p/bloodflowproblem.hh +++ b/test/mixeddimension/embedded/1p_1p/bloodflowproblem.hh @@ -106,6 +106,7 @@ class BloodFlowProblem : public ImplicitPorousMediaProblem<TypeTag> using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); + using VtkOutputModule = typename GET_PROP_TYPE(TypeTag, VtkOutputModule); using Element = typename GridView::template Codim<0>::Entity; using GlobalPosition = Dune::FieldVector<Scalar, dimworld>; @@ -324,7 +325,7 @@ public: /*! * \brief Adds additional VTK output data to the VTKWriter. Function is called by the output module on every write. */ - void addVtkOutputFields(VtkOutputModule<TypeTag>& outputModule) const + void addVtkOutputFields(VtkOutputModule& outputModule) const { auto& p = outputModule.createScalarField("exact pressure", dofCodim); p = exactPressure_; diff --git a/test/mixeddimension/embedded/1p_1p/tissueproblem.hh b/test/mixeddimension/embedded/1p_1p/tissueproblem.hh index bf10ffeee903f6d7bbbd2fb0a5b8643aab81c11d..f663847a9f87ce7894d8fb2c481528cf6a1838f2 100644 --- a/test/mixeddimension/embedded/1p_1p/tissueproblem.hh +++ b/test/mixeddimension/embedded/1p_1p/tissueproblem.hh @@ -104,6 +104,7 @@ class TissueProblem : public ImplicitPorousMediaProblem<TypeTag> using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); using PointSource = typename GET_PROP_TYPE(TypeTag, PointSource); using Indices = typename GET_PROP_TYPE(TypeTag, Indices); + using VtkOutputModule = typename GET_PROP_TYPE(TypeTag, VtkOutputModule); // copy some indices for convenience enum { @@ -328,7 +329,7 @@ public: /*! * \brief Adds additional VTK output data to the VTKWriter. Function is called by the output module on every write. */ - void addVtkOutputFields(VtkOutputModule<TypeTag>& outputModule) const + void addVtkOutputFields(VtkOutputModule& outputModule) const { auto& p = outputModule.createScalarField("exact pressure", dofCodim); p = exactPressure_; diff --git a/test/mixeddimension/facet/1p2c_1p2c/1d2dtestproblem.hh b/test/mixeddimension/facet/1p2c_1p2c/1d2dtestproblem.hh new file mode 100644 index 0000000000000000000000000000000000000000..37ce2a4242ff898a64d862dbec6421451ce01d1b --- /dev/null +++ b/test/mixeddimension/facet/1p2c_1p2c/1d2dtestproblem.hh @@ -0,0 +1,107 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * + * \brief A test problem for the 1d2d coupled problem: + * 1d fractures living on the element facets of a 2d matrix + */ +#ifndef DUMUX_1D2D_FACET_TEST_PROBLEM_HH +#define DUMUX_1D2D_FACET_TEST_PROBLEM_HH + +#include "fractureproblem.hh" +#include "matrixproblem.hh" + +#include <dumux/mixeddimension/problem.hh> +#include <dumux/mixeddimension/facet/gmshdualfacetgridcreator.hh> +#include <dumux/mixeddimension/facet/mpfa/couplingmanager.hh> + +namespace Dumux +{ +template <class TypeTag> +class OnePTwoCFacetCouplingProblem; + +namespace Properties +{ +// Type tag of the isothermal and non-isotherman global Problem +NEW_TYPE_TAG(OnePTwoCFacetCoupling, INHERITS_FROM(MixedDimension)); +NEW_TYPE_TAG(OnePTwoCIFacetCoupling, INHERITS_FROM(OnePTwoCFacetCoupling)); +NEW_TYPE_TAG(OnePTwoCNIFacetCoupling, INHERITS_FROM(OnePTwoCFacetCoupling)); + +// Set the problem property +SET_TYPE_PROP(OnePTwoCFacetCoupling, Problem, Dumux::OnePTwoCFacetCouplingProblem<TypeTag>); + +// Set the grid creator +SET_TYPE_PROP(OnePTwoCFacetCoupling, GridCreator, Dumux::GmshDualFacetGridCreator<TypeTag>); + +// Set the two sub-problems of the global problem +SET_TYPE_PROP(OnePTwoCIFacetCoupling, BulkProblemTypeTag, TTAG(OnePTwoCICCMpfaMatrixProblem)); +SET_TYPE_PROP(OnePTwoCIFacetCoupling, LowDimProblemTypeTag, TTAG(OnePTwoCICCFractureProblem)); +SET_TYPE_PROP(OnePTwoCNIFacetCoupling, BulkProblemTypeTag, TTAG(OnePTwoCNICCMpfaMatrixProblem)); +SET_TYPE_PROP(OnePTwoCNIFacetCoupling, LowDimProblemTypeTag, TTAG(OnePTwoCNICCFractureProblem)); + +// The coupling manager +SET_TYPE_PROP(OnePTwoCFacetCoupling, CouplingManager, CCMpfaFacetCouplingManager<TypeTag>); + +// The linear solver to be used +SET_TYPE_PROP(OnePTwoCFacetCoupling, LinearSolver, ILU0BiCGSTABBackend<TypeTag>); + +// The sub-problems need to know the global problem's type tag +SET_TYPE_PROP(OnePTwoCICCMpfaMatrixProblem, GlobalProblemTypeTag, TTAG(OnePTwoCIFacetCoupling)); +SET_TYPE_PROP(OnePTwoCICCFractureProblem, GlobalProblemTypeTag, TTAG(OnePTwoCIFacetCoupling)); +SET_TYPE_PROP(OnePTwoCNICCMpfaMatrixProblem, GlobalProblemTypeTag, TTAG(OnePTwoCNIFacetCoupling)); +SET_TYPE_PROP(OnePTwoCNICCFractureProblem, GlobalProblemTypeTag, TTAG(OnePTwoCNIFacetCoupling)); + +// The subproblems inherit the parameter tree from this problem +SET_PROP(OnePTwoCICCMpfaMatrixProblem, ParameterTree) : GET_PROP(TTAG(OnePTwoCIFacetCoupling), ParameterTree) {}; +SET_PROP(OnePTwoCICCFractureProblem, ParameterTree) : GET_PROP(TTAG(OnePTwoCIFacetCoupling), ParameterTree) {}; +SET_PROP(OnePTwoCNICCMpfaMatrixProblem, ParameterTree) : GET_PROP(TTAG(OnePTwoCNIFacetCoupling), ParameterTree) {}; +SET_PROP(OnePTwoCNICCFractureProblem, ParameterTree) : GET_PROP(TTAG(OnePTwoCNIFacetCoupling), ParameterTree) {}; + +// Set the grids for the two sub-problems +SET_TYPE_PROP(OnePTwoCICCMpfaMatrixProblem, Grid, Dune::ALUGrid<2, 2, Dune::simplex, Dune::nonconforming>); +SET_TYPE_PROP(OnePTwoCICCFractureProblem, Grid, Dune::FoamGrid<1,2>); +SET_TYPE_PROP(OnePTwoCNICCMpfaMatrixProblem, Grid, Dune::ALUGrid<2, 2, Dune::simplex, Dune::nonconforming>); +SET_TYPE_PROP(OnePTwoCNICCFractureProblem, Grid, Dune::FoamGrid<1,2>); + +} + +template <class TypeTag> +class OnePTwoCFacetCouplingProblem : public MixedDimensionProblem<TypeTag> +{ + using ParentType = MixedDimensionProblem<TypeTag>; + + using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); + + using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); + using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); + + using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); + using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); + +public: + + OnePTwoCFacetCouplingProblem(TimeManager &timeManager, const BulkGridView &bulkGridView, const LowDimGridView &lowDimGridView) + : ParentType(timeManager, bulkGridView, lowDimGridView) + {} +}; + +} //end namespace + +#endif diff --git a/test/mixeddimension/facet/1p2c_1p2c/CMakeLists.txt b/test/mixeddimension/facet/1p2c_1p2c/CMakeLists.txt new file mode 100644 index 0000000000000000000000000000000000000000..8e7d474239fecdc5628bc92dde40556ae0e1e2dc --- /dev/null +++ b/test/mixeddimension/facet/1p2c_1p2c/CMakeLists.txt @@ -0,0 +1,4 @@ +dune_add_test(SOURCES test_fracture_1p2c_1p2c.cc) +dune_add_test(SOURCES test_fracture_1p2cni_1p2cni.cc) +dune_symlink_to_source_files(FILES "grids" "test_fracture_1p2c_1p2c.input" "test_fracture_1p2cni_1p2cni.input") +set(CMAKE_BUILD_TYPE Release) diff --git a/test/mixeddimension/facet/1p2c_1p2c/fractureproblem.hh b/test/mixeddimension/facet/1p2c_1p2c/fractureproblem.hh new file mode 100644 index 0000000000000000000000000000000000000000..7790910a6ea6d486a12cb42c22d14205074cc7ce --- /dev/null +++ b/test/mixeddimension/facet/1p2c_1p2c/fractureproblem.hh @@ -0,0 +1,253 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * + * \brief A test problem for the one-dimensional single-phase fracture model + */ +#ifndef DUMUX_1P2C_FRACTURE_PROBLEM_HH +#define DUMUX_1P2C_FRACTURE_PROBLEM_HH + +#include <dumux/implicit/cellcentered/tpfa/properties.hh> +#include <dumux/mixeddimension/subproblemproperties.hh> + +#include <dumux/porousmediumflow/1p2c/implicit/model.hh> +#include <dumux/porousmediumflow/implicit/problem.hh> + +#include <dumux/material/fluidsystems/h2on2.hh> +#include "fracturespatialparams.hh" + +namespace Dumux +{ + +//! Forward declaration of the problem class +template <class TypeTag> +class OnePTwoCFractureProblem; + +namespace Properties +{ +NEW_TYPE_TAG(OnePTwoCIFractureProblem, INHERITS_FROM(OnePTwoC)); +NEW_TYPE_TAG(OnePTwoCNIFractureProblem, INHERITS_FROM(OnePTwoCNI)); +NEW_TYPE_TAG(OnePTwoCICCFractureProblem, INHERITS_FROM(CCTpfaModel, OnePTwoCIFractureProblem)); +NEW_TYPE_TAG(OnePTwoCNICCFractureProblem, INHERITS_FROM(CCTpfaModel, OnePTwoCNIFractureProblem)); + +// Set fluid configuration +SET_TYPE_PROP(OnePTwoCIFractureProblem, FluidSystem, FluidSystems::H2ON2<typename GET_PROP_TYPE(TypeTag, Scalar), false>); +SET_TYPE_PROP(OnePTwoCNIFractureProblem, FluidSystem, FluidSystems::H2ON2<typename GET_PROP_TYPE(TypeTag, Scalar), false>); + +// Set the problem property +SET_TYPE_PROP(OnePTwoCIFractureProblem, Problem, OnePTwoCFractureProblem<TypeTag>); +SET_TYPE_PROP(OnePTwoCNIFractureProblem, Problem, OnePTwoCFractureProblem<TypeTag>); + +// Set the spatial parameters +SET_TYPE_PROP(OnePTwoCIFractureProblem, SpatialParams, OnePFractureSpatialParams<TypeTag>); +SET_TYPE_PROP(OnePTwoCNIFractureProblem, SpatialParams, OnePFractureSpatialParams<TypeTag>); + +// Define whether mole(true) or mass (false) fractions are used +SET_BOOL_PROP(OnePTwoCIFractureProblem, UseMoles, true); +SET_BOOL_PROP(OnePTwoCNIFractureProblem, UseMoles, true); + +// Linear solver settings +SET_TYPE_PROP(OnePTwoCIFractureProblem, LinearSolver, SuperLUBackend<TypeTag>); +SET_TYPE_PROP(OnePTwoCNIFractureProblem, LinearSolver, SuperLUBackend<TypeTag>); + +// Enable gravity +SET_BOOL_PROP(OnePTwoCIFractureProblem, ProblemEnableGravity, false); +SET_BOOL_PROP(OnePTwoCNIFractureProblem, ProblemEnableGravity, false); + +// Solution-independent tensor +// SET_BOOL_PROP(OnePTwoCICCFractureProblem, SolutionDependentAdvection, false); +// SET_BOOL_PROP(OnePTwoCNICCFractureProblem, SolutionDependentMolecularDiffusion, false); +// SET_BOOL_PROP(OnePTwoCICCFractureProblem, SolutionDependentAdvection, false); +// SET_BOOL_PROP(OnePTwoCNICCFractureProblem, SolutionDependentMolecularDiffusion, false); +// SET_BOOL_PROP(OnePTwoCNICCFractureProblem, SolutionDependentHeatConduction, false); +} + +/*! + * \ingroup OnePModel + * \ingroup ImplicitTestProblems + * \brief Test problem for the one-phase model: + */ +template <class TypeTag> +class OnePTwoCFractureProblem : public ImplicitPorousMediaProblem<TypeTag> +{ + using ParentType = ImplicitPorousMediaProblem<TypeTag>; + + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Element = typename GridView::template Codim<0>::Entity; + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Indices = typename GET_PROP_TYPE(TypeTag, Indices); + using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); + using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem); + using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); + using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); + using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); + using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); + + using GlobalProblemTypeTag = typename GET_PROP_TYPE(TypeTag, GlobalProblemTypeTag); + using CouplingManager = typename GET_PROP_TYPE(GlobalProblemTypeTag, CouplingManager); + + // copy some indices for convenience + enum + { + // indices of the primary variables + pressureIdx = Indices::pressureIdx, + massOrMoleFracIdx = Indices::massOrMoleFracIdx, + + // indices of the equations + conti0EqIdx = Indices::conti0EqIdx, + transportEqIdx = Indices::transportEqIdx + }; + + //! property that defines whether mole or mass fractions are used + static const bool useMoles = GET_PROP_VALUE(TypeTag, UseMoles); + + static constexpr int numEq = GET_PROP_VALUE(TypeTag, NumEq); + static constexpr int dim = GridView::dimension; + static constexpr int dimWorld = GridView::dimensionworld; + + using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; + +public: + OnePTwoCFractureProblem(TimeManager &timeManager, const GridView &gridView) + : ParentType(timeManager, gridView) + { + //initialize fluid system + FluidSystem::init(); + + name_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Problem, Name) + "_fracture"; + eps_ = 1e-6; + + // stating in the console whether mole or mass fractions are used + if(useMoles) + std::cout<<"problem uses mole fractions"<<std::endl; + else + std::cout<<"problem uses mass fractions"<<std::endl; + } + + /*! + * \brief The problem name. + * This is used as a prefix for files generated by the simulation. + */ + const std::string& name() const + { return name_; } + + /*! + * \brief Return the temperature within the domain in [K]. + * + * This problem assumes a temperature of 10 degrees Celsius. + */ + Scalar temperature() const + { return 273.15 + 50; } // 50C + + /*! + * \brief Return how much the domain is extruded at a given sub-control volume. + */ + Scalar extrusionFactorAtPos(const GlobalPosition &globalPos) const + { + //! return the user-specified fracture aperture + static const Scalar a = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, FractureAperture); + return a; + } + + + /*! + * \brief Return the sources within the domain. + */ + PrimaryVariables source(const Element& element, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolume& scv) const + { + // we have only sources coming from the bulk domain + return couplingManager().evalSourcesFromBulk(element, fvGeometry, elemVolVars, scv); + } + + /*! + * \brief Specifies which kind of boundary condition should be used. + */ + BoundaryTypes boundaryTypesAtPos(const GlobalPosition& globalPos) const + { + BoundaryTypes values; + if (globalPos[0] < eps_ /*|| globalPos[0] > this->bBoxMax()[0] - eps_*/) + values.setAllDirichlet(); + else + values.setAllNeumann(); + return values; + } + + /*! + * \brief Evaluate the boundary conditions for a dirichlet + * control volume. + */ + PrimaryVariables dirichletAtPos(const GlobalPosition& globalPos) const + { + auto values = initialAtPos(globalPos); + // values[pressureIdx] = 2.0e5 - 1.0e5*globalPos[0]/this->bBoxMax()[0]; + if (globalPos[0] < eps_) + values[massOrMoleFracIdx] = 2.0e-5; + return values; + } + + PrimaryVariables neumannAtPos(const GlobalPosition& globalPos) const + { return PrimaryVariables(0.0); } + + /*! + * \brief Evaluate the initial value for a control volume (isothermal case) + */ + template<class T = TypeTag> + typename std::enable_if<std::is_same<T, TTAG(OnePTwoCICCFractureProblem)>::value, PrimaryVariables>::type + initialAtPos(const GlobalPosition& globalPos) const + { + PrimaryVariables values(0.0); + values[pressureIdx] = 1.0e5; + return values; + } + + /*! + * \brief Evaluate the initial value for a control volume (non-isothermal case) + */ + template<class T = TypeTag> + typename std::enable_if<std::is_same<T, TTAG(OnePTwoCNICCFractureProblem)>::value, PrimaryVariables>::type + initialAtPos(const GlobalPosition& globalPos) const + { + PrimaryVariables values(0.0); + values[pressureIdx] = 1.0e5; + values[Indices::temperatureIdx] = temperature(); + return values; + } + + //! Set the coupling manager + void setCouplingManager(std::shared_ptr<CouplingManager> cm) + { couplingManager_ = cm; } + + //! Get the coupling manager + const CouplingManager& couplingManager() const + { return *couplingManager_; } + +private: + std::string name_; + Scalar eps_; + std::shared_ptr<CouplingManager> couplingManager_; +}; +} //end namespace + +#endif diff --git a/test/mixeddimension/facet/1p2c_1p2c/fracturespatialparams.hh b/test/mixeddimension/facet/1p2c_1p2c/fracturespatialparams.hh new file mode 100644 index 0000000000000000000000000000000000000000..41e2f25494aa858169e727094d26ddd3cc77c9ac --- /dev/null +++ b/test/mixeddimension/facet/1p2c_1p2c/fracturespatialparams.hh @@ -0,0 +1,132 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * + * \brief The spatial parameters class for the fracture problem + */ +#ifndef DUMUX_1P_FRACTURE_SPATIALPARAMS_HH +#define DUMUX_1P_FRACTURE_SPATIALPARAMS_HH + +#include <dumux/material/spatialparams/implicit1p.hh> + +namespace Dumux +{ + +/*! + * \ingroup OnePModel + * \ingroup ImplicitTestProblems + * + * \brief The spatial parameters class for the fracture problem + */ +template<class TypeTag> +class OnePFractureSpatialParams : public ImplicitSpatialParamsOneP<TypeTag> +{ + using ParentType = ImplicitSpatialParamsOneP<TypeTag>; + + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Element = typename GridView::template Codim<0>::Entity; + using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); + + static constexpr int dimWorld = GridView::dimensionworld; + using GlobalPosition = Dune::FieldVector<Scalar,dimWorld>; + +public: + using PermeabilityType = Scalar; + + OnePFractureSpatialParams(const Problem& problem, const GridView& gridView) + : ParentType(problem, gridView) + { + permeability_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, FracturePermeability); + } + + /*! + * \brief Return the intrinsic permeability for a given position in [m^2]. + */ + Scalar permeabilityAtPos(const GlobalPosition& globalPos) const + { return permeability_; } + + /*! + * \brief Define the dispersivity. + * + * \param element The finite element + * \param scv The sub-control volume + * \param elemSol The solution for all dofs of the element + */ + Scalar dispersivity(const Element &element, + const SubControlVolume& scv, + const ElementSolutionVector& elemSol) const + { return 0; } + + /*! + * \brief Define the porosity in [-]. + */ + Scalar porosityAtPos(const GlobalPosition& globalPos) const + { return 0.8; } + + /*! + * \brief Returns the heat capacity \f$[J / (kg K)]\f$ of the rock matrix. + * + * This is only required for non-isothermal models. + * + * \param element The element + * \param scv The sub control volume + * \param elemSol The element solution vector + */ + Scalar solidHeatCapacity(const Element &element, + const SubControlVolume& scv, + const ElementSolutionVector& elemSol) const + { return 790; /*specific heat capacity of granite [J / (kg K)]*/ } + + /*! + * \brief Returns the mass density \f$[kg / m^3]\f$ of the rock matrix. + * + * This is only required for non-isothermal models. + * + * \param element The element + * \param scv The sub control volume + * \param elemSol The element solution vector + */ + Scalar solidDensity(const Element &element, + const SubControlVolume& scv, + const ElementSolutionVector& elemSol) const + { return 2700; /*density of granite [kg/m^3]*/ } + + /*! + * \brief Returns the thermal conductivity \f$\mathrm{[W/(m K)]}\f$ of the porous material. + * + * \param element The element + * \param scv The sub control volume + * \param elemSol The element solution vector + */ + Scalar solidThermalConductivity(const Element &element, + const SubControlVolume& scv, + const ElementSolutionVector& elemSol) const + { return 2.8; } + +private: + Scalar permeability_; +}; +} //end namespace + +#endif diff --git a/test/mixeddimension/facet/1p2c_1p2c/grids/minifracture.msh b/test/mixeddimension/facet/1p2c_1p2c/grids/minifracture.msh new file mode 100644 index 0000000000000000000000000000000000000000..63b76af4f5807b4ea70cad200226e4b596d2d85e --- /dev/null +++ b/test/mixeddimension/facet/1p2c_1p2c/grids/minifracture.msh @@ -0,0 +1,28 @@ +$MeshFormat +2.2 0 8 +$EndMeshFormat +$Nodes +8 +1 0 0 0 +2 1 0 0 +3 1 1 0 +4 0 1 0 +5 0.3 0.5 0 +6 0.7 0.5 0 +7 0.4999999999999999 0.75 0 +8 0.5 0.25 0 +$EndNodes +$Elements +11 +1 1 2 1 9 5 6 +2 2 2 2 11 1 4 5 +3 2 2 3 13 5 6 7 +4 2 2 3 13 3 7 6 +5 2 2 3 13 4 5 7 +6 2 2 3 13 3 4 7 +7 2 2 4 15 2 3 6 +8 2 2 5 17 5 6 8 +9 2 2 5 17 1 5 8 +10 2 2 5 17 2 8 6 +11 2 2 5 17 1 8 2 +$EndElements diff --git a/test/mixeddimension/facet/1p2c_1p2c/grids/simplefracture_long.msh b/test/mixeddimension/facet/1p2c_1p2c/grids/simplefracture_long.msh new file mode 100644 index 0000000000000000000000000000000000000000..97d57ee2faf29cac9cffb972184496b3cbce3f46 --- /dev/null +++ b/test/mixeddimension/facet/1p2c_1p2c/grids/simplefracture_long.msh @@ -0,0 +1,20728 @@ +$MeshFormat +2.2 0 8 +$EndMeshFormat +$Nodes +6953 +1 0 0 0 +2 1 0 0 +3 1 1 0 +4 0 1 0 +5 0 2 0 +6 1 2 0 +7 0 1.961246838739447 0 +8 0 1.923620027356419 0 +9 0 1.887086839128796 0 +10 0 1.851615478578754 0 +11 0 1.817175089469696 0 +12 0 1.783735707587069 0 +13 0 1.751268236839613 0 +14 0 1.719744426337889 0 +15 0 1.689136857907859 0 +16 0 1.659418885121227 0 +17 0 1.630564671287283 0 +18 0 1.602549093390542 0 +19 0 1.57534779490678 0 +20 0 1.548937093166071 0 +21 0 1.523294014611084 0 +22 0 1.498396249203548 0 +23 0 1.474222134050282 0 +24 0 1.450750629754289 0 +25 0 1.42796132677119 0 +26 0 1.405834394400535 0 +27 0 1.384350577400349 0 +28 0 1.363491184451146 0 +29 0 1.343238067032042 0 +30 0 1.323573604946558 0 +31 0 1.304480687581044 0 +32 0 1.285942703790913 0 +33 0 1.267943520816152 0 +34 0 1.250467486362735 0 +35 0 1.233499389066202 0 +36 0 1.217024467022857 0 +37 0 1.201028387241073 0 +38 0 1.185497232544095 0 +39 0 1.170417484876865 0 +40 0 1.155776031483197 0 +41 0 1.141560131320103 0 +42 0 1.127757413025329 0 +43 0 1.114355867344446 0 +44 0 1.101343837356743 0 +45 0 1.088710000985292 0 +46 0 1.076443364265634 0 +47 0 1.064533257314828 0 +48 0 1.052969311414612 0 +49 0 1.041741473455155 0 +50 0 1.030839971892862 0 +51 0 1.020255320150878 0 +52 0 1.009978311119173 0 +53 0 0.9900216888807783 0 +54 0 0.9797446798490225 0 +55 0 0.9691600281069848 0 +56 0 0.9582585265446345 0 +57 0 0.9470306885851157 0 +58 0 0.9354667426848361 0 +59 0 0.9235566357339615 0 +60 0 0.9112899990142319 0 +61 0 0.8986561626427046 0 +62 0 0.8856441326549224 0 +63 0 0.8722425869739866 0 +64 0 0.8584398686792792 0 +65 0 0.844223968516258 0 +66 0 0.8295825151226676 0 +67 0 0.8145027674555209 0 +68 0 0.7989716127586306 0 +69 0 0.7829755329769404 0 +70 0 0.7665006109336951 0 +71 0 0.7495325136372667 0 +72 0 0.7320564791839617 0 +73 0 0.7140572962093195 0 +74 0 0.6955193124193149 0 +75 0 0.6764263950539335 0 +76 0 0.6567619329685902 0 +77 0 0.6365088155496345 0 +78 0 0.6156494226005882 0 +79 0 0.5941656056005681 0 +80 0 0.5720386732300877 0 +81 0 0.5492493702471728 0 +82 0 0.5257778659513737 0 +83 0 0.5016037507983127 0 +84 0 0.4767059853907288 0 +85 0 0.4510629068356712 0 +86 0 0.4246522050948855 0 +87 0 0.3974509066110418 0 +88 0 0.3694353287142109 0 +89 0 0.3405811148801705 0 +90 0 0.3108631420934366 0 +91 0 0.280255573663297 0 +92 0 0.2487317631614541 0 +93 0 0.2162642924138732 0 +94 0 0.1828249105311132 0 +95 0 0.1483845214219136 0 +96 0 0.1129131608717201 0 +97 0 0.07637997264393659 0 +98 0 0.03875316126073414 0 +99 0.03999999999992186 0 0 +100 0.07999999999984518 0 0 +101 0.1199999999997832 0 0 +102 0.1599999999996745 0 0 +103 0.1999999999995579 0 0 +104 0.2399999999994413 0 0 +105 0.2799999999993247 0 0 +106 0.3199999999992081 0 0 +107 0.3599999999990915 0 0 +108 0.3999999999989749 0 0 +109 0.4399999999988584 0 0 +110 0.4799999999987418 0 0 +111 0.5199999999987361 0 0 +112 0.5599999999988415 0 0 +113 0.5999999999989468 0 0 +114 0.6399999999990521 0 0 +115 0.6799999999991574 0 0 +116 0.7199999999992628 0 0 +117 0.7599999999993681 0 0 +118 0.7999999999994734 0 0 +119 0.8399999999995788 0 0 +120 0.8799999999996841 0 0 +121 0.9199999999997894 0 0 +122 0.9599999999998947 0 0 +123 1 0.03875316126044642 0 +124 1 0.07637997264337447 0 +125 1 0.1129131608709185 0 +126 1 0.148384521420854 0 +127 1 0.1828249105297957 0 +128 1 0.2162642924123149 0 +129 1 0.2487317631596681 0 +130 1 0.2802555736612968 0 +131 1 0.310863142091238 0 +132 1 0.3405811148777859 0 +133 1 0.3694353287116517 0 +134 1 0.3974509066083207 0 +135 1 0.4246522050920155 0 +136 1 0.4510629068326624 0 +137 1 0.4767059853875909 0 +138 1 0.5016037507950835 0 +139 1 0.5257778659484318 0 +140 1 0.5492493702445046 0 +141 1 0.5720386732276799 0 +142 1 0.5941656055984066 0 +143 1 0.6156494225986616 0 +144 1 0.6365088155479306 0 +145 1 0.656761932967097 0 +146 1 0.6764263950526404 0 +147 1 0.6955193124182117 0 +148 1 0.7140572962083968 0 +149 1 0.7320564791832096 0 +150 1 0.7495325136366761 0 +151 1 0.7665006109332575 0 +152 1 0.782975532976647 0 +153 1 0.7989716127584735 0 +154 1 0.8145027674554923 0 +155 1 0.8295825151227607 0 +156 1 0.8442239685164651 0 +157 1 0.8584398686795944 0 +158 1 0.8722425869744029 0 +159 1 0.8856441326553172 0 +160 1 0.8986561626430498 0 +161 1 0.9112899990145296 0 +162 1 0.9235566357342145 0 +163 1 0.9354667426850464 0 +164 1 0.9470306885852854 0 +165 1 0.9582585265447658 0 +166 1 0.9691600281070806 0 +167 1 0.9797446798490843 0 +168 1 0.9900216888808085 0 +169 1 1.009978311119173 0 +170 1 1.020255320150877 0 +171 1 1.030839971892861 0 +172 1 1.041741473455154 0 +173 1 1.052969311414611 0 +174 1 1.064533257314827 0 +175 1 1.076443364265633 0 +176 1 1.088710000985291 0 +177 1 1.101343837356743 0 +178 1 1.114355867344445 0 +179 1 1.127757413025327 0 +180 1 1.141560131320103 0 +181 1 1.155776031483196 0 +182 1 1.170417484876864 0 +183 1 1.185497232544094 0 +184 1 1.201028387241072 0 +185 1 1.217024467022855 0 +186 1 1.2334993890662 0 +187 1 1.250467486362734 0 +188 1 1.267943520816151 0 +189 1 1.285942703790912 0 +190 1 1.304480687581042 0 +191 1 1.323573604946557 0 +192 1 1.34323806703204 0 +193 1 1.363491184451145 0 +194 1 1.384350577400348 0 +195 1 1.405834394400534 0 +196 1 1.427961326771189 0 +197 1 1.450750629754288 0 +198 1 1.474222134050281 0 +199 1 1.498396249203547 0 +200 1 1.523294014611084 0 +201 1 1.548937093166071 0 +202 1 1.57534779490678 0 +203 1 1.602549093390542 0 +204 1 1.630564671287284 0 +205 1 1.659418885121229 0 +206 1 1.689136857907859 0 +207 1 1.719744426337889 0 +208 1 1.751268236839613 0 +209 1 1.783735707587067 0 +210 1 1.817175089469695 0 +211 1 1.851615478578753 0 +212 1 1.887086839128794 0 +213 1 1.923620027356417 0 +214 1 1.961246838739447 0 +215 0.9599999999998334 2 0 +216 0.9199999999996669 2 0 +217 0.879999999999508 2 0 +218 0.8399999999997222 2 0 +219 0.7999999999999997 2 0 +220 0.7600000000002772 2 0 +221 0.7200000000005549 2 0 +222 0.6800000000008324 2 0 +223 0.6400000000011098 2 0 +224 0.6000000000013872 2 0 +225 0.5600000000016645 2 0 +226 0.5200000000019419 2 0 +227 0.4800000000019974 2 0 +228 0.4400000000018309 2 0 +229 0.4000000000016645 2 0 +230 0.360000000001498 2 0 +231 0.3200000000013316 2 0 +232 0.2800000000011651 2 0 +233 0.2400000000009987 2 0 +234 0.2000000000008322 2 0 +235 0.1600000000006658 2 0 +236 0.1200000000004994 2 0 +237 0.08000000000033292 2 0 +238 0.04000000000016646 2 0 +239 0.009999999999981104 1 0 +240 0.01999999999996237 1 0 +241 0.02999999999994307 1 0 +242 0.03999999999992186 1 0 +243 0.04999999999989966 1 0 +244 0.05999999999987837 1 0 +245 0.06999999999986051 1 0 +246 0.07999999999984518 1 0 +247 0.0899999999998299 1 0 +248 0.09999999999981463 1 0 +249 0.1099999999997994 1 0 +250 0.1199999999997832 1 0 +251 0.1299999999997609 1 0 +252 0.1399999999997328 1 0 +253 0.1499999999997036 1 0 +254 0.1599999999996745 1 0 +255 0.1699999999996453 1 0 +256 0.1799999999996162 1 0 +257 0.189999999999587 1 0 +258 0.1999999999995579 1 0 +259 0.2099999999995288 1 0 +260 0.2199999999994996 1 0 +261 0.2299999999994704 1 0 +262 0.2399999999994413 1 0 +263 0.2499999999994121 1 0 +264 0.259999999999383 1 0 +265 0.2699999999993538 1 0 +266 0.2799999999993247 1 0 +267 0.2899999999992955 1 0 +268 0.2999999999992664 1 0 +269 0.3099999999992372 1 0 +270 0.3199999999992081 1 0 +271 0.329999999999179 1 0 +272 0.3399999999991498 1 0 +273 0.3499999999991207 1 0 +274 0.3599999999990915 1 0 +275 0.3699999999990624 1 0 +276 0.3799999999990332 1 0 +277 0.3899999999990041 1 0 +278 0.3999999999989749 1 0 +279 0.4099999999989458 1 0 +280 0.4199999999989167 1 0 +281 0.4299999999988875 1 0 +282 0.4399999999988584 1 0 +283 0.4499999999988292 1 0 +284 0.4599999999988 1 0 +285 0.4699999999987708 1 0 +286 0.4799999999987418 1 0 +287 0.4899999999987126 1 0 +288 0.4999999999986943 1 0 +289 0.5099999999987098 1 0 +290 0.5199999999987361 1 0 +291 0.5299999999987626 1 0 +292 0.5399999999987888 1 0 +293 0.5499999999988152 1 0 +294 0.5599999999988415 1 0 +295 0.5699999999988679 1 0 +296 0.5799999999988942 1 0 +297 0.5899999999989205 1 0 +298 0.5999999999989468 1 0 +299 0.6099999999989731 1 0 +300 0.6199999999989995 1 0 +301 0.6299999999990258 1 0 +302 0.6399999999990521 1 0 +303 0.6499999999990784 1 0 +304 0.6599999999991049 1 0 +305 0.6699999999991312 1 0 +306 0.6799999999991574 1 0 +307 0.6899999999991837 1 0 +308 0.6999999999992101 1 0 +309 0.7099999999992365 1 0 +310 0.7199999999992628 1 0 +311 0.7299999999992892 1 0 +312 0.7399999999993154 1 0 +313 0.7499999999993417 1 0 +314 0.7599999999993681 1 0 +315 0.7699999999993945 1 0 +316 0.7799999999994207 1 0 +317 0.789999999999447 1 0 +318 0.7999999999994734 1 0 +319 0.8099999999994998 1 0 +320 0.8199999999995261 1 0 +321 0.8299999999995523 1 0 +322 0.8399999999995788 1 0 +323 0.8499999999996051 1 0 +324 0.8599999999996314 1 0 +325 0.8699999999996577 1 0 +326 0.8799999999996841 1 0 +327 0.8899999999997104 1 0 +328 0.8999999999997367 1 0 +329 0.9099999999997631 1 0 +330 0.9199999999997894 1 0 +331 0.9299999999998156 1 0 +332 0.939999999999842 1 0 +333 0.9499999999998684 1 0 +334 0.9599999999998947 1 0 +335 0.969999999999921 1 0 +336 0.9799999999999475 1 0 +337 0.9899999999999737 1 0 +338 0.5048683847089982 1.496966078704385 0 +339 0.7113755267421392 1.28439929627209 0 +340 0.2870897505559813 1.285911559479631 0 +341 0.4971637719999193 1.219543611537615 0 +342 0.8349999999995662 1.165012760259128 0 +343 0.16499999999966 1.16501276025838 0 +344 0.3051755485833004 1.141833156394544 0 +345 0.6978641611449509 1.141179812287203 0 +346 0.2541598676914442 1.537498841875233 0 +347 0.7516074000513059 1.530214991369846 0 +348 0.5749999999988812 1.121590436419565 0 +349 0.4249999999989025 1.120996334876456 0 +350 0.5886825120497132 1.742395246458429 0 +351 0.9049999999997509 1.095075210653423 0 +352 0.09499999999982227 1.095075210653024 0 +353 0.14379076891955 1.308427229581727 0 +354 0.8544707740310964 1.305664085757452 0 +355 0.2249252111609139 1.095412579796293 0 +356 0.7750747888379796 1.095412579796752 0 +357 0.4250637377962498 1.359847963402365 0 +358 0.5768274368598336 1.35129270071606 0 +359 0.232351283641529 1.768503569817728 0 +360 0.3802897055841284 1.226198321611149 0 +361 0.6192760303371638 1.22479805545081 0 +362 0.4025305533449121 1.669262073403616 0 +363 0.504999999998701 1.080842025111615 0 +364 0.3540355588524646 1.075474426616115 0 +365 0.644999999999064 1.079635838679168 0 +366 0.7990645241381551 1.730231666731534 0 +367 0.2316891351137946 1.404742804797436 0 +368 0.7694331512231478 1.402730452017867 0 +369 0.1545042280176006 1.063593299286463 0 +370 0.8454957719816769 1.063593299286772 0 +371 0.2849999999993101 1.065820086360372 0 +372 0.7149999999992496 1.065820086360718 0 +373 0.09377905012273467 1.225368003754102 0 +374 0.9062209498772704 1.225368003754103 0 +375 0.6373218323081091 1.468198342147499 0 +376 0.2437488911468461 1.206227823557092 0 +377 0.7563457096313686 1.204448828360671 0 +378 0.3742987035237452 1.48152301108111 0 +379 0.130120956628325 1.488144491727632 0 +380 0.8842018299350152 1.417708531946811 0 +381 0.4454026484076493 1.061978585006698 0 +382 0.1436146135644482 1.629187449451359 0 +383 0.5629536743808899 1.06080313266998 0 +384 0.9452464482995113 1.054556622190714 0 +385 0.05475355170023977 1.054556622190453 0 +386 0.5950547835237185 1.600890719371526 0 +387 0.8740072178815945 1.542984157925946 0 +388 0.5108757413372551 1.148615146531299 0 +389 0.4502909068163569 1.82938502013177 0 +390 0.320959186607418 1.382362774719732 0 +391 0.6740927104205064 1.374617160813473 0 +392 0.07186653785835088 1.159868242939921 0 +393 0.928133462141609 1.159868242940092 0 +394 0.4959118282364381 1.309385292052621 0 +395 0.3643843179845154 1.13888859794135 0 +396 0.394999999998989 1.049706683155523 0 +397 0.09900920945088526 1.394612170649323 0 +398 0.6342119551505342 1.139828098776277 0 +399 0.1761403003962369 1.239746873375074 0 +400 0.8274952264771659 1.237723114919311 0 +401 0.3119424735119836 1.211680323591548 0 +402 0.6870211765169325 1.211624423530248 0 +403 0.204572779491465 1.049475474480661 0 +404 0.7954272205075397 1.049475474480903 0 +405 0.5641251270693396 1.188701642478922 0 +406 0.6938995237861791 1.848342835421058 0 +407 0.55453485340953 1.256873385419238 0 +408 0.1048764334162882 1.047448610287509 0 +409 0.8951235665832384 1.047448610287716 0 +410 0.5026335410681588 1.395655529701533 0 +411 0.3643240580771657 1.304695217186724 0 +412 0.7096536221770959 1.648333690533706 0 +413 0.4363994351997544 1.18712353107406 0 +414 0.6368321661548365 1.299017190009066 0 +415 0.324999999999193 1.044874475977855 0 +416 0.6751442204991802 1.045403814441373 0 +417 0.6149999999989879 1.045311677015255 0 +418 0.2834057122870183 1.65669529178889 0 +419 0.4424341595009901 1.267051502655688 0 +420 0.2469301178973238 1.14826630595116 0 +421 0.7530698821014439 1.14826630595191 0 +422 0.07143472313351716 1.295821946784376 0 +423 0.9276346844210719 1.295049584115116 0 +424 0.2224279297201235 1.324104723781493 0 +425 0.8633971649281783 1.864639346706618 0 +426 0.1425930199360525 1.117439720643538 0 +427 0.8574069800633141 1.11743972064408 0 +428 0.4313365006717135 1.567463047102743 0 +429 0.7841807853234315 1.299559681794741 0 +430 0.4843312226870911 1.043718999612552 0 +431 0.8835672430108014 1.654316002243618 0 +432 0.2472488140342124 1.041119926334183 0 +433 0.7527511859645566 1.041119926334408 0 +434 0.0475989151197406 1.100213359190462 0 +435 0.9524010848800448 1.100213359190834 0 +436 0.5262244164522624 1.039972999530269 0 +437 0.1387448480122291 1.868075170033056 0 +438 0.8182179157022071 1.47531658027092 0 +439 0.1198586083418926 1.735554942864486 0 +440 0.5782092546423236 1.861628818245807 0 +441 0.3227958499757315 1.86550086858886 0 +442 0.2963443339199617 1.45414217456952 0 +443 0.4760358061261165 1.11884223216365 0 +444 0.3360668310449968 1.561700003484749 0 +445 0.5203473837657192 1.669521313702595 0 +446 0.6005435161090046 1.085506457923628 0 +447 0.4362003367629996 1.432232531259177 0 +448 0.1651436870037796 1.373609734503185 0 +449 0.8062768600613532 1.603678045390721 0 +450 0.5721601540390162 1.422483920265093 0 +451 0.2705835837177517 1.108619809700702 0 +452 0.7294164162809211 1.108619809701243 0 +453 0.929392206389964 1.365084835705914 0 +454 0.1864718869718126 1.126018362677127 0 +455 0.8135281130272991 1.126018362677697 0 +456 0.3344082486261599 1.748186264316926 0 +457 0.2329460877155683 1.261831202934324 0 +458 0.3127434919582956 1.098227407216015 0 +459 0.6871248470305197 1.098025283728294 0 +460 0.6666634367468084 1.548678585712974 0 +461 0.7059985982824595 1.443645413628561 0 +462 0.0880348923487676 1.564160737256966 0 +463 0.8962248988273027 1.756537303899436 0 +464 0.1174095429570162 1.156001542818463 0 +465 0.8825904570426577 1.156001542819261 0 +466 0.3945727958490747 1.090005009089835 0 +467 0.8324775331093248 1.372361299807416 0 +468 0.3614282206818003 1.03507407938755 0 +469 0.7403340088783437 1.342877523132671 0 +470 0.5428783977445191 1.096307691144361 0 +471 0.2059344475222542 1.476256816378896 0 +472 0.425738149301633 1.033524767413993 0 +473 0.9246321199467035 1.484420615646103 0 +474 0.1744882687329351 1.553141965653251 0 +475 0.1751514215878712 1.033583309557956 0 +476 0.8248485784112987 1.03358330955813 0 +477 0.6986772632360908 1.744352652800111 0 +478 0.1354786227014112 1.031764002975215 0 +479 0.8645213772979718 1.031764002975363 0 +480 0.515371287911105 1.575021930415143 0 +481 0.04985701529613179 1.20381835688959 0 +482 0.9501429847039704 1.203818356889792 0 +483 0.1356191196138404 1.203391819878145 0 +484 0.8644361939104058 1.203133908868517 0 +485 0.5771546382616788 1.524403817864126 0 +486 0.1902710231370598 1.082273511389928 0 +487 0.8097289768620298 1.082273511390346 0 +488 0.5844780350137612 1.031919667260371 0 +489 0.2949999999992809 1.03218665545763 0 +490 0.6447839974194614 1.032526177169373 0 +491 0.7049999999992214 1.032186655457807 0 +492 0.3386417500680102 1.257812188029089 0 +493 0.3549062890939554 1.18732522773497 0 +494 0.2097435177636035 1.174326610202922 0 +495 0.7902564822353856 1.174326610203758 0 +496 0.6459079348747186 1.186828513620802 0 +497 0.2797423306870386 1.180649839711299 0 +498 0.7212555455889628 1.179591474007765 0 +499 0.2739284282698835 1.343376949108817 0 +500 0.6619618549268813 1.25470389556274 0 +501 0.06974372727177681 1.455592152671457 0 +502 0.03216403228629063 1.032116530624794 0 +503 0.9678359677135613 1.032116530624944 0 +504 0.3828333561213982 1.405700943887016 0 +505 0.4048784758487263 1.158511166190438 0 +506 0.07499999999985285 1.030822819132027 0 +507 0.9249999999997995 1.030822819132173 0 +508 0.4714467339244875 1.164260216518812 0 +509 0.05638110927802219 1.348365021899717 0 +510 0.4553259913329818 1.030077482502192 0 +511 0.5958623226376665 1.157873110951488 0 +512 0.5547414348476822 1.029868773340605 0 +513 0.760452995118204 1.257428995447735 0 +514 0.1319722170854474 1.256878163711136 0 +515 0.8696324864519224 1.258573757825914 0 +516 0.4572442991479824 1.741561175628193 0 +517 0.04814828103691974 1.252553517768934 0 +518 0.9518517189628571 1.252553517769338 0 +519 0.1229207587044873 1.076365566024789 0 +520 0.8770792412949471 1.076365566025116 0 +521 0.203855458945367 1.688748245649081 0 +522 0.2239627504718836 1.609684914668316 0 +523 0.2763901191838297 1.239297140096479 0 +524 0.5862732550271118 1.299917186960195 0 +525 0.2533910647130193 1.076071473630957 0 +526 0.746608935285705 1.076071473631355 0 +527 0.03898608645145495 1.138715992232082 0 +528 0.9610139135485798 1.138715992232449 0 +529 0.4726850006227989 1.083854564865381 0 +530 0.1879677589347564 1.286596558441257 0 +531 0.6179323802290941 1.392486538899737 0 +532 0.5246136467267515 1.189403168958926 0 +533 0.438622568151799 1.505122055911884 0 +534 0.4164012791981738 1.311632414995821 0 +535 0.5138519793785878 1.113764797232734 0 +536 0.5505558842535986 1.152296101333632 0 +537 0.2286319907358996 1.867417555706223 0 +538 0.1453868199239883 1.431983459051211 0 +539 0.9467566053090382 1.421237450062602 0 +540 0.6319082750988454 1.671469534242648 0 +541 0.9268512964147272 1.59618598493076 0 +542 0.6836219048474306 1.325605431183472 0 +543 0.0752100818455609 1.12468940322967 0 +544 0.9247899181541184 1.124689403229922 0 +545 0.0769102984955212 1.67216964801866 0 +546 0.2266702183242972 1.027164454102343 0 +547 0.7733297816745925 1.027164454102493 0 +548 0.5094674813310797 1.264196899877203 0 +549 0.3460718419089456 1.112652257447309 0 +550 0.6539609433060007 1.112582868665854 0 +551 0.03095925860294166 1.075253881247921 0 +552 0.9690407413969335 1.075253881248284 0 +553 0.3723806536000443 1.354835804846698 0 +554 0.5273551167236247 1.790846882407766 0 +555 0.7225962044601031 1.23378066830778 0 +556 0.3950173176655707 1.26871462402894 0 +557 0.8828755332595645 1.351456441184084 0 +558 0.7653573584609243 1.464506585398373 0 +559 0.4535664057216711 1.225202082826928 0 +560 0.7808572111062158 1.813954609853594 0 +561 0.7736518006864613 1.908899104393791 0 +562 0.07958294756056862 1.066870977253348 0 +563 0.1081572010676713 1.343581737917401 0 +564 0.9204170524390723 1.066870977253651 0 +565 0.4272240465958173 1.08888385026421 0 +566 0.3180579033420357 1.319725536656434 0 +567 0.7883947112036476 1.349437668616844 0 +568 0.5256144948566308 1.350578018113227 0 +569 0.8140267334883057 1.536180092638261 0 +570 0.3168980447747105 1.501858811864778 0 +571 0.4738100646241676 1.353989244197258 0 +572 0.1817751161976196 1.199514735523571 0 +573 0.8191202158725644 1.199992414668096 0 +574 0.1094412303760258 1.123859586718336 0 +575 0.890558769623521 1.123859586718911 0 +576 0.6072316071079984 1.115182507181506 0 +577 0.5407759365081095 1.300398237819001 0 +578 0.2687145685562897 1.028267818260896 0 +579 0.7312854314423486 1.028267818261052 0 +580 0.3848499011084606 1.026220027758316 0 +581 0.09438381662255753 1.187827283366739 0 +582 0.9056161833777533 1.187827283366877 0 +583 0.5381752219618656 1.067269536279207 0 +584 0.4035860052508178 1.9085339591121 0 +585 0.4933266463598208 1.906876434721966 0 +586 0.5791726680740346 1.224396131825406 0 +587 0.2236307030788081 1.127656637560064 0 +588 0.776369296920125 1.127656637560704 0 +589 0.7240101678577586 1.39005283925881 0 +590 0.5071306834769315 1.02625513141825 0 +591 0.3193444349961477 1.175643043238262 0 +592 0.2788484115801563 1.39277161430332 0 +593 0.2291431614987724 1.063034403560922 0 +594 0.7708568385000947 1.063034403561262 0 +595 0.7004693288541993 1.501744798367538 0 +596 0.6808691982410278 1.175490553125656 0 +597 0.8187947105819663 1.419523644513117 0 +598 0.3453210823463811 1.634395215945646 0 +599 0.05572254946890599 1.510845131907316 0 +600 0.3962669583047747 1.123996924313109 0 +601 0.1610911214063988 1.094851142463035 0 +602 0.8389088785928496 1.094851142463484 0 +603 0.4655126411242813 1.6215263669657 0 +604 0.5984505789434684 1.26008984836154 0 +605 0.5276125684044863 1.45335230450441 0 +606 0.4012227660695611 1.192196291299601 0 +607 0.5732641923368413 1.090592014021488 0 +608 0.6017031352219305 1.192719313123014 0 +609 0.5915857119596174 1.05822828647841 0 +610 0.3131646032185611 1.070868119354563 0 +611 0.6868059079327227 1.070880372134253 0 +612 0.04687169832595089 1.398384554542657 0 +613 0.4373238795439551 1.150317819767526 0 +614 0.03245394526644756 1.174104559919675 0 +615 0.9675460547336536 1.174104559919884 0 +616 0.718550209908918 1.582842817849688 0 +617 0.8749173617249391 1.470681398428636 0 +618 0.8230523744243365 1.281352424224439 0 +619 0.07895518036043786 1.811813076251157 0 +620 0.2082028320168079 1.223734683991199 0 +621 0.7896444750335313 1.223404834676072 0 +622 0.6467635294185026 1.801653110195687 0 +623 0.6469062969066819 1.91420798254675 0 +624 0.104999999999807 1.023705229002148 0 +625 0.8949999999997217 1.023705229002247 0 +626 0.7711757512590844 1.66515641734804 0 +627 0.9548380205133138 1.331633358682849 0 +628 0.5299936044782878 1.225084057652564 0 +629 0.6574620269413445 1.42070492433435 0 +630 0.1981889624062577 1.024890894031797 0 +631 0.8018110375928029 1.024890894031918 0 +632 0.6209181603243408 1.346268299270745 0 +633 0.3391650416318992 1.024665133074319 0 +634 0.2844836266571301 1.589577585708552 0 +635 0.9415188663418799 1.538229576488797 0 +636 0.4192758564183099 1.057652982670849 0 +637 0.6517914139308951 1.608816183609679 0 +638 0.9423647441389441 1.705967568047342 0 +639 0.4555037721575113 1.304048527328971 0 +640 0.379452767186408 1.814361250475803 0 +641 0.3357722291285306 1.141650135089167 0 +642 0.4173464661051023 1.226707887981034 0 +643 0.9223024049908609 1.906069030610277 0 +644 0.6651635023958936 1.141772030982669 0 +645 0.4673525941927508 1.196043115007613 0 +646 0.9298954366245888 1.821874496146171 0 +647 0.1834429980742782 1.058380130575113 0 +648 0.8165570019248389 1.058380130575404 0 +649 0.3759462771784473 1.061302503952137 0 +650 0.1549999999996889 1.02221252282042 0 +651 0.8449999999995867 1.022212522820531 0 +652 0.2475564184779633 1.299889332127325 0 +653 0.2504710027680291 1.453151165689995 0 +654 0.2745060729982198 1.1382096137547 0 +655 0.7254939270004104 1.138209613755408 0 +656 0.6146826352280125 1.023768448068067 0 +657 0.3480876393771392 1.218320149655876 0 +658 0.3353900204201292 1.422177612590626 0 +659 0.164744018633862 1.79898400239591 0 +660 0.06136688115016602 1.616576484513275 0 +661 0.3151488066220225 1.022604313855231 0 +662 0.8180341197256054 1.317837195040082 0 +663 0.05081468179599744 1.02043497625855 0 +664 0.9491853182037735 1.020434976258642 0 +665 0.6535555701545785 1.219810214182851 0 +666 0.09621011880110795 1.263978198508291 0 +667 0.9086652393369654 1.262947028991559 0 +668 0.6846135277903629 1.020786696508784 0 +669 0.5614276279877052 1.475012107783639 0 +670 0.3859848290187913 1.543251293990811 0 +671 0.1801337726086816 1.336234406647904 0 +672 0.450690562024449 1.10375028210227 0 +673 0.6525579664355614 1.053661542809959 0 +674 0.4518420797877518 1.390859658623436 0 +675 0.863194229940893 1.602393221548905 0 +676 0.5072419189512092 1.055580801080491 0 +677 0.7996397202508009 1.258535168113664 0 +678 0.6208534869099951 1.070467992210701 0 +679 0.6214819367662816 1.093820312696573 0 +680 0.5504476470798463 1.384313375717408 0 +681 0.5385801555017435 1.123675515015415 0 +682 0.3461661413192844 1.056636093517496 0 +683 0.08312641484563575 1.918454894790681 0 +684 0.5736752371555937 1.656200270238859 0 +685 0.4749529830694161 1.535501085771155 0 +686 0.474999999998756 1.02119976559362 0 +687 0.06116647035632453 1.080027491555228 0 +688 0.9388335296434021 1.080027491555599 0 +689 0.2902609242367211 1.092466405302242 0 +690 0.7097390757618164 1.092466405302733 0 +691 0.1921143744799669 1.439214249394353 0 +692 0.3688173944349879 1.101172545697751 0 +693 0.4708959074629217 1.255796333059937 0 +694 0.2104642353092421 1.366605532913096 0 +695 0.4956770080563517 1.176708192573298 0 +696 0.03544579990692806 1.31261815245473 0 +697 0.2906181420916345 1.800169314422933 0 +698 0.1826874667777417 1.923689544068806 0 +699 0.2788079446919697 1.723487117810183 0 +700 0.8954983700176242 1.316352287984157 0 +701 0.4065983848656299 1.021686330095798 0 +702 0.7469595602463371 1.307263741791362 0 +703 0.5350061574492293 1.019802261500719 0 +704 0.2732209111343161 1.923784880056412 0 +705 0.1642993460496607 1.139158603729777 0 +706 0.8357006539495735 1.139158603730439 0 +707 0.2450618270813173 1.020151332089083 0 +708 0.7549381729174609 1.020151332089197 0 +709 0.6778664241681795 1.288727433175952 0 +710 0.02321986608265446 1.053552581468502 0 +711 0.9767801339172393 1.053552581468754 0 +712 0.6637800237508615 1.019673250132107 0 +713 0.9648920616781493 1.285360057838596 0 +714 0.4700428252082163 1.061348707599324 0 +715 0.6959664684676375 1.25596411311435 0 +716 0.274336154868959 1.486857053664732 0 +717 0.859555809988204 1.70710620490268 0 +718 0.3948773504896747 1.729793310929485 0 +719 0.375459424328313 1.166833218046657 0 +720 0.6259729348091094 1.517232753959606 0 +721 0.1051207993864324 1.293982979665758 0 +722 0.1489963915488253 1.685718413104741 0 +723 0.12197099217751 1.102971434274687 0 +724 0.8780290078219228 1.102971434275165 0 +725 0.6224034537111914 1.168741878062297 0 +726 0.4782346811296834 1.457195269046559 0 +727 0.1916588275864359 1.153305401110045 0 +728 0.808341172412639 1.15330540111074 0 +729 0.8290715396551643 1.659912084697822 0 +730 0.2695777097337912 1.04623887496122 0 +731 0.7304222902648487 1.04623887496146 0 +732 0.3832988932168223 1.594890512279816 0 +733 0.23940255049482 1.176184851616829 0 +734 0.7605974495040165 1.17618485161771 0 +735 0.2997606355031102 1.114700265991839 0 +736 0.7002458984271072 1.114693200965817 0 +737 0.1350437084035231 1.054480564031925 0 +738 0.8649562915958616 1.054480564032177 0 +739 0.1535489845508016 1.042207986976496 0 +740 0.8464510154484944 1.042207986976704 0 +741 0.30901978967761 1.243605663149359 0 +742 0.3253416060451962 1.690207729830557 0 +743 0.5346068490343162 1.727438836572012 0 +744 0.02573684457220856 1.114825325769857 0 +745 0.9742631554277377 1.114825325770101 0 +746 0.8344175404560306 1.774396056578362 0 +747 0.1295299807760892 1.535211494863679 0 +748 0.9447800288308483 1.650953644708485 0 +749 0.0528581554567815 1.72193971791524 0 +750 0.0920474170988192 1.145470529203618 0 +751 0.9079525829010122 1.145470529204047 0 +752 0.2423443279418369 1.111699486614291 0 +753 0.7576556720569906 1.111699486614849 0 +754 0.6176178344116282 1.426428827483588 0 +755 0.4909462759205802 1.099217897989591 0 +756 0.2025650979701836 1.100066226241647 0 +757 0.7974349020288216 1.100066226242132 0 +758 0.2847081921562871 1.21287736086785 0 +759 0.8582753181417773 1.931742848137956 0 +760 0.07350146430712444 1.098180701794621 0 +761 0.9264985356925344 1.098180701795035 0 +762 0.2504804308953618 1.366429950529226 0 +763 0.1758405404669717 1.737825380517377 0 +764 0.4492771293794934 1.129927817775632 0 +765 0.3199551262486476 1.280932793007847 0 +766 0.6306615739083007 1.268997354379919 0 +767 0.1695619102620896 1.507805457993693 0 +768 0.206817653132825 1.068672067828947 0 +769 0.7931823468661675 1.068672067829293 0 +770 0.1388865773955359 1.141595002649761 0 +771 0.8611134226038619 1.141595002650475 0 +772 0.7264377386871367 1.698569524523234 0 +773 0.1462190433959284 1.23264913638115 0 +774 0.8539250492147981 1.232272956556789 0 +775 0.5327335382141311 1.53149462873611 0 +776 0.3312608165783479 1.080865103700489 0 +777 0.6709377155380395 1.081180031413402 0 +778 0.1038223262446245 1.434252626593483 0 +779 0.3957141263811421 1.446312390112534 0 +780 0.5423518164594813 1.045766800746079 0 +781 0.7656825601534485 1.576956265475083 0 +782 0.457771578467531 1.673756860525292 0 +783 0.1386052984819073 1.177774628988324 0 +784 0.8613947015174809 1.177774628989154 0 +785 0.03064047675698196 1.228422238228792 0 +786 0.9692984182498403 1.228560049614654 0 +787 0.3052929899393282 1.049468038574465 0 +788 0.6946611523550207 1.049539835347877 0 +789 0.9594770046973375 1.458433612853462 0 +790 0.1621524829917373 1.265857814480317 0 +791 0.9601012575361855 1.386569755895768 0 +792 0.2469316846177428 1.237495906239972 0 +793 0.4874058124764199 1.141762884680299 0 +794 0.4381852144054595 1.017579803230586 0 +795 0.7038379148887731 1.356190112030703 0 +796 0.1643546501515032 1.465369649396486 0 +797 0.3209782524407079 1.122529743021743 0 +798 0.03140041854011572 1.280975321460325 0 +799 0.6796548079837164 1.122455612933911 0 +800 0.8479028893300604 1.508397242784909 0 +801 0.781461123383506 1.500275373296001 0 +802 0.4017251044733837 1.069185231670215 0 +803 0.3639894499329577 1.0175308856422 0 +804 0.2110236677891623 1.52267675785457 0 +805 0.3352150220181531 1.932190367522508 0 +806 0.2215733283575031 1.151701975123256 0 +807 0.7784266716413957 1.151701975124007 0 +808 0.01732335881401268 1.017288754910273 0 +809 0.9826766411859112 1.017288754910306 0 +810 0.584113732952564 1.93468825658745 0 +811 0.1451124223790181 1.34394987548412 0 +812 0.5732117507522227 1.017266357000999 0 +813 0.1320485497884978 1.581379616183636 0 +814 0.7142250957385593 1.93436460746508 0 +815 0.1397577237023708 1.091389127401331 0 +816 0.86024227629698 1.091389127401738 0 +817 0.5477097286139612 1.613511529721244 0 +818 0.8964405404792415 1.384421660303715 0 +819 0.7592515402809309 1.766580445021483 0 +820 0.1027690986309362 1.06762285053724 0 +821 0.8972309013685922 1.067622850537532 0 +822 0.3379618690102277 1.460519758985365 0 +823 0.1230826102563555 1.01854899165203 0 +824 0.8769173897430907 1.018548991652111 0 +825 0.6184121476452416 1.561174626292751 0 +826 0.8475726314166462 1.33967925933898 0 +827 0.3686254642033712 1.251233838531329 0 +828 0.1266919706459415 1.375311365833281 0 +829 0.06703733796428706 1.230791447389639 0 +830 0.9329626620356544 1.230791447389813 0 +831 0.8873821998342596 1.285140734274467 0 +832 0.6492956341968291 1.724042238840412 0 +833 0.2634519459183526 1.265702117636851 0 +834 0.7149503558518808 1.317866633526652 0 +835 0.5648971388353405 1.56484162942942 0 +836 0.4920220431073269 1.066416542844554 0 +837 0.518743848235153 1.845046013291716 0 +838 0.4182798098737909 1.398915959212635 0 +839 0.7135276344933216 1.20471154674194 0 +840 0.08511963209959281 1.048630554699387 0 +841 0.9148803679000121 1.048630554699599 0 +842 0.598838162057048 1.016857355008949 0 +843 0.3518912447391224 1.158855316424406 0 +844 0.632848718998555 1.018019237482506 0 +845 0.6483547785703244 1.158869785269719 0 +846 0.5737288210390995 1.144659941374075 0 +847 0.02101200697820348 1.094540536350213 0 +848 0.9789879930218649 1.09454053635045 0 +849 0.2029274742840555 1.251949239728037 0 +850 0.3760438501018435 1.081615701034624 0 +851 0.914322897332451 1.444424363886258 0 +852 0.06805100739912706 1.186189790708724 0 +853 0.9319489926010983 1.186189790708768 0 +854 0.5855332095051125 1.794305260711012 0 +855 0.6343591332954933 1.048712883120502 0 +856 0.2849999999993101 1.017258406842087 0 +857 0.7149999999992493 1.017258406842185 0 +858 0.7383434752987191 1.424839730307673 0 +859 0.6752192673054986 1.470065968157034 0 +860 0.08779985109549458 1.017990595009571 0 +861 0.9122001489041109 1.017990595009649 0 +862 0.6528235302694242 1.344019306307661 0 +863 0.1779401265167148 1.599949870808794 0 +864 0.5546530607412045 1.211785712977279 0 +865 0.8513820751604271 1.406981107082139 0 +866 0.04382015169950791 1.551087075978233 0 +867 0.2181650277570157 1.29378777502682 0 +868 0.7974166745205853 1.378995107201303 0 +869 0.07988593648935285 1.323748565666345 0 +870 0.7524694856701515 1.620488599703033 0 +871 0.2962581360430431 1.547569635686735 0 +872 0.4498213345046592 1.082629396880051 0 +873 0.5196297092657058 1.093376025421895 0 +874 0.4419498980022703 1.043150271056709 0 +875 0.568994607856848 1.042535902853124 0 +876 0.3469588125728622 1.331561977430853 0 +877 0.5876260298347696 1.104478412772627 0 +878 0.6878392734148544 1.410049720542555 0 +879 0.5542603151278055 1.078691599257077 0 +880 0.03575722722513339 1.432550694825774 0 +881 0.4467439492385682 1.337612930504251 0 +882 0.5303350227773364 1.166447905910315 0 +883 0.6308753008142262 1.117392401627417 0 +884 0.9232142663124301 1.330128687280605 0 +885 0.05933028558700117 1.864080619328858 0 +886 0.08881770639590164 1.488004959293343 0 +887 0.3882498810844109 1.32456290900526 0 +888 0.8511990058120416 1.441908160647442 0 +889 0.9605570188934992 1.500063951422074 0 +890 0.1822317739143025 1.017639627022243 0 +891 0.8177682260848371 1.017639627022332 0 +892 0.9498142671274913 1.766645879759187 0 +893 0.1207035052929326 1.227768548161322 0 +894 0.8789687249328717 1.224221887760149 0 +895 0.4787621746340503 1.284659820698208 0 +896 0.6006810476486413 1.490735659225033 0 +897 0.3784552070524573 1.044138450055919 0 +898 0.218210089388379 1.566507426468412 0 +899 0.6790669877403435 1.685472310170668 0 +900 0.7391730172755183 1.492899891210004 0 +901 0.02334128481750834 1.201376189411586 0 +902 0.976658715182473 1.201376189411772 0 +903 0.4743238962420662 1.421210505449406 0 +904 0.1821973871908495 1.100805185223681 0 +905 0.8178026128082696 1.100805185224179 0 +906 0.4123510836380153 1.103987037352426 0 +907 0.7645780670357591 1.369536194853452 0 +908 0.8911502033818453 1.507417584351576 0 +909 0.7109396949484268 1.542688014463661 0 +910 0.5652829731956515 1.32051839191376 0 +911 0.05366620553673269 1.121810002453433 0 +912 0.9463337944630141 1.121810002453881 0 +913 0.421846259883653 1.780271626685188 0 +914 0.7282050099572057 1.259413370524345 0 +915 0.2214162017745438 1.197461024401772 0 +916 0.7809827444424337 1.199195793668273 0 +917 0.3750142522908606 1.199544322151415 0 +918 0.1845971709676333 1.177493123268267 0 +919 0.8154028290314971 1.17749312326909 0 +920 0.6333763331752649 1.857707707142758 0 +921 0.1915540986612671 1.398402789430784 0 +922 0.4225921849734932 1.624419298665114 0 +923 0.03387348846111227 1.015899485282361 0 +924 0.9661265115387395 1.01589948528242 0 +925 0.2231574639843962 1.045758009434277 0 +926 0.776842536014497 1.045758009434528 0 +927 0.2725398215141116 1.081257498476481 0 +928 0.7274601784845115 1.081257498476921 0 +929 0.287696081212362 1.156423926965742 0 +930 0.7108249566319291 1.158764699719963 0 +931 0.5916223512374552 1.133720606337292 0 +932 0.2350442647952174 1.652908866044909 0 +933 0.5855938306501858 1.380325120392519 0 +934 0.4715681724035449 1.581028291492537 0 +935 0.8418141408456581 1.259485989507131 0 +936 0.7643817999237927 1.231469244239164 0 +937 0.669995403316218 1.062889432440023 0 +938 0.1595310920820351 1.1885728417315 0 +939 0.8404689079172745 1.188572841732376 0 +940 0.625094108830086 1.199782092796714 0 +941 0.2717971273760793 1.314405739853056 0 +942 0.1871682298225736 1.645354373732688 0 +943 0.1173818456212346 1.034334607369009 0 +944 0.8826181543782377 1.034334607369173 0 +945 0.03189877589768881 1.371201856949706 0 +946 0.03770714788182898 1.477552960024035 0 +947 0.3072870723780685 1.349554356499209 0 +948 0.5608941264376373 1.108136705438094 0 +949 0.6127843368407898 1.314293660968488 0 +950 0.1669286053797976 1.116491127132817 0 +951 0.8330713946194106 1.116491127133367 0 +952 0.841011785908762 1.56825334772903 0 +953 0.1390729585363194 1.015384365982212 0 +954 0.8609270414630409 1.015384365982283 0 +955 0.408610396098658 1.136637931759814 0 +956 0.2727474957353982 1.427683775905435 0 +957 0.4222229175893341 1.016357806279581 0 +958 0.4671424346748636 1.042922357705219 0 +959 0.2126965781286911 1.016632798978344 0 +960 0.7873034218702811 1.016632798978436 0 +961 0.3558393601930892 1.386767720482331 0 +962 0.3005643706533258 1.19031282187702 0 +963 0.8773524753151363 1.812451963402752 0 +964 0.1715393775150516 1.07516201995467 0 +965 0.8284606224841315 1.07516201995504 0 +966 0.7848484138806036 1.434094363967352 0 +967 0.4896467260301543 1.016490847720485 0 +968 0.4090374695796062 1.039661421460267 0 +969 0.04785293513927573 1.039160660371534 0 +970 0.9521470648605014 1.039160660371717 0 +971 0.5192042285394238 1.01639104763949 0 +972 0.7107068551454572 1.796180889260681 0 +973 0.1162135326283688 1.181877349784169 0 +974 0.8837864673713693 1.18187734978523 0 +975 0.2499651433316649 1.329733935364252 0 +976 0.101530015081079 1.611563645251985 0 +977 0.3879863847654005 1.144518011207138 0 +978 0.2876017521159563 1.048751556567512 0 +979 0.7123982478825878 1.048751556567772 0 +980 0.6748264625287863 1.235425032416492 0 +981 0.30128234277826 1.01662504845527 0 +982 0.7676963624331639 1.328675880426054 0 +983 0.3293061123404644 1.062557840500174 0 +984 0.3319474162443696 1.195782095947593 0 +985 0.6676191774403487 1.196414102658601 0 +986 0.01603076109681405 1.037232906096547 0 +987 0.9839692389031077 1.037232906096625 0 +988 0.0237728167223666 1.155397808673102 0 +989 0.9762271832776999 1.15539780867335 0 +990 0.5796953554051784 1.072633604815174 0 +991 0.6023934233408159 1.033792643958504 0 +992 0.2636670648221204 1.162890432890539 0 +993 0.7363329351765793 1.162890432891376 0 +994 0.6393174594094391 1.242479804508066 0 +995 0.2577196191555046 1.125801657172263 0 +996 0.7422803808432327 1.125801657172915 0 +997 0.06925318001422347 1.015416076919484 0 +998 0.9307468199854646 1.015416076919555 0 +999 0.9693398153186322 1.357454839924715 0 +1000 0.4164151595852283 1.253874359707409 0 +1001 0.4278048029939758 1.468498876034178 0 +1002 0.3591906099290338 1.278158869810226 0 +1003 0.530204894573735 1.412213562155625 0 +1004 0.1906068062079785 1.039816657255773 0 +1005 0.8093931937911105 1.039816657255976 0 +1006 0.6614890112017699 1.503569819347941 0 +1007 0.08728436784372604 1.365199104903088 0 +1008 0.6285051988883447 1.034436664346815 0 +1009 0.6127499493739298 1.144056294141511 0 +1010 0.5630892057169667 1.283066295016315 0 +1011 0.420061208438303 1.282443376695496 0 +1012 0.6486233908940694 1.015782496410471 0 +1013 0.2392160293569889 1.496598062407582 0 +1014 0.7636850866090904 1.284514689735623 0 +1015 0.09280397515413977 1.11444210765936 0 +1016 0.9071960248453916 1.114442107659803 0 +1017 0.3908298290229613 1.296473534928996 0 +1018 0.3570969256837546 1.513787243780693 0 +1019 0.4937145947038362 1.119776222429542 0 +1020 0.3011417699143227 1.417335682079365 0 +1021 0.535852822695271 1.274640122608464 0 +1022 0.6994729783965448 1.187941200321058 0 +1023 0.6992454682576172 1.016634976191159 0 +1024 0.7543715370226114 1.859974057558124 0 +1025 0.52213598020332 1.32102277528815 0 +1026 0.4984882904558169 1.338154690025477 0 +1027 0.453042611509742 1.941634900706103 0 +1028 0.5317434507261012 1.14349089166425 0 +1029 0.07576651641425737 1.417638095801315 0 +1030 0.9610217559471596 1.574479236630343 0 +1031 0.1604917762563934 1.213202960246828 0 +1032 0.8393358742972696 1.213012715060642 0 +1033 0.2533043276454702 1.095272315543577 0 +1034 0.7466956723533112 1.095272315544064 0 +1035 0.2051791141809452 1.137452636653062 0 +1036 0.7948208858180859 1.137452636653693 0 +1037 0.4764212749072455 1.788568293079991 0 +1038 0.5183443969227232 1.068965302220556 0 +1039 0.2588864111108916 1.189057439459088 0 +1040 0.7411135888878539 1.189057439460056 0 +1041 0.6092676172239896 1.285168890166481 0 +1042 0.6605249056169841 1.037289440931298 0 +1043 0.08002756883388029 1.206142615735062 0 +1044 0.9199724311664677 1.206142615735259 0 +1045 0.09255756052184733 1.033764991064498 0 +1046 0.9074424394777344 1.033764991064648 0 +1047 0.2554401950341439 1.058463570059767 0 +1048 0.744559804964575 1.058463570060075 0 +1049 0.9092071797876939 1.560598448136613 0 +1050 0.1311875568177489 1.944127962111655 0 +1051 0.4552236224512686 1.014850753853796 0 +1052 0.0292818724631451 1.342011367700425 0 +1053 0.3729537025080666 1.121835884452202 0 +1054 0.4240391690753835 1.169071485835996 0 +1055 0.4908120604233604 1.709691052377504 0 +1056 0.0950333449551794 1.168642583115016 0 +1057 0.9049666550448063 1.168642583115446 0 +1058 0.2160518152260851 1.814661904713744 0 +1059 0.55567518745793 1.014397568857115 0 +1060 0.344624197812278 1.040238710609723 0 +1061 0.04697726977973533 1.157456826726417 0 +1062 0.5101785563923218 1.239416087560102 0 +1063 0.9530227302203623 1.157456826726629 0 +1064 0.5774768754272473 1.16841610755576 0 +1065 0.4496231757060124 1.17040906319534 0 +1066 0.1104091998713541 1.205009845943742 0 +1067 0.8895908001287585 1.205009845944253 0 +1068 0.4699642066362467 1.491426532187457 0 +1069 0.4069941249805112 1.852659895008483 0 +1070 0.4351062845121629 1.21024686095713 0 +1071 0.8078474282445104 1.86196677252668 0 +1072 0.3962311796043581 1.373538074038283 0 +1073 0.6426834915883372 1.373191361642871 0 +1074 0.3206507348510015 1.603280990226957 0 +1075 0.589945325313159 1.456824413013083 0 +1076 0.9751811035022794 1.259113773789341 0 +1077 0.1176502788948742 1.059261450855904 0 +1078 0.882349721104576 1.059261450856158 0 +1079 0.08960154393460185 1.5247868019029 0 +1080 0.3617487314489472 1.43706916597798 0 +1081 0.01672564688097562 1.134098993152536 0 +1082 0.9832743531190394 1.134098993152721 0 +1083 0.1964018427018784 1.310704454554017 0 +1084 0.03864703065873284 1.059921518824767 0 +1085 0.9613529693410905 1.059921518825047 0 +1086 0.4534559287543344 1.884793343662517 0 +1087 0.04698705756953726 1.778070073464848 0 +1088 0.06237605580063066 1.141360655307879 0 +1089 0.9376239441990379 1.141360655308076 0 +1090 0.06891141872568582 1.04683203206937 0 +1091 0.9310885812739933 1.04683203206959 0 +1092 0.4736314826835565 1.32540770122966 0 +1093 0.06703082981185354 1.27105185563872 0 +1094 0.9327811214695709 1.269073793312503 0 +1095 0.6021373889833467 1.699828213200178 0 +1096 0.5584707826822748 1.132469266243076 0 +1097 0.863488528217939 1.378352110216156 0 +1098 0.2902117698043898 1.26033299790055 0 +1099 0.5011931542425805 1.040130698839658 0 +1100 0.2365098776918482 1.080115166220042 0 +1101 0.7634901223069654 1.080115166220452 0 +1102 0.04440309113455441 1.656832720451006 0 +1103 0.9264789138049752 1.394642416693109 0 +1104 0.2591182893134713 1.015108001587667 0 +1105 0.7408817106852218 1.015108001587754 0 +1106 0.6532594277221753 1.278453077011473 0 +1107 0.7006787139208592 1.230088738061946 0 +1108 0.4307488462440198 1.071913306297576 0 +1109 0.5038756623246924 1.199140274258191 0 +1110 0.5144832785213653 1.288881941804271 0 +1111 0.8570624818758337 1.280462041411847 0 +1112 0.2622766136635372 1.219335751676736 0 +1113 0.5059361000286065 1.616606751512862 0 +1114 0.02435229388447152 1.260437274686242 0 +1115 0.1514987515658174 1.399072558371672 0 +1116 0.6435069330559549 1.09827329187248 0 +1117 0.4013790429946008 1.50429808815484 0 +1118 0.5448537626758532 1.182577725348483 0 +1119 0.3502748759863072 1.014715868918223 0 +1120 0.2271625550769119 1.723464227730544 0 +1121 0.1680780570161887 1.014768798196081 0 +1122 0.8319219429830211 1.014768798196153 0 +1123 0.01612157377241585 1.068583287858511 0 +1124 0.9838784262275513 1.068583287858851 0 +1125 0.2107888131967949 1.03422457922024 0 +1126 0.7892111868021889 1.034224579220399 0 +1127 0.170077575570412 1.306890007245519 0 +1128 0.96446725914928 1.61489265528045 0 +1129 0.6171282442080105 1.633952939785105 0 +1130 0.1392455552605454 1.072264392394617 0 +1131 0.860754444738809 1.072264392394939 0 +1132 0.4673730393193751 1.141346674094104 0 +1133 0.08037730913511788 1.08525360001454 0 +1134 0.9196226908645516 1.085253600014918 0 +1135 0.5392374691044528 1.499917124911838 0 +1136 0.500507661967947 1.366415948825976 0 +1137 0.1310993912053274 1.284183979150925 0 +1138 0.6081506402700735 1.0603398946826 0 +1139 0.3450952957259867 1.094396680620111 0 +1140 0.2632140217185417 1.622803503307088 0 +1141 0.3206098558574353 1.156322140155059 0 +1142 0.6795105079739993 1.154868186584574 0 +1143 0.8164463568610144 1.349341624818541 0 +1144 0.5816697939685267 1.202504989059667 0 +1145 0.1070712199643722 1.244307087377708 0 +1146 0.8946770858769926 1.244995448867616 0 +1147 0.1188463134212067 1.789037814288943 0 +1148 0.9752126980741912 1.312250835241471 0 +1149 0.3279377418496755 1.014324132417214 0 +1150 0.118332750746222 1.322568619377422 0 +1151 0.1142640479385176 1.655496233638815 0 +1152 0.3940631572554494 1.014085361485176 0 +1153 0.6362795954503547 1.064890646902633 0 +1154 0.5781750259494849 1.248757073254238 0 +1155 0.6899237412610107 1.037639851017039 0 +1156 0.9692231032428993 1.418428702300109 0 +1157 0.2304244292351013 1.01636421293752 0 +1158 0.7695755707637636 1.01636421293761 0 +1159 0.1689714021005658 1.047917782443216 0 +1160 0.8310285978986405 1.047917782443464 0 +1161 0.2767735740689962 1.850697146275869 0 +1162 0.6662215974524117 1.307727800873085 0 +1163 0.5989350359323878 1.236912426522421 0 +1164 0.6676365819098316 1.102130322639346 0 +1165 0.6798484832125943 1.583346017391035 0 +1166 0.9547485371468434 1.871469203552564 0 +1167 0.2970493465702064 1.081238828120493 0 +1168 0.7029506534282867 1.081238828120929 0 +1169 0.4225415884448154 1.534920512767768 0 +1170 0.2227219391655229 1.436259376331281 0 +1171 0.3725541286571634 1.705262112799084 0 +1172 0.03446271388088232 1.588527085831263 0 +1173 0.3951821133074684 1.245125964478851 0 +1174 0.7350046788939972 1.21459751859619 0 +1175 0.4366236914300083 1.241875069126993 0 +1176 0.3336053944597156 1.307315401918199 0 +1177 0.3101880276316399 1.037617782732386 0 +1178 0.3366855792099399 1.795581428929004 0 +1179 0.1084216317660207 1.084916405064285 0 +1180 0.8915783682334816 1.084916405064652 0 +1181 0.4343910849675152 1.69991290490074 0 +1182 0.4759932499312994 1.232707875168285 0 +1183 0.4119728001697494 1.082816303704818 0 +1184 0.5581381923059603 1.233668049754009 0 +1185 0.1827695075909666 1.855632524965281 0 +1186 0.4115711164955508 1.339620902518397 0 +1187 0.8997870444010682 1.622090952459767 0 +1188 0.1298202732700994 1.452968090907417 0 +1189 0.5303625628932096 1.250765945842498 0 +1190 0.3262307633193099 1.229225940268823 0 +1191 0.4686630715451836 1.101432200957633 0 +1192 0.4781386790132462 1.381890160445526 0 +1193 0.8025475828857709 1.571731018726347 0 +1194 0.5982484843677046 1.214893986131703 0 +1195 0.5071280938487064 1.134522290227878 0 +1196 0.9521967649206859 1.945125779974887 0 +1197 0.208946054927438 1.087734952362177 0 +1198 0.7910539450715237 1.0877349523626 0 +1199 0.5454445087416474 1.693807004503302 0 +1200 0.04425590105703177 1.087112571068343 0 +1201 0.9557440989427626 1.08711257106872 0 +1202 0.4348713832640062 1.105130020306964 0 +1203 0.1212387324129834 1.410725387443975 0 +1204 0.8748081708171568 1.332494210010687 0 +1205 0.531701500824432 1.949440570608314 0 +1206 0.1905644263512034 1.220225003028779 0 +1207 0.8114543953925862 1.221038415210947 0 +1208 0.5838233149909822 1.01346723817484 0 +1209 0.8948030020751232 1.697460265348612 0 +1210 0.3854086562146177 1.062799568064158 0 +1211 0.1058513327249278 1.703989972331406 0 +1212 0.2378974128992069 1.129832306194317 0 +1213 0.7621025870996405 1.129832306194978 0 +1214 0.3508166508861011 1.130810142089118 0 +1215 0.223501475636426 1.241876441706235 0 +1216 0.03990967374134053 1.694053066877621 0 +1217 0.1285763858643799 1.129429057654668 0 +1218 0.8714236141350802 1.129429057655287 0 +1219 0.6470098631159311 1.131224790135127 0 +1220 0.3869221786982499 1.107016953422077 0 +1221 0.5338857487059122 1.107989197217155 0 +1222 0.594259816424455 1.412340834705424 0 +1223 0.08097562939594526 1.244007189079537 0 +1224 0.9203040709736917 1.242973931036239 0 +1225 0.7312975847315546 1.466502539877618 0 +1226 0.3768371532388788 1.771926153656685 0 +1227 0.3851744991021436 1.63534160915883 0 +1228 0.6672818104517914 1.646693033572066 0 +1229 0.06844028229426127 1.065025969133274 0 +1230 0.9315597177054284 1.065025969133579 0 +1231 0.2976136708814533 1.225253262659552 0 +1232 0.2324365785646558 1.956645751796542 0 +1233 0.8076261185975664 1.949514482014995 0 +1234 0.5272970932159979 1.054967731944338 0 +1235 0.7398596297786042 1.281761775878691 0 +1236 0.6749558891658085 1.013560677437725 0 +1237 0.6088770878552974 1.102815819193598 0 +1238 0.5475695392382699 1.345764172627341 0 +1239 0.3315603475102415 1.104054958468724 0 +1240 0.2576233010837896 1.68680344282223 0 +1241 0.1974623474063127 1.195582362239602 0 +1242 0.8026290130081681 1.195631105010289 0 +1243 0.4485117697187572 1.370204681587779 0 +1244 0.3974036243935294 1.17528784972531 0 +1245 0.6180052055277383 1.248862935485071 0 +1246 0.3781005450341657 1.013278222746576 0 +1247 0.8932980850819866 1.94991634803484 0 +1248 0.2551066866345831 1.030786767446896 0 +1249 0.7448933133641282 1.030786767447065 0 +1250 0.2950093327238816 1.763759658062241 0 +1251 0.9077064765402743 1.354067237478569 0 +1252 0.4864383754210707 1.08646762422074 0 +1253 0.2811006527517921 1.034299794402836 0 +1254 0.7189062356839639 1.034315781362493 0 +1255 0.5325855615335903 1.083191867795916 0 +1256 0.5968207119303641 1.359082961686952 0 +1257 0.5855577491076152 1.327815823573339 0 +1258 0.4920234116599588 1.157294782650777 0 +1259 0.7968434960206228 1.77173407237564 0 +1260 0.2697006728666986 1.064555284921215 0 +1261 0.7302993271319501 1.064555284921558 0 +1262 0.2638894904382683 1.579297994558265 0 +1263 0.285125205610623 1.367059530435991 0 +1264 0.8080681840712355 1.686980391860552 0 +1265 0.1988360824370556 1.346371187157398 0 +1266 0.2210868364101463 1.107660533742082 0 +1267 0.7789131635887757 1.107660533742606 0 +1268 0.3477480826867645 1.358460883125359 0 +1269 0.5441630848075065 1.034228557501702 0 +1270 0.2957062757016458 1.301996665259004 0 +1271 0.2373735526417196 1.033470287641567 0 +1272 0.7626264473571078 1.033470287641752 0 +1273 0.7432849730992642 1.238466666660619 0 +1274 0.7655354323486602 1.705088640507602 0 +1275 0.3104792744560319 1.481964609942909 0 +1276 0.552275115096119 1.448808372931466 0 +1277 0.5414872493534836 1.900237630178375 0 +1278 0.561876305326539 1.763381288632418 0 +1279 0.6745564396241781 1.03143545053497 0 +1280 0.5296842038708257 1.380796159560034 0 +1281 0.7811289864350623 1.543394073796156 0 +1282 0.5514227985736257 1.830867943066162 0 +1283 0.499092151846725 1.751543856082354 0 +1284 0.698926949137658 1.304106306903707 0 +1285 0.4540711508408158 1.049815452939203 0 +1286 0.1824119709117939 1.260697355657497 0 +1287 0.1964425640817918 1.060976065928913 0 +1288 0.803557435917259 1.060976065929218 0 +1289 0.9462244609740303 1.303789785276324 0 +1290 0.6424553026566601 1.328161558121473 0 +1291 0.6064799172631002 1.176318138502318 0 +1292 0.7980359198812659 1.281264115151046 0 +1293 0.4019039525756251 1.215844002663783 0 +1294 0.799990899530184 1.324653649285214 0 +1295 0.3018041839316535 1.1703078363915 0 +1296 0.2749849291949251 1.014037084654936 0 +1297 0.7250150708036864 1.014037084655016 0 +1298 0.9205823767806327 1.513861697064001 0 +1299 0.03558660959702013 1.045698919450772 0 +1300 0.9644133904028299 1.045698919450992 0 +1301 0.1538317161502786 1.082755103213785 0 +1302 0.8461682838489977 1.082755103214174 0 +1303 0.3416340672056184 1.072936402756499 0 +1304 0.5570794333549717 1.167023806777678 0 +1305 0.8111935379353494 1.505449894896943 0 +1306 0.3368801009114792 1.173285988831283 0 +1307 0.8159573031906487 1.260186624811216 0 +1308 0.3664748224067241 1.879783841642942 0 +1309 0.6632549853008139 1.173048695517503 0 +1310 0.5809876230090266 1.045135940485993 0 +1311 0.3835712702538189 1.953552580776986 0 +1312 0.2266364801947291 1.354192187973581 0 +1313 0.2788015096627693 1.117916702394729 0 +1314 0.721198490335866 1.117916702395343 0 +1315 0.5208465880537497 1.212421849634813 0 +1316 0.837463829767092 1.626479860315993 0 +1317 0.5493451930918662 1.062889936150788 0 +1318 0.06232682554474273 1.033603828122874 0 +1319 0.9376731744549724 1.033603828123033 0 +1320 0.8303159237440187 1.823404142090441 0 +1321 0.6290557105190713 1.756878716622504 0 +1322 0.1954167111353211 1.010625940397088 0 +1323 0.8045832888637392 1.01062594039714 0 +1324 0.2055804492321563 1.119950622236444 0 +1325 0.7944195507668509 1.119950622237036 0 +1326 0.7881231338227134 1.458995167237009 0 +1327 0.06627932221822729 1.380967099540743 0 +1328 0.6766623623309993 1.442153706001752 0 +1329 0.4919175654574046 1.030281002704754 0 +1330 0.8343708105342499 1.304370391104469 0 +1331 0.9121450963689021 1.419349345451634 0 +1332 0.5105999368907171 1.423504044893142 0 +1333 0.6569057044723534 1.070379030552191 0 +1334 0.802338556606096 1.238211395778497 0 +1335 0.6970671169175946 1.163463418671204 0 +1336 0.231187807851162 1.224460978449169 0 +1337 0.3262454577867037 1.032784405252578 0 +1338 0.7326059697824412 1.371109073786136 0 +1339 0.393536995428678 1.034289729464825 0 +1340 0.3601191962050916 1.050639404155833 0 +1341 0.5058124497111409 1.097299906122886 0 +1342 0.6874166110571479 1.891601714653192 0 +1343 0.05567537089012627 1.178618114630763 0 +1344 0.9443246291099983 1.178618114630873 0 +1345 0.1484757769158896 1.158041713811067 0 +1346 0.8515242230834029 1.158041713811824 0 +1347 0.428213491074337 1.0468994561553 0 +1348 0.7573304234267674 1.951734240410933 0 +1349 0.5145540346942643 1.170119558743787 0 +1350 0.9011775312106528 1.866074137513676 0 +1351 0.9636567588267799 1.681512133762253 0 +1352 0.3170323106081283 1.262907739964797 0 +1353 0.9592273235099233 1.736967063163039 0 +1354 0.6563831445931259 1.39682051025599 0 +1355 0.4186121358867979 1.199876470381781 0 +1356 0.4135217584530143 1.424818262948549 0 +1357 0.2390356803107166 1.057348146646894 0 +1358 0.760964319688089 1.057348146647204 0 +1359 0.4577019289232521 1.279764572910742 0 +1360 0.504994865789132 1.008730706005746 0 +1361 0.8235213169400097 1.39483121054813 0 +1362 0.1091560533704775 1.143778124737088 0 +1363 0.8908439466292198 1.143778124737719 0 +1364 0.1122239274870524 1.271353930843264 0 +1365 0.5980269648593466 1.072577695503483 0 +1366 0.3721695815631691 1.0296019928432 0 +1367 0.1782870773589796 1.138113414804288 0 +1368 0.8217129226401865 1.138113414804914 0 +1369 0.9077045412438723 1.285342661599792 0 +1370 0.3547587411296007 1.242734551226264 0 +1371 0.781309978768695 1.633019535872545 0 +1372 0.3756458429560244 1.566089563723524 0 +1373 0.1622245164869955 1.416091382791415 0 +1374 0.6787206475367338 1.349663720382962 0 +1375 0.4480193009228002 1.197839780311325 0 +1376 0.2211602872128621 1.07827693169737 0 +1377 0.7788397127860359 1.078276931697751 0 +1378 0.4277147122316601 1.140120387918699 0 +1379 0.3125054059005411 1.63616681540862 0 +1380 0.4520191600589123 1.462413316353598 0 +1381 0.4780912759175534 1.176399487714507 0 +1382 0.4552471842362025 1.070927048475333 0 +1383 0.09948904966319957 1.467316327520788 0 +1384 0.01673059310966755 1.17795735871048 0 +1385 0.983269406890404 1.177957358710483 0 +1386 0.5245238935145241 1.472368380963238 0 +1387 0.04931199799953665 1.069359224603661 0 +1388 0.9506880020002355 1.069359224603994 0 +1389 0.6981477076797283 1.611153637015575 0 +1390 0.6160160546197366 1.96334948232346 0 +1391 0.1116460558047521 1.012727116874489 0 +1392 0.8883539441947464 1.012727116874542 0 +1393 0.7136699046471631 1.417797386501919 0 +1394 0.460621788231202 1.247883901503063 0 +1395 0.7911884271444105 1.40758209260233 0 +1396 0.206014605607537 1.276440389924756 0 +1397 0.7789529625096036 1.240532917965696 0 +1398 0.963963837467823 1.8119075273891 0 +1399 0.6963203486421858 1.477910174755796 0 +1400 0.3578535292272713 1.065855914913647 0 +1401 0.8825475330044039 1.449269539741745 0 +1402 0.3332063783061395 1.539846641249134 0 +1403 0.4468155443447985 1.601477710782173 0 +1404 0.6977993447283805 1.378783191223039 0 +1405 0.6321611182588698 1.083026541081841 0 +1406 0.08475757031901335 1.7655707381442 0 +1407 0.2162733233479228 1.056705987473216 0 +1408 0.7837266766510161 1.056705987473511 0 +1409 0.5923200487370578 1.556282133788927 0 +1410 0.5024140405504284 1.523825017410743 0 +1411 0.6755367480429364 1.95500418874565 0 +1412 0.585302376318118 1.275309169700233 0 +1413 0.04611372998506449 1.953669509922682 0 +1414 0.04166467767575872 1.834625112014256 0 +1415 0.09841948698576948 1.013789090993405 0 +1416 0.9015805130137871 1.013789090993464 0 +1417 0.5855988532257326 1.184214798487958 0 +1418 0.6138771557322263 1.084598032433125 0 +1419 0.07961535751714653 1.173717697897167 0 +1420 0.9203846424829583 1.173717697897389 0 +1421 0.09388964622270515 1.848787072349182 0 +1422 0.681362068123701 1.269051519939747 0 +1423 0.02428973759383199 1.392908134080392 0 +1424 0.682753430852495 1.054979335546691 0 +1425 0.7398588050883511 1.567982920576331 0 +1426 0.2970532175716006 1.333045997602025 0 +1427 0.1284600707858684 1.046254798064075 0 +1428 0.8715399292135432 1.046254798064293 0 +1429 0.5168568859220658 1.027008046865808 0 +1430 0.9633930985562648 1.53005178443705 0 +1431 0.6231848415916569 1.132747412065687 0 +1432 0.9788476593800917 1.330724498042673 0 +1433 0.06073211795988133 1.314268968512277 0 +1434 0.6260720988444692 1.591183241630014 0 +1435 0.04695621898392609 1.012111627343555 0 +1436 0.9530437810158643 1.012111627343613 0 +1437 0.1616284138052639 1.034884911568204 0 +1438 0.83837158619398 1.034884911568383 0 +1439 0.09580254503612032 1.056461271427961 0 +1440 0.9041974549634397 1.056461271428206 0 +1441 0.2552362926413267 1.395397171510955 0 +1442 0.4096927472559348 1.119063817267025 0 +1443 0.293202913333349 1.135091014830442 0 +1444 0.7069751894164503 1.133220292464311 0 +1445 0.8331008013979837 1.741656084893487 0 +1446 0.8840985947546303 1.579137515525924 0 +1447 0.1576505431476743 1.286866874756793 0 +1448 0.2493636691849785 1.801397597213157 0 +1449 0.3007747224298952 1.388205626986782 0 +1450 0.6249126720443516 1.055228272493474 0 +1451 0.5245831136724286 1.127530746859052 0 +1452 0.4319722470154369 1.299030650305157 0 +1453 0.8152025288711811 1.298194439240769 0 +1454 0.6020275023164409 1.050632415683287 0 +1455 0.2930272818319186 1.519316926125008 0 +1456 0.2736462654256175 1.46293010667262 0 +1457 0.7477661082389266 1.396276428289809 0 +1458 0.6293339109123771 1.409732051951666 0 +1459 0.1467675717146781 1.103209049996413 0 +1460 0.8532324282846437 1.103209049996887 0 +1461 0.2279519509102736 1.900101356531651 0 +1462 0.04971231698788624 1.294674114228781 0 +1463 0.8161323101772073 1.894134978752443 0 +1464 0.02824321091941144 1.90522157223009 0 +1465 0.01251764000915863 1.081167122030712 0 +1466 0.9874823599908519 1.08116712203088 0 +1467 0.3573514508105886 1.204735398097151 0 +1468 0.6101994844752797 1.89158484380946 0 +1469 0.02986421501269721 1.526034951228734 0 +1470 0.6076933337046221 1.011758288400327 0 +1471 0.9022480465060874 1.47545467282981 0 +1472 0.09287835819600113 1.082004656801049 0 +1473 0.9071216418036011 1.082004656801392 0 +1474 0.3535865235252714 1.028554080739409 0 +1475 0.6227919001725752 1.012184237444334 0 +1476 0.7365937730613684 1.665025878513171 0 +1477 0.4546934202816162 1.150771076749163 0 +1478 0.6756512914733921 1.783768614804902 0 +1479 0.2995477013510898 1.691341743643306 0 +1480 0.4906731792194428 1.054580577395268 0 +1481 0.3095531183278268 1.083342866075611 0 +1482 0.6904308071550952 1.083323417675065 0 +1483 0.5857933833087164 1.08597193751518 0 +1484 0.4646630736744242 1.010345349191253 0 +1485 0.5408537266307083 1.201325656457649 0 +1486 0.533757626623247 1.648506234262048 0 +1487 0.9158391628949125 1.670876411698502 0 +1488 0.3565174970297745 1.598200949584769 0 +1489 0.08676635959908342 1.287654277814599 0 +1490 0.8459888141912867 1.466384825762305 0 +1491 0.6815667369032885 1.529040007280133 0 +1492 0.8244923932627786 1.448254199395507 0 +1493 0.318299252717366 1.054956464260293 0 +1494 0.1750115020139588 1.089024224567609 0 +1495 0.8249884979852232 1.089024224568065 0 +1496 0.1584066713738506 1.247562575349788 0 +1497 0.2422549531785792 1.281505114043959 0 +1498 0.1052260249087069 1.106327016353782 0 +1499 0.8947739750907995 1.106327016354175 0 +1500 0.3067763933482186 1.965264441618542 0 +1501 0.4765787160756468 1.2132007322945 0 +1502 0.1452540563411426 1.03493550768675 0 +1503 0.8547459436581925 1.034935507686917 0 +1504 0.02129122218746901 1.300114597018594 0 +1505 0.844164891391566 1.539297346778372 0 +1506 0.5464941772426861 1.011559249884041 0 +1507 0.5610535925381057 1.047895282995608 0 +1508 0.3010489353222427 1.102809645112322 0 +1509 0.6989320759405568 1.102767654274176 0 +1510 0.2986789950316274 1.063395561756023 0 +1511 0.7013210049668441 1.063395561756364 0 +1512 0.5924087500491066 1.118954460060622 0 +1513 0.7733382975903708 1.269950097542087 0 +1514 0.2468921135568173 1.427056266792553 0 +1515 0.3420236529420274 1.495810115680273 0 +1516 0.1465881506996409 1.764077409919087 0 +1517 0.9121270534322363 1.787919698068142 0 +1518 0.7433335745915791 1.82197183028254 0 +1519 0.1389339345907782 1.04300552206283 0 +1520 0.8610660654085909 1.043005522063034 0 +1521 0.3150593586492489 1.008025813751174 0 +1522 0.26301933091577 1.284528564474793 0 +1523 0.3647286479433904 1.663821609469348 0 +1524 0.3368200573122268 1.124412750615158 0 +1525 0.6656711582090921 1.124262857336009 0 +1526 0.07877081781676794 1.594231130553396 0 +1527 0.1354666642572639 1.825087714741606 0 +1528 0.1663598598539948 1.064867497559414 0 +1529 0.8336401401452118 1.064867497559731 0 +1530 0.08942809212583332 1.306601178871015 0 +1531 0.857529908056945 1.675565889334949 0 +1532 0.6418563263599547 1.203914341741455 0 +1533 0.01338650830518007 1.106972349329796 0 +1534 0.9866134916948553 1.106972349330005 0 +1535 0.1145807784841902 1.512353564030207 0 +1536 0.4887479985797444 1.240943879353358 0 +1537 0.3260686785797539 1.403099614383736 0 +1538 0.5561096398262423 1.091555582118914 0 +1539 0.6037040757391626 1.836589673903682 0 +1540 0.1581552711497942 1.323760706166316 0 +1541 0.01874304569024386 1.215191332205178 0 +1542 0.9811862769201648 1.21527031952507 0 +1543 0.4862117371378305 1.65516333561732 0 +1544 0.3112587971947582 1.720065956844191 0 +1545 0.637742300624771 1.444157149739842 0 +1546 0.1943459229343064 1.77441466636252 0 +1547 0.2810458619562471 1.101621369583768 0 +1548 0.7189541380423613 1.101621369584299 0 +1549 0.620528336291272 1.184452816143784 0 +1550 0.2356672419650671 1.160371051731645 0 +1551 0.7643327580337528 1.160371051732442 0 +1552 0.4058204976661204 1.057702585100289 0 +1553 0.7618680228798127 1.345883004305126 0 +1554 0.650999941311504 1.089969448461361 0 +1555 0.9502317721536241 1.352935894378699 0 +1556 0.5797844335601458 1.059177608524496 0 +1557 0.7303688500399934 1.73446820373542 0 +1558 0.3144191658558659 1.573557051281711 0 +1559 0.7207015213764739 1.514469598376777 0 +1560 0.1346307090920045 1.106201605560626 0 +1561 0.8653692909073718 1.106201605561103 0 +1562 0.6609267440178047 1.834666613928059 0 +1563 0.1181883349000979 1.903641729580386 0 +1564 0.9289275397207835 1.74102793980628 0 +1565 0.0330669587709776 1.102980605319288 0 +1566 0.9669330412289224 1.102980605319444 0 +1567 0.1418840339251989 1.511189420830781 0 +1568 0.6568629905312598 1.586363776375571 0 +1569 0.4759795406325346 1.033836516011811 0 +1570 0.07816277938700485 1.643354779596752 0 +1571 0.4559955475236971 1.116184535124403 0 +1572 0.4115001443294869 1.181050078636877 0 +1573 0.3789893566625959 1.279840405446548 0 +1574 0.06075176103110969 1.108632952307608 0 +1575 0.939248238968586 1.108632952308025 0 +1576 0.5111988585487603 1.045834148294043 0 +1577 0.4026722094848387 1.561434685963921 0 +1578 0.3562307443188961 1.407866265365277 0 +1579 0.4191721287984816 1.153675025368597 0 +1580 0.9792444659793228 1.438593033278843 0 +1581 0.4323219589611959 1.41351019326556 0 +1582 0.08792983002350216 1.131181013004555 0 +1583 0.91207016997618 1.131181013004916 0 +1584 0.1783258219317796 1.356963783664116 0 +1585 0.04324426086459452 1.185776142796404 0 +1586 0.9567557391355163 1.18577614279659 0 +1587 0.154740114872336 1.008021161127617 0 +1588 0.8452598851269455 1.008021161127652 0 +1589 0.6987464304884959 1.272977936042692 0 +1590 0.9148005468749716 1.312045861390605 0 +1591 0.8787694624623098 1.394168887995288 0 +1592 0.3201483001244542 1.137872298075531 0 +1593 0.4936174623866023 1.269627265360317 0 +1594 0.4826470803606446 1.190158823603414 0 +1595 0.6801416026413017 1.138541929336917 0 +1596 0.4168781002614067 1.817699461124223 0 +1597 0.4155725014209651 1.074248816966523 0 +1598 0.0117552071147949 1.048466678824575 0 +1599 0.9882447928851199 1.048466678824712 0 +1600 0.2385352210663191 1.092793607233794 0 +1601 0.7614647789325154 1.092793607234259 0 +1602 0.3444341586977429 1.828757709742545 0 +1603 0.7730650107450523 1.214810497588176 0 +1604 0.731060578609976 1.893701218237031 0 +1605 0.2258311664530152 1.382944693234825 0 +1606 0.1495767527455916 1.131431570479477 0 +1607 0.8504232472537612 1.131431570480128 0 +1608 0.4446825211947514 1.033119963312767 0 +1609 0.04954565825564744 1.220770452212206 0 +1610 0.9504441575788505 1.220793420776711 0 +1611 0.3609770846955486 1.113104704290984 0 +1612 0.5606282635731242 1.361501975399593 0 +1613 0.2079996040968948 1.411386678035299 0 +1614 0.1618416820970086 1.578071432803962 0 +1615 0.04062386767576311 1.115679418172515 0 +1616 0.9593761323240534 1.115679418172818 0 +1617 0.4435244708936735 1.11650327031105 0 +1618 0.175534804777607 1.704895030586384 0 +1619 0.5729504416268045 1.398315542564204 0 +1620 0.2290228098683907 1.308873262282221 0 +1621 0.3259464329783126 1.337244115632636 0 +1622 0.2064978002433709 1.159152844078602 0 +1623 0.793502199755626 1.159152844079351 0 +1624 0.4382413881497792 1.646680487263044 0 +1625 0.06089959888436646 1.096296802371878 0 +1626 0.9391004011153534 1.096296802372278 0 +1627 0.06425719973477335 1.47811437172569 0 +1628 0.3710676634156111 1.183766791295809 0 +1629 0.3363422712871743 1.157778222641568 0 +1630 0.1610069459156927 1.651374550326023 0 +1631 0.4478908755373141 1.528303722517505 0 +1632 0.9839231783189639 1.243276898733598 0 +1633 0.6453982566274626 1.044479911447842 0 +1634 0.9385967721430639 1.445651244910694 0 +1635 0.4049999999989607 1.010325669332425 0 +1636 0.1473492238489656 1.054027230884211 0 +1637 0.8526507761503666 1.054027230884472 0 +1638 0.3940102133418256 1.351778383582751 0 +1639 0.4760247380804355 1.072194522047131 0 +1640 0.8852028059929484 1.266529568120554 0 +1641 0.4416203057786958 1.093516402057662 0 +1642 0.6636782758597186 1.157563453717568 0 +1643 0.9614976357608271 1.907767582905676 0 +1644 0.5760875050384048 1.62603232124672 0 +1645 0.8773866561344099 1.305139728250962 0 +1646 0.9826090494749027 1.275987708963745 0 +1647 0.3403614053517528 1.011517601636396 0 +1648 0.5477421929065333 1.112128814973993 0 +1649 0.5663653936319523 1.073750528243041 0 +1650 0.1083900479288564 1.364805882705171 0 +1651 0.02987665745149662 1.614416037580508 0 +1652 0.3391315209494828 1.27624315923744 0 +1653 0.1493400074749239 1.72255288215618 0 +1654 0.04246079629601342 1.028053921286899 0 +1655 0.9575392037037957 1.028053921287022 0 +1656 0.5664840037456682 1.031470476004189 0 +1657 0.3873002757682726 1.081246655985661 0 +1658 0.07568757025257022 1.054997260558172 0 +1659 0.9243124297470806 1.054997260558419 0 +1660 0.07932143985782369 1.011673816469576 0 +1661 0.920678560141821 1.011673816469627 0 +1662 0.1879403487172224 1.028375997008667 0 +1663 0.8120596512818856 1.028375997008808 0 +1664 0.2291810379992018 1.459215296149387 0 +1665 0.3219486276012629 1.443440418391772 0 +1666 0.6199585669476186 1.109077260294253 0 +1667 0.1021199732966851 1.03491419026822 0 +1668 0.8978800267028566 1.034914190268374 0 +1669 0.7185416726362968 1.339484131299576 0 +1670 0.3023369799534296 1.274879158863818 0 +1671 0.6636110242490182 1.047796247356454 0 +1672 0.01596239100049949 1.243393822479002 0 +1673 0.7141721551714876 1.249119212650614 0 +1674 0.5032942195011828 1.4596582193332 0 +1675 0.9497587152274398 1.270916397068575 0 +1676 0.5380266210029309 1.316610217892344 0 +1677 0.8734803688066715 1.894713121260277 0 +1678 0.3615147625178329 1.093324921907372 0 +1679 0.2635268253303262 1.036544177860199 0 +1680 0.7364731746683402 1.036544177860393 0 +1681 0.3108839341183536 1.904413000187354 0 +1682 0.4962528747428769 1.961032716164873 0 +1683 0.2590993993591028 1.885302552045916 0 +1684 0.4153848228197968 1.592578696140905 0 +1685 0.5643077910258467 1.717451905003975 0 +1686 0.4342278299860741 1.320773040629483 0 +1687 0.6709619065651022 1.212217460684311 0 +1688 0.3991613327593835 1.470540322840005 0 +1689 0.1650556980539425 1.884492126577331 0 +1690 0.4976139725229419 1.553004764708679 0 +1691 0.7296038013271215 1.29786690671069 0 +1692 0.1868074093375889 1.459137669500813 0 +1693 0.8702726182204868 1.627551034319364 0 +1694 0.223689984529217 1.182484164540328 0 +1695 0.7756114334631499 1.185650017080701 0 +1696 0.2612784195375845 1.140051981112966 0 +1697 0.7387215804611251 1.140051981113688 0 +1698 0.1261511812497802 1.089691626141032 0 +1699 0.8738488187496458 1.08969162614144 0 +1700 0.2359484217714043 1.045443145223011 0 +1701 0.7640515782274224 1.045443145223259 0 +1702 0.1686268695969757 1.441026054663444 0 +1703 0.6844186657385044 1.009174928573805 0 +1704 0.131924221922249 1.239018105148526 0 +1705 0.8705361523540117 1.237814505868862 0 +1706 0.4797977074956976 1.054205962947559 0 +1707 0.4811330023484638 1.012009632641965 0 +1708 0.07795727497581416 1.139337367599855 0 +1709 0.9220427250239228 1.139337367599872 0 +1710 0.05821383211572706 1.011759534039748 0 +1711 0.941786167884012 1.011759534039806 0 +1712 0.04917293455488167 1.331799577707842 0 +1713 0.4601970602426647 1.440229817929107 0 +1714 0.04893286990602787 1.271637590800177 0 +1715 0.6359324003533627 1.219892476233232 0 +1716 0.2738614356296792 1.095130728617688 0 +1717 0.7261385643689789 1.095130728618176 0 +1718 0.3105539960236046 1.112797113469678 0 +1719 0.5016014819810687 1.070136473007622 0 +1720 0.02322850060454679 1.457495002737063 0 +1721 0.0109972683052967 1.01099945954156 0 +1722 0.9890027316946527 1.010999459541614 0 +1723 0.7374134245399585 1.321824765953971 0 +1724 0.3820898034075261 1.095570020516798 0 +1725 0.1867452764643828 1.069925629010018 0 +1726 0.8132547235347162 1.069925629010368 0 +1727 0.475593715474494 1.306540168075893 0 +1728 0.6217384907478309 1.36509156942236 0 +1729 0.3373347310416704 1.049338378076901 0 +1730 0.3642837198023857 1.22141463529862 0 +1731 0.1920885756700064 1.57418041362173 0 +1732 0.6893300349513557 1.112544882634943 0 +1733 0.4449999999988435 1.009834419939386 0 +1734 0.1700748860643287 1.150526006389004 0 +1735 0.8299251139348781 1.150526006389683 0 +1736 0.09186582962255053 1.95800540296326 0 +1737 0.5643355014725605 1.009824024904067 0 +1738 0.5289478002885146 1.011402601026616 0 +1739 0.3621653283032414 1.728327737854277 0 +1740 0.6584726955161372 1.237271700011114 0 +1741 0.5427278046878793 1.584458579189472 0 +1742 0.7623183775324321 1.425712092514215 0 +1743 0.02547551206921448 1.009775380546244 0 +1744 0.9745244879306694 1.009775380546281 0 +1745 0.3529412992202863 1.144496753813938 0 +1746 0.4326110221304705 1.059377340742407 0 +1747 0.3662418250752965 1.153629626053834 0 +1748 0.517871980599294 1.080816405729828 0 +1749 0.4319676729204253 1.380808248127539 0 +1750 0.5738926691441627 1.103111176288461 0 +1751 0.6465563042508211 1.144647387878987 0 +1752 0.09859489244969388 1.32544165797598 0 +1753 0.6375339010817939 1.495050913683121 0 +1754 0.6967396601894161 1.71341023553605 0 +1755 0.6593756972627105 1.010935180684107 0 +1756 0.8331184471826958 1.596006363544031 0 +1757 0.8850499853871938 1.722776790980374 0 +1758 0.8961148323183634 1.534881439365525 0 +1759 0.2739818134134839 1.195999635730333 0 +1760 0.6335438316870903 1.155708931309635 0 +1761 0.229037582356828 1.139197728608386 0 +1762 0.7709624176420738 1.139197728609073 0 +1763 0.6039636780548822 1.658153438395696 0 +1764 0.188095597482738 1.377453523538903 0 +1765 0.2555521166439686 1.346933687821055 0 +1766 0.009912930490979698 1.025902423376436 0 +1767 0.9900870695089976 1.025902423376437 0 +1768 0.3623373094897565 1.457841755368865 0 +1769 0.1176242862198361 1.559822930795623 0 +1770 0.5766003665395085 1.498111411997358 0 +1771 0.4571938465119326 1.18471022988318 0 +1772 0.1581275826813519 1.532229576198945 0 +1773 0.5008660600062748 1.815906300647446 0 +1774 0.1854294366842165 1.527509909607555 0 +1775 0.1205315829907918 1.117590990323308 0 +1776 0.8794684170086939 1.117590990323865 0 +1777 0.194964504568624 1.502411683511218 0 +1778 0.4590965769170281 1.092726363822945 0 +1779 0.6381587890015873 1.538042603638914 0 +1780 0.3668236354042959 1.324419947246179 0 +1781 0.6140980181279748 1.454734385857907 0 +1782 0.2595902921870787 1.250432270327945 0 +1783 0.9757327494972733 1.483092236877727 0 +1784 0.2649060638665572 1.748481407340416 0 +1785 0.3055293456664271 1.126873017774059 0 +1786 0.2449999999994267 1.009670990913548 0 +1787 0.7549999999993507 1.009670990913599 0 +1788 0.695046560129568 1.12656046617977 0 +1789 0.5449886796055228 1.024320193064386 0 +1790 0.0649842999542521 1.53495259832372 0 +1791 0.4634572586411065 1.022760819917886 0 +1792 0.03181169190327937 1.503840213539674 0 +1793 0.2425835267004245 1.069599974389253 0 +1794 0.757416473298351 1.069599974389621 0 +1795 0.3320533437947311 1.21349743691756 0 +1796 0.1323338408924918 1.155457519955617 0 +1797 0.8676661591069742 1.155457519956403 0 +1798 0.2565343694781148 1.176225775491501 0 +1799 0.7435126815472837 1.176198523079507 0 +1800 0.01247696085086004 1.122589760942111 0 +1801 0.987523039149141 1.122589760942236 0 +1802 0.06556473889338765 1.213741341722324 0 +1803 0.9344335637458251 1.213745169816564 0 +1804 0.9271478158824468 1.625694674762937 0 +1805 0.4309311121363045 1.011517013271308 0 +1806 0.08109472075434772 1.399353605119127 0 +1807 0.06147971307893951 1.573710923104925 0 +1808 0.6841545248269346 1.189144133171135 0 +1809 0.7657227375403499 1.302215220964341 0 +1810 0.8624439206485932 1.758791645065031 0 +1811 0.155072236528789 1.487716895119892 0 +1812 0.6949704476117879 1.026648443108347 0 +1813 0.1457363513377697 1.364128303971519 0 +1814 0.8403013925211991 1.321032545269435 0 +1815 0.356820763560079 1.542906462989085 0 +1816 0.08550830360346379 1.105011540413705 0 +1817 0.9144916963961174 1.10501154041412 0 +1818 0.02053398411607882 1.324646479081549 0 +1819 0.1240368264947708 1.143213243553162 0 +1820 0.8759631735047608 1.143213243553859 0 +1821 0.6127367096328877 1.03300909492778 0 +1822 0.8934747587653146 1.336047976327256 0 +1823 0.7270739513648025 1.193762448046446 0 +1824 0.1752184368776151 1.126283605545843 0 +1825 0.8247815631215744 1.12628360554642 0 +1826 0.8102041703435074 1.637111916870119 0 +1827 0.6103800280238214 1.158534652353839 0 +1828 0.7500234758731192 1.222111658292078 0 +1829 0.08717097594833297 1.158387265680563 0 +1830 0.9128290240516461 1.158387265680887 0 +1831 0.9797871248523023 1.376468907498227 0 +1832 0.3166170696317585 1.190975006797362 0 +1833 0.2146148845766929 1.636298158682441 0 +1834 0.01861447673173511 1.41752576251523 0 +1835 0.3897512578210214 1.159579887361764 0 +1836 0.1266112422386982 1.354737419547293 0 +1837 0.3391692139302137 1.659592054851591 0 +1838 0.2016845130700723 1.210250763781453 0 +1839 0.7992031568300352 1.211166790635472 0 +1840 0.792664126268221 1.524898389460468 0 +1841 0.5573820430114038 1.540049571428264 0 +1842 0.6380740774390484 1.172789027114497 0 +1843 0.2232376464142119 1.00958411914316 0 +1844 0.7767623535846921 1.009584119143212 0 +1845 0.6024686209170629 1.514565844696254 0 +1846 0.2849423695736947 1.078531667484422 0 +1847 0.7150576304248637 1.078531667484845 0 +1848 0.1456100583826198 1.556642836083183 0 +1849 0.4180501201640903 1.026176979778029 0 +1850 0.1936412762776413 1.235186419658842 0 +1851 0.3041497694467667 1.156792131505723 0 +1852 0.1639696274917743 1.957393468776791 0 +1853 0.9737822816262725 1.638971398278397 0 +1854 0.1303393100494752 1.012339003492229 0 +1855 0.8696606899499348 1.012339003492284 0 +1856 0.2563550932659178 1.514428140544755 0 +1857 0.0318659543103559 1.087988973767038 0 +1858 0.968134045689499 1.087988973767478 0 +1859 0.4564654773622829 1.557390433553833 0 +1860 0.2512570647326824 1.476789328142382 0 +1861 0.1792869961406473 1.045135879016064 0 +1862 0.820713003858498 1.045135879016294 0 +1863 0.8415989605671719 1.242962806964758 0 +1864 0.1631740024733374 1.227677131980952 0 +1865 0.5450945626466963 1.137843101241501 0 +1866 0.7781476330352186 1.603777668355222 0 +1867 0.5558912131262865 1.119787333810297 0 +1868 0.204999999999543 1.009149411772196 0 +1869 0.7949999999994576 1.009149411772257 0 +1870 0.4582273797523627 1.262244493653419 0 +1871 0.4254445428999811 1.746596752175994 0 +1872 0.5378374929183676 1.559574970150986 0 +1873 0.03457720511724604 1.212296950800446 0 +1874 0.9654227948826942 1.21229695080066 0 +1875 0.8700209059850211 1.496518551380331 0 +1876 0.5675945355170743 1.3003120461337 0 +1877 0.8496440468217714 1.360526511650975 0 +1878 0.7841465124683823 1.368253165614996 0 +1879 0.2909482692433644 1.612229037726445 0 +1880 0.4141127735951107 1.048124555826303 0 +1881 0.1434679067885991 1.27101494884259 0 +1882 0.3863293159074262 1.188760731051833 0 +1883 0.7618849372965923 1.48607523020365 0 +1884 0.1520930466446257 1.145016989540456 0 +1885 0.8479069533546686 1.145016989541159 0 +1886 0.4001232215111544 1.10958575853212 0 +1887 0.4606722793665414 1.708346148464479 0 +1888 0.1945939971618717 1.111928456343726 0 +1889 0.8054060028371891 1.111928456344265 0 +1890 0.2227624038922636 1.16737024954893 0 +1891 0.777121165772221 1.167897891639661 0 +1892 0.2331825557006087 1.104649197274569 0 +1893 0.7668174442982576 1.10464919727508 0 +1894 0.6575666862515637 1.45527827592039 0 +1895 0.1794842438232933 1.162229785601425 0 +1896 0.82051575617585 1.162229785602169 0 +1897 0.1169971873452828 1.046686485382433 0 +1898 0.8830028126541825 1.04668648538265 0 +1899 0.3053040956980385 1.026769250485196 0 +1900 0.06392993616871255 1.24585270171517 0 +1901 0.936070063831129 1.245852701715393 0 +1902 0.06013750131700139 1.432045095227549 0 +1903 0.3958226291316718 1.023505652321041 0 +1904 0.1924508227629811 1.095149888689246 0 +1905 0.8075491772361134 1.095149888689733 0 +1906 0.377148226163243 1.384683121915274 0 +1907 0.3673738420170892 1.071010433513946 0 +1908 0.2674039214137685 1.378029728527427 0 +1909 0.1344414996845994 1.222108759905904 0 +1910 0.02744647986399516 1.735506331588752 0 +1911 0.8659803798364015 1.221093141281715 0 +1912 0.0876569881871975 1.343636705461433 0 +1913 0.6538996920355378 1.026097605344896 0 +1914 0.6933701665226202 1.563787524063246 0 +1915 0.7123807038560013 1.266110315202807 0 +1916 0.5095885034584053 1.184820151560342 0 +1917 0.2933597579722765 1.010368072803908 0 +1918 0.5939928235128039 1.040269355732589 0 +1919 0.5696269032516708 1.266516651681863 0 +1920 0.8619498806529748 1.422974738371203 0 +1921 0.2367565364115237 1.192976067184187 0 +1922 0.7627325250576875 1.192078160427286 0 +1923 0.7441097986637095 1.593083500344335 0 +1924 0.07171557645244529 1.076598344915446 0 +1925 0.9282844235472408 1.076598344915794 0 +1926 0.9347120007217984 1.567878552007669 0 +1927 0.8233423111854732 1.710581195280778 0 +1928 0.2618309309568392 1.204429643427829 0 +1929 0.3828665712359585 1.131614629498487 0 +1930 0.306063105488766 1.834469317280389 0 +1931 0.07397811590968398 1.695754684989576 0 +1932 0.551829080481935 1.427418097095619 0 +1933 0.6271692125494556 1.286971920848768 0 +1934 0.8265006754485748 1.223679790649367 0 +1935 0.2579098681207076 1.047262021849317 0 +1936 0.7420901318780004 1.04726202184957 0 +1937 0.5178858147592814 1.700687013220689 0 +1938 0.3279855027971465 1.247727616175733 0 +1939 0.7669991237691466 1.734910024566651 0 +1940 0.6274613154507542 1.699365570343305 0 +1941 0.09577685086407008 1.209376818520836 0 +1942 0.9042231491367253 1.209376818521126 0 +1943 0.2060120022232498 1.746963032947698 0 +1944 0.4787036845354107 1.852040693945571 0 +1945 0.1704541376211083 1.177970402666852 0 +1946 0.8295458623781076 1.177970402667681 0 +1947 0.14416662426055 1.189927231182806 0 +1948 0.85583337573882 1.189927231183569 0 +1949 0.4803838477741659 1.514226289217374 0 +1950 0.0156776004375533 1.274148142540154 0 +1951 0.2981240476860536 1.206007844677198 0 +1952 0.3239839727924476 1.071426663218374 0 +1953 0.08785474620680163 1.884523387382669 0 +1954 0.675580106770746 1.073304072611617 0 +1955 0.2444933799370497 1.253169245062978 0 +1956 0.2084240140641045 1.39119473368074 0 +1957 0.706720130807567 1.677584372371792 0 +1958 0.4985630721814919 1.286583697951079 0 +1959 0.5272648367935169 1.030309746661296 0 +1960 0.1794491930618081 1.483116361983499 0 +1961 0.612466595261273 1.537821890578596 0 +1962 0.9487159971720964 1.371233950340879 0 +1963 0.6423907119281544 1.010599178919727 0 +1964 0.9653928597467655 1.24668944924121 0 +1965 0.645245503128506 1.260030604115 0 +1966 0.7082398288968355 1.174555644289763 0 +1967 0.02736770568715491 1.064256349414609 0 +1968 0.9726322943127153 1.064256349414922 0 +1969 0.5680345081402352 1.594095559129904 0 +1970 0.362563884902023 1.171575296280291 0 +1971 0.4157620768697803 1.008619152368975 0 +1972 0.2681937934565681 1.957420060780857 0 +1973 0.9743938418550899 1.553111234286536 0 +1974 0.6791418009711589 1.250053136850562 0 +1975 0.2784198226526192 1.05637801625902 0 +1976 0.7215801773459838 1.056378016259317 0 +1977 0.02753429274848121 1.041934772296269 0 +1978 0.972465707251381 1.041934772296453 0 +1979 0.1256376071734777 1.302219577829865 0 +1980 0.2609838056415137 1.086317206399151 0 +1981 0.7390161943571902 1.086317206399599 0 +1982 0.3676316620391438 1.234919150069465 0 +1983 0.5019209186998863 1.109358723710899 0 +1984 0.6677218717434913 1.753575097246623 0 +1985 0.479680976008357 1.095710771767852 0 +1986 0.4825622058110138 1.127951198384719 0 +1987 0.6637594993211857 1.328674258715477 0 +1988 0.03463095676034268 1.24747100852619 0 +1989 0.9371262009871737 1.317695419714111 0 +1990 0.4627619036874025 1.210014839253461 0 +1991 0.5113398094517708 1.224128721267505 0 +1992 0.1704701232449447 1.394540156805218 0 +1993 0.9013876922001541 1.596167525349352 0 +1994 0.5760617612020729 1.007735744418398 0 +1995 0.4520236835492349 1.413634959189053 0 +1996 0.3843314276994749 1.052785872645919 0 +1997 0.2560238928644291 1.110215166345754 0 +1998 0.7064606446168739 1.010452047779177 0 +1999 0.5436292608078989 1.242121071362822 0 +2000 0.7439761071343243 1.110215166346311 0 +2001 0.128203013834791 1.06604649451107 0 +2002 0.8717969861646158 1.066046494511361 0 +2003 0.1638231026155551 1.344567036383962 0 +2004 0.2278375117322295 1.541199029141715 0 +2005 0.437097361665723 1.128646281741983 0 +2006 0.1522173451869736 1.174608683707464 0 +2007 0.847782654812319 1.174608683708255 0 +2008 0.292348746218609 1.242220508949792 0 +2009 0.950141997089236 1.481209888463451 0 +2010 0.8030541759907543 1.362004030032993 0 +2011 0.1260362702479695 1.16985254498585 0 +2012 0.8739637297516609 1.169852544986847 0 +2013 0.758891510663338 1.508405134173101 0 +2014 0.9459306581138512 1.28912645618923 0 +2015 0.70079256369617 1.215690352383343 0 +2016 0.1608953896414062 1.053151652143149 0 +2017 0.8391046103578392 1.05315165214341 0 +2018 0.8673264847469432 1.520896980552137 0 +2019 0.4217217054647685 1.967189886739287 0 +2020 0.5670290114423467 1.158265665607041 0 +2021 0.8806414424851595 1.372527903961492 0 +2022 0.8404250379701619 1.277474672985963 0 +2023 0.1921012955458994 1.049549523920727 0 +2024 0.8078987044531749 1.049549523920973 0 +2025 0.1667596275776418 1.025704905452568 0 +2026 0.833240372421572 1.025704905452702 0 +2027 0.699469288966292 1.335437285881577 0 +2028 0.447163015802219 1.79955888093813 0 +2029 0.2015129249994881 1.547535917057872 0 +2030 0.2956382843634384 1.043318504715491 0 +2031 0.7043328220147673 1.043326308630081 0 +2032 0.149815425092113 1.452000026728363 0 +2033 0.03322219127291086 1.1276583390886 0 +2034 0.9667778087270498 1.127658339088923 0 +2035 0.6024721618403006 1.341253534719694 0 +2036 0.7165605180680079 1.370507799258252 0 +2037 0.08211482328749958 1.436591101799652 0 +2038 0.6775270146101005 1.107470769230827 0 +2039 0.5324294510389613 1.047176526105539 0 +2040 0.05834643421919659 1.043557151751575 0 +2041 0.9416535657805349 1.04355715175178 0 +2042 0.4373309311078256 1.081646688323138 0 +2043 0.1757150562566806 1.009333843141428 0 +2044 0.8242849437424866 1.009333843141474 0 +2045 0.606435889235086 1.129939411271857 0 +2046 0.5674075782240189 1.200250734669209 0 +2047 0.2002405263313292 1.035252963107884 0 +2048 0.7997594736677088 1.035252963108054 0 +2049 0.5523157243353665 1.040903584941117 0 +2050 0.2513120474041305 1.600223033278485 0 +2051 0.008869757682282854 1.06090774539327 0 +2052 0.991130242317674 1.060907745393404 0 +2053 0.428572337150359 1.021999380817825 0 +2054 0.9798449062744337 1.3988480892044 0 +2055 0.8560898397849038 1.249100717623396 0 +2056 0.379906043111042 1.504713625053354 0 +2057 0.272532818139513 1.151381550821801 0 +2058 0.7272559015513816 1.151715946930214 0 +2059 0.356745541492913 1.009917679246867 0 +2060 0.6846557308686028 1.305860243175372 0 +2061 0.08714079832757156 1.734909779511169 0 +2062 0.8400150590438813 1.424156279737596 0 +2063 0.5933383741432143 1.008958334910085 0 +2064 0.2705136801267467 1.553460155605202 0 +2065 0.965385333701911 1.843014132114027 0 +2066 0.6386966745422131 1.355488786214845 0 +2067 0.8665252251706854 1.971809501410483 0 +2068 0.9820949512587762 1.297096437138225 0 +2069 0.03615638995613647 1.150604770057545 0 +2070 0.9638436100439778 1.150604770057832 0 +2071 0.4895994311900977 1.437839367573432 0 +2072 0.1514131063759163 1.603336188169901 0 +2073 0.4177696222708859 1.448159842847469 0 +2074 0.6103923412652905 1.208648684626435 0 +2075 0.3442076737687241 1.442134370437397 0 +2076 0.3404386207122936 1.969127580425501 0 +2077 0.5444207867287427 1.168506061880991 0 +2078 0.4795481514829413 1.10794642130366 0 +2079 0.2009848388279936 1.886086828398841 0 +2080 0.6148075888515304 1.265721875828371 0 +2081 0.09658846249911561 1.414472733446401 0 +2082 0.02353660305992512 1.028593042207709 0 +2083 0.9764633969399723 1.028593042207789 0 +2084 0.04681438408732135 1.454884805392139 0 +2085 0.451175577132779 1.039110595021683 0 +2086 0.5797938481339602 1.134012273139594 0 +2087 0.609934940545047 1.072246520391785 0 +2088 0.1449656292904127 1.008223463394859 0 +2089 0.8550343707089234 1.008223463394896 0 +2090 0.590460099736939 1.170984208737595 0 +2091 0.5292696632865045 1.759059703937938 0 +2092 0.4883221154853772 1.479002461273176 0 +2093 0.5806648813343145 1.022275255686573 0 +2094 0.05129973305321583 1.134712957097158 0 +2095 0.9487002669466476 1.134712957097605 0 +2096 0.04426282461234832 1.049400337207207 0 +2097 0.955737175387451 1.049400337207442 0 +2098 0.8099763954840026 1.798573898416366 0 +2099 0.4661317279311475 1.127806744688285 0 +2100 0.7483715743899884 1.448137144407937 0 +2101 0.09502051656371546 1.043905955397741 0 +2102 0.9049794834358547 1.043905955397932 0 +2103 0.2318473580149737 1.117791116100699 0 +2104 0.7681526419839296 1.117791116101271 0 +2105 0.4482731064374137 1.022160747257612 0 +2106 0.3904237451632521 1.424236798817851 0 +2107 0.7217970621698427 1.76667148339369 0 +2108 0.3961510664141517 1.230308961788109 0 +2109 0.6064958462041103 1.023120951699352 0 +2110 0.07827044573813537 1.221524332051237 0 +2111 0.9217295542618398 1.221524332051461 0 +2112 0.9430398101745519 1.399891910807088 0 +2113 0.5465874879587067 1.869794292935753 0 +2114 0.3214036490763777 1.088510236500664 0 +2115 0.6786623141279533 1.088426701333874 0 +2116 0.5520376257110979 1.193525564168789 0 +2117 0.1299015217104029 1.186260615674174 0 +2118 0.8701076972099632 1.186217630506735 0 +2119 0.5929184663678062 1.434598570127111 0 +2120 0.2017401129760921 1.079678988950125 0 +2121 0.7982598870229237 1.079678988950528 0 +2122 0.1151957459583702 1.024969933208169 0 +2123 0.884804254041114 1.02496993320828 0 +2124 0.2746327014355624 1.255510554686107 0 +2125 0.2472826508168402 1.220350543469557 0 +2126 0.01273565874639171 1.163923468083115 0 +2127 0.9872643412536666 1.163923468083227 0 +2128 0.4712512329975019 1.399596369631081 0 +2129 0.132111284008946 1.022647928026197 0 +2130 0.8678887159904536 1.0226479280263 0 +2131 0.1807586128299933 1.672997320175485 0 +2132 0.136101380073499 1.322928893301953 0 +2133 0.3437952484083727 1.082829196403842 0 +2134 0.5868410512445059 1.145284134045907 0 +2135 0.438603114066438 1.28215724617847 0 +2136 0.6853938462836076 1.045800050598333 0 +2137 0.07561781945562387 1.112309247825873 0 +2138 0.9243821805439293 1.112309247826226 0 +2139 0.5560095425502198 1.516250594280434 0 +2140 0.01871380242351933 1.355514239171304 0 +2141 0.4959481301902377 1.592706067739345 0 +2142 0.07797514699932538 1.021065725418745 0 +2143 0.9220248530003248 1.021065725418842 0 +2144 0.6637545542748219 1.863511076446011 0 +2145 0.3353636582360394 1.038373684102795 0 +2146 0.1645229955356057 1.083357920346921 0 +2147 0.4875327168789771 1.682941262859293 0 +2148 0.8354770044636202 1.083357920347322 0 +2149 0.3761083345513266 1.84687142048503 0 +2150 0.2741008468502953 1.224925449319769 0 +2151 0.6333181207285565 1.105407244731822 0 +2152 0.1755858547231468 1.213850074413578 0 +2153 0.0261757603801651 1.80159747629283 0 +2154 0.6007160861068624 1.576760455524258 0 +2155 0.1793214923670735 1.114422410292022 0 +2156 0.8206785076320341 1.114422410292585 0 +2157 0.6365350515204296 1.0384250866456 0 +2158 0.1693255843156125 1.624881200064417 0 +2159 0.02164870612970708 1.565387712577066 0 +2160 0.6354508407273606 1.028215418302689 0 +2161 0.08270077109235817 1.037857516254943 0 +2162 0.9172992289072571 1.037857516255114 0 +2163 0.5998321287691302 1.769364797826695 0 +2164 0.8298178491891557 1.336571357819605 0 +2165 0.7527859353988637 1.330997162859243 0 +2166 0.5258435291239074 1.303178670179201 0 +2167 0.5116849957764512 1.642206686824897 0 +2168 0.4776052058869856 1.151412640668384 0 +2169 0.01242659049893313 1.145731527548932 0 +2170 0.9875734095011103 1.14573152754917 0 +2171 0.8994886050807953 1.300374556985441 0 +2172 0.2496617762402528 1.161951873983885 0 +2173 0.7503422246961428 1.161949556602649 0 +2174 0.5623022331621876 1.021829685663601 0 +2175 0.7985830155877583 1.662256342634103 0 +2176 0.4468485119230721 1.143439840939882 0 +2177 0.4995799472483723 1.145753470585167 0 +2178 0.5385558254411901 1.36449961192785 0 +2179 0.3152725617578118 1.301914044049464 0 +2180 0.2019650834310384 1.716905711027309 0 +2181 0.8709055538433237 1.274553834352554 0 +2182 0.352717671148069 1.259891628720189 0 +2183 0.4137835368403202 1.212724644096485 0 +2184 0.7829125414814452 1.283070722091011 0 +2185 0.8345090748393948 1.491459210364769 0 +2186 0.4647665742582281 1.032948237937426 0 +2187 0.6572127978963609 1.479948171438262 0 +2188 0.10687252195885 1.586323961651251 0 +2189 0.5421004732268 1.076863751249264 0 +2190 0.1173760866278616 1.390861612958324 0 +2191 0.9448717414548565 1.51610757247957 0 +2192 0.3974005433439814 1.135590000617764 0 +2193 0.7974348103751557 1.482895490993941 0 +2194 0.3148713400133976 1.045500140778384 0 +2195 0.06797456480814938 1.087495973976509 0 +2196 0.9320254351915567 1.087495973976895 0 +2197 0.5219576539716246 1.154555784792072 0 +2198 0.3904272688864535 1.204473783123806 0 +2199 0.3977708065818873 1.392026131897953 0 +2200 0.5945803455850158 1.027906802244898 0 +2201 0.4019486570923889 1.284101626938114 0 +2202 0.2765171062125843 1.025066889101606 0 +2203 0.7234887981607393 1.025080592209863 0 +2204 0.1758557526560303 1.27775460757229 0 +2205 0.9136518823238828 1.375396452990999 0 +2206 0.7443960407730932 1.266873315075178 0 +2207 0.12459080310233 1.431662300570973 0 +2208 0.4480100586917132 1.484851401399625 0 +2209 0.2944378100425409 1.496329730399626 0 +2210 0.8044837195806125 1.440617180702402 0 +2211 0.6399006031828921 1.391510323739811 0 +2212 0.3690439829379977 1.009642632848299 0 +2213 0.170060425218992 1.104164627670242 0 +2214 0.8299395747802024 1.104164627670734 0 +2215 0.2286028152215735 1.037350276990135 0 +2216 0.7713971847772998 1.037350276990342 0 +2217 0.2934789486989772 1.0223920844985 0 +2218 0.6240986683788222 1.024477051803363 0 +2219 0.1067063187395025 1.058628892594812 0 +2220 0.8932936812599981 1.058628892595063 0 +2221 0.1019544830037276 1.156168329210506 0 +2222 0.898045516996135 1.156168329211049 0 +2223 0.1949932944472074 1.167360191180254 0 +2224 0.8050067055518592 1.167360191181032 0 +2225 0.6603777903850399 1.525662481711951 0 +2226 0.245391803708043 1.839016074433248 0 +2227 0.3536320252392992 1.100940444907367 0 +2228 0.430124478536677 1.339336612917217 0 +2229 0.8981725405470772 1.404937256092329 0 +2230 0.7056960397471062 1.966866997920286 0 +2231 0.7065906866764419 1.022438731214329 0 +2232 0.2012001018747546 1.296400206811763 0 +2233 0.5382723984422578 1.056627237162958 0 +2234 0.3798666203494291 1.310251258741632 0 +2235 0.3990227367746531 1.310108703462735 0 +2236 0.9117525192661133 1.64479300902244 0 +2237 0.4951810597463845 1.008451206003383 0 +2238 0.3856346040606316 1.008168370836947 0 +2239 0.2087041922933102 1.662087307904705 0 +2240 0.3500211561285503 1.315240935638154 0 +2241 0.3672262886427102 1.043981484963431 0 +2242 0.1857050544428206 1.00959084544459 0 +2243 0.8142949455562938 1.009590845444634 0 +2244 0.5509801862589658 1.272620855548112 0 +2245 0.2140945244988742 1.098129765853059 0 +2246 0.7859054755000723 1.098129765853532 0 +2247 0.4021674146340235 1.696762127597667 0 +2248 0.5147155367269787 1.008293638884416 0 +2249 0.4369845258039767 1.165050585233715 0 +2250 0.5206700377111164 1.138172889735004 0 +2251 0.546795981103024 1.224721312396716 0 +2252 0.3025089281790439 1.368300007658468 0 +2253 0.2341126445558551 1.518265510477182 0 +2254 0.4356367600180777 1.226413554981793 0 +2255 0.2369969387214383 1.023583745817155 0 +2256 0.7630030612773915 1.023583745817285 0 +2257 0.4559812611581235 1.320533350905662 0 +2258 0.2335734519951339 1.681423422958383 0 +2259 0.4292872480628778 1.671242647141369 0 +2260 0.264472788858505 1.410511893550946 0 +2261 0.2571714983681211 1.31441854883512 0 +2262 0.6033216968307413 1.300647053559742 0 +2263 0.370079851951482 1.91253016377385 0 +2264 0.6794529692814966 1.490715166827631 0 +2265 0.647840151516906 1.635057466727348 0 +2266 0.06135947373672783 1.023243990569141 0 +2267 0.9386405262629929 1.02324399056925 0 +2268 0.6248662932447063 1.044861339047427 0 +2269 0.5986620587730942 1.107755736277664 0 +2270 0.7548265455407078 1.644886179436472 0 +2271 0.009383231058508435 1.094546769210551 0 +2272 0.9906167689415144 1.094546769210673 0 +2273 0.1134398551864522 1.071915810670201 0 +2274 0.8865601448130263 1.071915810670512 0 +2275 0.1205171102691512 1.009444704192922 0 +2276 0.879482889730312 1.00944470419296 0 +2277 0.0489887744904819 1.237643560973488 0 +2278 0.9510033134008493 1.237540097751186 0 +2279 0.2688866197010794 1.778305656566948 0 +2280 0.2957130783744299 1.432191137037003 0 +2281 0.08170306107622252 1.190003637189627 0 +2282 0.9182969389240309 1.190003637189772 0 +2283 0.0265612515232721 1.669183113035363 0 +2284 0.2774339130464847 1.271072567261085 0 +2285 0.3620069931151046 1.125667785784697 0 +2286 0.9586595902743323 1.436468808681142 0 +2287 0.7583855466338468 1.795021702291691 0 +2288 0.109669217838644 1.168406388612293 0 +2289 0.8903307821612053 1.168406388612989 0 +2290 0.4257808632309708 1.267606317903767 0 +2291 0.5692392034793637 1.965073394678322 0 +2292 0.717005996876628 1.485352536021845 0 +2293 0.3842787205213968 1.257130098686424 0 +2294 0.9770491638045107 1.593205418819539 0 +2295 0.7237512723442916 1.609343430199297 0 +2296 0.6523260756385681 1.692825755796842 0 +2297 0.6415398522969602 1.055835752825549 0 +2298 0.6473866148370341 1.06562704554478 0 +2299 0.1439734553980161 1.24702207557063 0 +2300 0.9215455716191034 1.462096544002173 0 +2301 0.1546656494557317 1.118004125443832 0 +2302 0.8453343505435619 1.118004125444394 0 +2303 0.8450882357943197 1.38766758924316 0 +2304 0.09526390365603181 1.024926589485136 0 +2305 0.9047360963435404 1.024926589485246 0 +2306 0.9751489074892264 1.71003651193841 0 +2307 0.483382295349191 1.024440346686145 0 +2308 0.5201125974092214 1.51138207790068 0 +2309 0.6924461965592059 1.429243527648868 0 +2310 0.4642437143912083 1.339026206342744 0 +2311 0.3049183415756433 1.008461664762768 0 +2312 0.3118390138473546 1.225711787092636 0 +2313 0.2648776171657372 1.074498456311161 0 +2314 0.735122382832928 1.074498456311559 0 +2315 0.8951581107698734 1.836584734264075 0 +2316 0.1217895541052448 1.211672378617253 0 +2317 0.8782282343793661 1.211098546470539 0 +2318 0.06641206891134892 1.172700183373423 0 +2319 0.9335879310887987 1.17270018337351 0 +2320 0.1073717434058908 1.218946756730697 0 +2321 0.8913038602959973 1.217798449821929 0 +2322 0.2846807038366894 1.143647967582996 0 +2323 0.713041527093548 1.143860802479325 0 +2324 0.1268629993010217 1.337553309125638 0 +2325 0.05709561234444471 1.190760650216339 0 +2326 0.9429043876557501 1.190760650216474 0 +2327 0.5520622519351621 1.406305628507964 0 +2328 0.5842457084275658 1.475504564103277 0 +2329 0.3505918093717602 1.293557554188062 0 +2330 0.1916210558857136 1.140032387424628 0 +2331 0.8083789441133791 1.140032387425264 0 +2332 0.2077155698757716 1.025156481557727 0 +2333 0.7922844301232447 1.025156481557845 0 +2334 0.3637298281476182 1.083497409541887 0 +2335 0.5218386483709547 1.395909361987244 0 +2336 0.2463899594886432 1.084139678373507 0 +2337 0.7536100405101218 1.08413967837395 0 +2338 0.5087632245543942 1.034503281659485 0 +2339 0.802096146906212 1.339519855560701 0 +2340 0.4450712517349534 1.072739927785263 0 +2341 0.344292075680827 1.201122594483379 0 +2342 0.2245335632221269 1.278277771774352 0 +2343 0.4981555014409521 1.088601459809012 0 +2344 0.4236870496346242 1.099704839301133 0 +2345 0.7268906318502145 1.356444381904256 0 +2346 0.6580110871678138 1.363469687951121 0 +2347 0.6444483296814207 1.120136138480627 0 +2348 0.206500046888421 1.59263244337669 0 +2349 0.4636924260648623 1.173488488079738 0 +2350 0.2654646572918291 1.008445754448973 0 +2351 0.7345353427068364 1.008445754449022 0 +2352 0.3265014877061418 1.359338834767213 0 +2353 0.6762687079588712 1.393569658200308 0 +2354 0.9811095987413255 1.511835631740009 0 +2355 0.01315927290548044 1.192460494600644 0 +2356 0.9868407270945394 1.192460494600732 0 +2357 0.6952476703046778 1.008855766010172 0 +2358 0.2661990976369464 1.32899360584412 0 +2359 0.4606967727407756 1.080262989742472 0 +2360 0.4179054261309286 1.490960253609345 0 +2361 0.4497968842408223 1.769685215744619 0 +2362 0.3389250621454352 1.388762446921705 0 +2363 0.3814697860675392 1.035982892395799 0 +2364 0.3013584124700316 1.091348106485285 0 +2365 0.6986245748487731 1.091321212329855 0 +2366 0.2767236146962959 1.165620086925194 0 +2367 0.7226534770979616 1.166520336546416 0 +2368 0.5337444050254593 1.33397028841418 0 +2369 0.5959306874797072 1.096252333343265 0 +2370 0.6836804341957428 1.813088233286651 0 +2371 0.8287839974984158 1.519635857113617 0 +2372 0.5998863768721036 1.145069322781776 0 +2373 0.0406490703173942 1.077659850433175 0 +2374 0.9593509296824165 1.077659850433543 0 +2375 0.2190098595493452 1.069222901724268 0 +2376 0.7809901404495685 1.069222901724616 0 +2377 0.08733254541050008 1.008803615701622 0 +2378 0.9126674545891079 1.008803615701655 0 +2379 0.2173543957771154 1.49837315237014 0 +2380 0.6330061775108567 1.188287088854407 0 +2381 0.6308747319545311 1.008514558289734 0 +2382 0.09206982873417487 1.069350357251731 0 +2383 0.9079301712654164 1.069350357252031 0 +2384 0.1516569801493239 1.202556509649534 0 +2385 0.01552004091228306 1.437256683320709 0 +2386 0.8483528092033974 1.20241870995643 0 +2387 0.02977943533127755 1.867048694239952 0 +2388 0.1327707255350447 1.081032376661927 0 +2389 0.8672292744643423 1.081032376662292 0 +2390 0.6143544677023551 1.723287235189883 0 +2391 0.2828958165869668 1.007954474588847 0 +2392 0.7170742505100419 1.007968470418093 0 +2393 0.6816327337084717 1.630045117136917 0 +2394 0.4347966875263482 1.036496886568068 0 +2395 0.6212887283138765 1.301964830951968 0 +2396 0.1470557202360741 1.917220080289103 0 +2397 0.5750963357773513 1.901911764417661 0 +2398 0.5751126276669639 1.035450141720274 0 +2399 0.9868815746977937 1.227526224792475 0 +2400 0.3158062981237815 1.529930065561749 0 +2401 0.5373512268506833 1.153856641137126 0 +2402 0.07488271101506541 1.506248703292401 0 +2403 0.3628903642233461 1.025794691740807 0 +2404 0.1443088065002906 1.024777956481689 0 +2405 0.8556911934990445 1.024777956481807 0 +2406 0.0607819156414147 1.282940049343619 0 +2407 0.6513752964619469 1.294492809119977 0 +2408 0.5128246276479598 1.88282551548083 0 +2409 0.2115606447741488 1.310436033681391 0 +2410 0.1105575221893233 1.095556962196495 0 +2411 0.8894424778101364 1.095556962196898 0 +2412 0.8668423050189283 1.290685897985153 0 +2413 0.8477850056084667 1.291328515433773 0 +2414 0.6576014023897282 1.205460001679072 0 +2415 0.5174404449227227 1.057377587203173 0 +2416 0.5796255608677263 1.313062082509097 0 +2417 0.2297736655304172 1.208372092822526 0 +2418 0.4127515621233034 1.377753413080143 0 +2419 0.7256206039629089 1.439936279134227 0 +2420 0.6556605726084838 1.102288907934563 0 +2421 0.7175689562404489 1.220932072636383 0 +2422 0.697421629061731 1.201172393001228 0 +2423 0.5346853865425205 1.213530776419037 0 +2424 0.4042946220073286 1.094608865799074 0 +2425 0.3802200732768813 1.071136532231312 0 +2426 0.698927220805335 1.318634077608448 0 +2427 0.8963414791753435 1.435000473311314 0 +2428 0.04060830863109199 1.355708508230532 0 +2429 0.483009615102541 1.165931114740444 0 +2430 0.7819834862331816 1.387428856356128 0 +2431 0.4946713975984484 1.077556774412957 0 +2432 0.43579161692004 1.910885478095247 0 +2433 0.3664873227226103 1.618284690680676 0 +2434 0.2660920317846424 1.118521323051379 0 +2435 0.733907968214054 1.118521323051987 0 +2436 0.7333017283096598 1.407803041538581 0 +2437 0.5434344444458639 1.466586446096726 0 +2438 0.1084641515809967 1.488886667711622 0 +2439 0.8333726130297561 1.685906100322729 0 +2440 0.06426240905092909 1.129424987982342 0 +2441 0.935737590948744 1.129424987982568 0 +2442 0.5227111313346383 1.177624183859562 0 +2443 0.288205862710769 1.195401811311246 0 +2444 0.691180416808395 1.455751973782095 0 +2445 0.5137808638311128 1.103952643389808 0 +2446 0.9669772807958988 1.271286970488561 0 +2447 0.1011827234355184 1.133950863803468 0 +2448 0.8988172765641812 1.133950863804081 0 +2449 0.06432379583407943 1.054920096304593 0 +2450 0.9356762041656257 1.054920096304852 0 +2451 0.1671352718783606 1.201382908862429 0 +2452 0.8333496878351739 1.200910990898491 0 +2453 0.8334431353372178 1.353752967968184 0 +2454 0.9826961612826518 1.460882419695907 0 +2455 0.3347234962956788 1.322537733508801 0 +2456 0.1888835345691721 1.247136318413714 0 +2457 0.201199918520275 1.327515173994747 0 +2458 0.047608747939825 1.418705795349814 0 +2459 0.1421131389231776 1.469891553039637 0 +2460 0.4736451880142024 1.26955045356819 0 +2461 0.1864848443756276 1.82580443035625 0 +2462 0.8635862349904041 1.344291048158857 0 +2463 0.607858238172303 1.378161770341 0 +2464 0.2134684806521862 1.043611974452363 0 +2465 0.7865315193467725 1.043611974452588 0 +2466 0.2170697885937288 1.261972679641198 0 +2467 0.6653327885673148 1.112583618089412 0 +2468 0.4028480559693264 1.031980948436563 0 +2469 0.01306918268954506 1.227506249800406 0 +2470 0.5706896709283737 1.051529441131618 0 +2471 0.2940544974538614 1.473889395584197 0 +2472 0.1103949300739344 1.816076851287972 0 +2473 0.4004694185305982 1.081362101846985 0 +2474 0.6116894790062615 1.809535577550265 0 +2475 0.7125372984926814 1.189879436968841 0 +2476 0.4950925463465343 1.131563329329821 0 +2477 0.673600724589354 1.424745730861811 0 +2478 0.7679311319821593 1.245427047958923 0 +2479 0.5278155936671252 1.073725558412694 0 +2480 0.5647537920816906 1.22235090384175 0 +2481 0.3182142201352389 1.038267744136485 0 +2482 0.7307105340819755 1.24460143968555 0 +2483 0.5052220355286432 1.322112889385458 0 +2484 0.2080602466202005 1.449930318978343 0 +2485 0.1223013727918149 1.679223472738413 0 +2486 0.2297431815266326 1.053327412069824 0 +2487 0.7702568184722273 1.053327412070121 0 +2488 0.2914727956908776 1.877361294072467 0 +2489 0.1128295332170542 1.257829635235314 0 +2490 0.5572526768897683 1.068871194445014 0 +2491 0.6886563521083723 1.365225127920008 0 +2492 0.9201258078599812 1.541350921646632 0 +2493 0.7477565761416181 1.920518225563881 0 +2494 0.4592102675916969 1.060675288033551 0 +2495 0.06685791667303886 1.335875473456547 0 +2496 0.6189873652577433 1.481370800431678 0 +2497 0.8561392263921054 1.265784804462159 0 +2498 0.9778842768414369 1.764106022422698 0 +2499 0.9077682474679726 1.326766493657349 0 +2500 0.2400966280348704 1.628466649581014 0 +2501 0.4004307598922787 1.759126097460738 0 +2502 0.2169448201779346 1.13870751439649 0 +2503 0.7830551798210181 1.138707514397156 0 +2504 0.3223386752368323 1.109626179197909 0 +2505 0.5310420778216919 1.096229406795321 0 +2506 0.3066886690121686 1.667638168593698 0 +2507 0.4047946604028866 1.048093302673197 0 +2508 0.02638778293257049 1.139666719507557 0 +2509 0.9736122170674596 1.139666719507826 0 +2510 0.3191513618747654 1.550520679452815 0 +2511 0.1486540545378149 1.381354277263337 0 +2512 0.2658860648783699 1.444301894815109 0 +2513 0.2344685259676118 1.337595098368086 0 +2514 0.3548672646901477 1.042681314115025 0 +2515 0.2549999999993979 1.007287926784018 0 +2516 0.7449999999993338 1.007287926784064 0 +2517 0.5550215240543818 1.792579410126008 0 +2518 0.1259407089873475 1.607450016704592 0 +2519 0.5154191742448895 1.336516639615168 0 +2520 0.3424096883067851 1.892405460799233 0 +2521 0.9105603993720903 1.719417359195687 0 +2522 0.491454738942629 1.20617921794475 0 +2523 0.6732263419553889 1.022299263980984 0 +2524 0.7430580752959772 1.20260102690801 0 +2525 0.1039099014739094 1.193661257526501 0 +2526 0.896090098526272 1.193661257527041 0 +2527 0.6846852872809485 1.224446181225649 0 +2528 0.8207689912389049 1.558269157343574 0 +2529 0.9392746459407867 1.335927085252018 0 +2530 0.379367471238798 1.153223991895915 0 +2531 0.5720940361450669 1.443410919372026 0 +2532 0.7013456790211355 1.152270471296674 0 +2533 0.5298620938251043 1.288745818290119 0 +2534 0.6363029879174498 1.128476598153378 0 +2535 0.6672184715967526 1.008419341751467 0 +2536 0.196585270431983 1.618133493555558 0 +2537 0.5804299184411017 1.686271262535574 0 +2538 0.6931899798368829 1.17652197360088 0 +2539 0.2346353876000118 1.583881108971837 0 +2540 0.08521620556081834 1.027738039394153 0 +2541 0.9147837944387944 1.027738039394278 0 +2542 0.6246996730273499 1.146432601727515 0 +2543 0.4599707566434424 1.5099051811675 0 +2544 0.2792751343594291 1.043557490500691 0 +2545 0.7207256856912051 1.04355939371038 0 +2546 0.3400363126671407 1.23289961771773 0 +2547 0.1499176889434355 1.092036808942738 0 +2548 0.8500823110558688 1.092036808943163 0 +2549 0.855581027742098 1.648764974182349 0 +2550 0.1053949332094417 1.53955918550553 0 +2551 0.8282007383357128 1.252590037115486 0 +2552 0.3099346299457577 1.062399834998713 0 +2553 0.08138930525559313 1.469273180661253 0 +2554 0.07858807124297797 1.258722840546687 0 +2555 0.9235162067448727 1.25774658665901 0 +2556 0.6704309120100591 1.710057776059305 0 +2557 0.2058741041496006 1.058717842698004 0 +2558 0.7941258958493975 1.058717842698295 0 +2559 0.02688037153822537 1.019263096542427 0 +2560 0.973119628461658 1.019263096542486 0 +2561 0.81468299209774 1.376795747251186 0 +2562 0.4034166702609964 1.147140839771551 0 +2563 0.7801865265424012 1.844426025993615 0 +2564 0.6150339681149277 1.00736353804205 0 +2565 0.294938978290965 1.052502766958926 0 +2566 0.7050460714426577 1.052518687096704 0 +2567 0.7319287368217113 1.63574421567549 0 +2568 0.3340946506599562 1.093147791460886 0 +2569 0.4404316102494155 1.052949799364807 0 +2570 0.9047938223845702 1.491835355842626 0 +2571 0.4256619298075464 1.184401828401098 0 +2572 0.6211206450997407 1.330267389266602 0 +2573 0.1250073282127057 1.028011614476925 0 +2574 0.8749926717867289 1.028011614477054 0 +2575 0.3200190013282347 1.781414700543657 0 +2576 0.9189731193720814 1.275265309291993 0 +2577 0.6901067559151041 1.062467578741231 0 +2578 0.304055937200396 1.289722891444562 0 +2579 0.9860693992169491 1.353364625741588 0 +2580 0.3593263150821457 1.342773246238401 0 +2581 0.05944852326034498 1.152965412381895 0 +2582 0.9405514767395645 1.152965412382083 0 +2583 0.7843952779556428 1.882808212907494 0 +2584 0.6324906271196172 1.828195344923558 0 +2585 0.7032001696686101 1.398133290621532 0 +2586 0.06652196976942409 1.835355425494591 0 +2587 0.2097049418753495 1.188455123909301 0 +2588 0.7905936788947983 1.189280018006007 0 +2589 0.5225412693386131 1.600025226039479 0 +2590 0.6798486513412809 1.038107170495391 0 +2591 0.02387478382974286 1.08249634857144 0 +2592 0.9761252161701999 1.082496348571754 0 +2593 0.2779597660864515 1.300678141243776 0 +2594 0.2591217727801293 1.643836903572349 0 +2595 0.7598104551748428 1.551387239951554 0 +2596 0.2889307224182623 1.409949581561286 0 +2597 0.8659438368155949 1.452599915930364 0 +2598 0.4907876541050186 1.352792237830689 0 +2599 0.01498046318300802 1.37349319841058 0 +2600 0.03763922292149573 1.008690344082199 0 +2601 0.9623607770783348 1.008690344082235 0 +2602 0.876632603190035 1.78641928485738 0 +2603 0.8630308744054651 1.562389319726338 0 +2604 0.2933484794348677 1.18082329088673 0 +2605 0.2767919312146016 1.071942282721758 0 +2606 0.3386817151504491 1.716255984530099 0 +2607 0.7232080687840086 1.071942282722145 0 +2608 0.5890315869114644 1.067771595000768 0 +2609 0.7348014888143021 1.228514209363373 0 +2610 0.2496449407004006 1.134574501694504 0 +2611 0.7503550592983742 1.134574501695211 0 +2612 0.6132807059574744 1.924574955876986 0 +2613 0.5201440961598349 1.275999181418699 0 +2614 0.2326648371431266 1.293406394049293 0 +2615 0.1991458628670774 1.96671147504198 0 +2616 0.4374489440809444 1.857404545720575 0 +2617 0.3998859097555322 1.615600570843229 0 +2618 0.02763755847059179 1.188612713552259 0 +2619 0.9723624415294598 1.188612713552409 0 +2620 0.8948036635915393 1.918358328030976 0 +2621 0.6430969430320795 1.022257488351416 0 +2622 0.4219382215270147 1.882488030584234 0 +2623 0.3037267957583709 1.257293440284194 0 +2624 0.576076272208203 1.366954312861611 0 +2625 0.8404191490518897 1.227458673558944 0 +2626 0.2218862152882494 1.019309457166607 0 +2627 0.7781137847106706 1.019309457166717 0 +2628 0.9276243651134165 1.34694280496324 0 +2629 0.06823376491010882 1.199151441126167 0 +2630 0.9317661614507545 1.19915160720702 0 +2631 0.676697511644481 1.923780393053954 0 +2632 0.3950165720325161 1.059971105785633 0 +2633 0.9484162675011533 1.600159769019392 0 +2634 0.698359853853734 1.523096517748169 0 +2635 0.9271563152895147 1.430112539820764 0 +2636 0.4212115752165234 1.110605771996282 0 +2637 0.481729067655641 1.339322306190931 0 +2638 0.410299444455764 1.268669934134591 0 +2639 0.1313749050839675 1.116432713163102 0 +2640 0.8686250949154555 1.116432713163635 0 +2641 0.08552080732061212 1.058498278524766 0 +2642 0.9144791926789948 1.058498278525015 0 +2643 0.3685818410387591 1.266012443924983 0 +2644 0.5024870819690308 1.777413477316763 0 +2645 0.1851803169822588 1.302073384235638 0 +2646 0.5403604092217136 1.260183869263166 0 +2647 0.4093020974519384 1.645491930749867 0 +2648 0.4311431729614566 1.254213630021399 0 +2649 0.2677819516394609 1.173699374978892 0 +2650 0.7322180483592285 1.173699374979808 0 +2651 0.06609118493186687 1.00771389030964 0 +2652 0.9339088150678417 1.007713890309675 0 +2653 0.886333600527577 1.486856373894653 0 +2654 0.1870477402856157 1.189235924520833 0 +2655 0.8129884766171266 1.189430282651496 0 +2656 0.4473228753812691 1.213683908573492 0 +2657 0.2746457085800106 1.531820895213034 0 +2658 0.8504795284220902 1.803595370621843 0 +2659 0.6411313163706881 1.089385539461865 0 +2660 0.1915064933455573 1.019017877247363 0 +2661 0.8084935066535319 1.019017877247449 0 +2662 0.8298899189533036 1.266217949728847 0 +2663 0.670943415912441 1.182607191556009 0 +2664 0.7709272669960461 1.526429200341188 0 +2665 0.785584344950767 1.970392710009836 0 +2666 0.1972581687909536 1.182075555886863 0 +2667 0.8028128642231392 1.182253555053612 0 +2668 0.3821202536900856 1.459636329343728 0 +2669 0.3292816911051026 1.183302337965912 0 +2670 0.3762046127783428 1.110092919710277 0 +2671 0.02490035216207662 1.643795677999869 0 +2672 0.3939766203587988 1.789561675407629 0 +2673 0.6733241855370542 1.166082174356053 0 +2674 0.4237832213186445 1.007298794383973 0 +2675 0.4425854805748365 1.352237802952996 0 +2676 0.6117750087707944 1.406932243873857 0 +2677 0.1492977266574467 1.016045059769873 0 +2678 0.8507022733418605 1.016045059769946 0 +2679 0.7459081625918377 1.360701508648281 0 +2680 0.1202013868247774 1.632031624687146 0 +2681 0.04435793157129748 1.381730065024117 0 +2682 0.4924779926680551 1.411668049949156 0 +2683 0.5455868774917915 1.085322098313106 0 +2684 0.4226062835544963 1.2404640922895 0 +2685 0.03762297543597007 1.262544401207915 0 +2686 0.3414063147641791 1.187075258547122 0 +2687 0.4888055337200645 1.323491481494812 0 +2688 0.2140062695843855 1.007290760395776 0 +2689 0.785993730414567 1.007290760395818 0 +2690 0.0952717258761891 1.238162577061232 0 +2691 0.9059949101832974 1.238901118740743 0 +2692 0.1599095202371173 1.073871276751049 0 +2693 0.8400904797621289 1.073871276751405 0 +2694 0.01854946807793103 1.48230131191092 0 +2695 0.2894496678610404 1.569945309058891 0 +2696 0.3244282302742709 1.007632226875165 0 +2697 0.3267767272415669 1.165379983947205 0 +2698 0.5804611360294702 1.114339465561189 0 +2699 0.7346634671933665 1.540063909171378 0 +2700 0.4787860365311311 1.560280106802425 0 +2701 0.6436781235358668 1.108897743654242 0 +2702 0.1777570062389003 1.02557585838108 0 +2703 0.8222429937602531 1.025575858381215 0 +2704 0.7541539702357625 1.686233058625092 0 +2705 0.4203058672629181 1.514379946323455 0 +2706 0.02534809005594198 1.763874793561482 0 +2707 0.7258186323090416 1.274787962612752 0 +2708 0.4610870895891317 1.973586381790231 0 +2709 0.5006408496116438 1.250595077759769 0 +2710 0.1252708518528679 1.054545958569082 0 +2711 0.8747291481465558 1.054545958569328 0 +2712 0.03938391277717404 1.094740966249867 0 +2713 0.9606160872226537 1.094740966250186 0 +2714 0.5675715044348002 1.338982802992977 0 +2715 0.6642131036752703 1.270936836965853 0 +2716 0.4653577351625374 1.293180948359519 0 +2717 0.5607178726647342 1.038534804026929 0 +2718 0.1413952707015503 1.062774869411188 0 +2719 0.8586047292978228 1.06277486941148 0 +2720 0.2629514090997688 1.099111045321375 0 +2721 0.7370485908989451 1.099111045321879 0 +2722 0.5533474158556826 1.309003220629826 0 +2723 0.4117313843256126 1.168740002490928 0 +2724 0.4460962096700886 1.625092662968165 0 +2725 0.4367187179516349 1.547886036725576 0 +2726 0.4657287356498001 1.052263821581162 0 +2727 0.6582638640048655 1.184514126378541 0 +2728 0.2530147486726955 1.022407860094514 0 +2729 0.7469852513260371 1.022407860094647 0 +2730 0.6286855802512056 1.236472307303276 0 +2731 0.2346870324814782 1.008455640612283 0 +2732 0.7653129675173608 1.008455640612327 0 +2733 0.3623299169758621 1.371269289813307 0 +2734 0.2889156923740188 1.350197530891613 0 +2735 0.2628842651513345 1.233686474352008 0 +2736 0.5827308655895163 1.095931231145731 0 +2737 0.2198562118521974 1.035376208241158 0 +2738 0.7801437881467311 1.035376208241353 0 +2739 0.1649439339150396 1.007097116786803 0 +2740 0.8350560660841868 1.007097116786832 0 +2741 0.4674294458929631 1.368531629431262 0 +2742 0.7510718586353879 1.411701651929033 0 +2743 0.02401251706849928 1.166794279087094 0 +2744 0.9759874829315841 1.166794279087261 0 +2745 0.2466205164482834 1.029667639778234 0 +2746 0.7533794835504892 1.029667639778406 0 +2747 0.8339034125695897 1.874604190131635 0 +2748 0.4670232220185516 1.474249282569385 0 +2749 0.5818996969213007 1.157580528045311 0 +2750 0.4755516073958432 1.045532826559348 0 +2751 0.18185811625555 1.31786302214069 0 +2752 0.3660827041517126 1.290387914974962 0 +2753 0.761347650185163 1.387356050377003 0 +2754 0.1593215058851385 1.10703142280523 0 +2755 0.840678494114118 1.107031422805699 0 +2756 0.3262456057269053 1.023485044590965 0 +2757 0.7503422027858173 1.291267892963433 0 +2758 0.05337380909562552 1.031553237302947 0 +2759 0.9466261909041291 1.031553237303092 0 +2760 0.057469119032688 1.164891440853474 0 +2761 0.9425308809673754 1.164891440853636 0 +2762 0.2172854963499038 1.213468036424039 0 +2763 0.00753977974051773 1.036836690729115 0 +2764 0.992460220259445 1.036836690729158 0 +2765 0.4665512416283742 1.910537931454778 0 +2766 0.3105813620514997 1.333884865997126 0 +2767 0.3083359811803948 1.180650605104522 0 +2768 0.4999545142939948 1.020019218895563 0 +2769 0.375454053643587 1.213565494941158 0 +2770 0.2882740691481924 1.038693200068688 0 +2771 0.7117270581509294 1.03870218211657 0 +2772 0.3734965725812673 1.020574356973204 0 +2773 0.8584488564777401 1.831526508145217 0 +2774 0.6063722870080076 1.861877760775427 0 +2775 0.1048732388192985 1.006396257793335 0 +2776 0.8951267611802314 1.006396257793362 0 +2777 0.7698037716173323 1.446289070704977 0 +2778 0.3150259190505175 1.464130264978701 0 +2779 0.3511073643217986 1.478357842447523 0 +2780 0.2017540524818569 1.017578900664085 0 +2781 0.7982459475171761 1.017578900664174 0 +2782 0.1432206599035693 1.081823017383028 0 +2783 0.8567793400957614 1.081823017383404 0 +2784 0.2467573028157113 1.121479810277247 0 +2785 0.598982477813105 1.623493347318789 0 +2786 0.7532426971830887 1.121479810277866 0 +2787 0.5104761191247543 1.017782964951546 0 +2788 0.08352842493676289 1.272942110041936 0 +2789 0.5079278233240452 1.351475738625013 0 +2790 0.05448194057721629 1.674196219511389 0 +2791 0.2702342992012707 1.358671229552355 0 +2792 0.2584473023736181 1.152693716025776 0 +2793 0.7822432403505836 1.337056146754361 0 +2794 0.741523086286513 1.152741155844497 0 +2795 0.5237021034766426 1.238858713450787 0 +2796 0.5854356284949629 1.236655533432351 0 +2797 0.1964365575924616 1.071869859051953 0 +2798 0.8035634424065857 1.071869859052315 0 +2799 0.5488965021084053 1.288599088065097 0 +2800 0.06948497133683337 1.356538680878103 0 +2801 0.2949810032824935 1.146757639455889 0 +2802 0.5626405882755808 1.144069798178987 0 +2803 0.6883271313792545 1.239393636035811 0 +2804 0.7993223259900448 1.308268471045901 0 +2805 0.5892871855207226 1.020230775547619 0 +2806 0.3801831290786846 1.339837230304242 0 +2807 0.9358442976149552 1.38139197208213 0 +2808 0.2870536564611025 1.028405294063754 0 +2809 0.6590110032183223 1.081164115065105 0 +2810 0.7134521297784242 1.028330391533875 0 +2811 0.7191171460095185 1.561002005161688 0 +2812 0.4157424834940389 1.13143596515865 0 +2813 0.3715396502219074 1.051957329785141 0 +2814 0.5046557810415299 1.122178850554884 0 +2815 0.3162331814826231 1.422801759355729 0 +2816 0.1016589318909385 1.179710114147281 0 +2817 0.8983410681090872 1.17971011414779 0 +2818 0.1596154694115436 1.153170892600329 0 +2819 0.8403845305876794 1.153170892601049 0 +2820 0.6485752951168573 1.312109092438454 0 +2821 0.6717524080245076 1.053674909909382 0 +2822 0.1713853371459996 1.252240846138065 0 +2823 0.4005658952386686 1.409139619352801 0 +2824 0.9294775333219978 1.854771955760222 0 +2825 0.1908950826018478 1.272409381268901 0 +2826 0.6607329680707571 1.061338263785553 0 +2827 0.1334046027866478 1.971905366770341 0 +2828 0.4231755304273396 1.079893895547409 0 +2829 0.1941488857526259 1.36150428900243 0 +2830 0.7796964269440891 1.316692330375459 0 +2831 0.598269665166175 1.273501324314886 0 +2832 0.1026720586457845 1.11481619593721 0 +2833 0.516708826836367 1.25163639701923 0 +2834 0.8973279413537272 1.114816195937673 0 +2835 0.881305893337626 1.249602066224565 0 +2836 0.3331660648725014 1.112853667476421 0 +2837 0.7492168944309157 1.471624278219516 0 +2838 0.3505935001593734 1.172894141054609 0 +2839 0.03900599805737198 1.037871362443797 0 +2840 0.9609940019424514 1.037871362443979 0 +2841 0.1858260091508975 1.41871928032299 0 +2842 0.5687647776811359 1.379257755082687 0 +2843 0.9220580040000598 1.765583076378356 0 +2844 0.9396285639384199 1.498903633006723 0 +2845 0.7769942119766137 1.22737775318183 0 +2846 0.9396922731971658 1.675581473106377 0 +2847 0.9313277656060316 1.968385325334156 0 +2848 0.4195426418798375 1.936359361085945 0 +2849 0.6312927660414346 1.252861168828801 0 +2850 0.3643805930657786 1.193896051494866 0 +2851 0.059393463003176 1.755021404206746 0 +2852 0.2101047399856204 1.147495561611076 0 +2853 0.7898952600133502 1.147495561611751 0 +2854 0.5241869105064323 1.116714258927648 0 +2855 0.4135266998975591 1.016633187570962 0 +2856 0.68641570903661 1.659613183656362 0 +2857 0.9658890197184886 1.342925348269771 0 +2858 0.07115646171733639 1.148546398648356 0 +2859 0.9288435382823026 1.148546398648545 0 +2860 0.2897663234243298 1.168553349863917 0 +2861 0.417534666429404 1.038737586897918 0 +2862 0.2349622537745057 1.148338909913371 0 +2863 0.665876260568999 1.029166616203806 0 +2864 0.7650377462243316 1.148338909914103 0 +2865 0.385957841209587 1.017321545648354 0 +2866 0.8628091854317986 1.323777363883258 0 +2867 0.5951057499927664 1.313800449733704 0 +2868 0.1172413439426848 1.132745435918073 0 +2869 0.8827586560568293 1.132745435918698 0 +2870 0.3820264553449433 1.240819389194221 0 +2871 0.2095753723637706 1.846389486602504 0 +2872 0.7863461830261411 1.210930870721902 0 +2873 0.5715966479904148 1.235382524467846 0 +2874 0.5640454308261659 1.084685283169291 0 +2875 0.1387499972860813 1.127663899273432 0 +2876 0.8612500027133079 1.127663899274012 0 +2877 0.7806620493699954 1.418064635420868 0 +2878 0.629543135234943 1.072551734643087 0 +2879 0.4898458320442233 1.297211485431618 0 +2880 0.08725613884094617 1.383529712448756 0 +2881 0.3384580962492686 1.062041420669449 0 +2882 0.7126536059243005 1.299634188443179 0 +2883 0.7233477148870193 1.860586748210058 0 +2884 0.4751101182558506 1.761839760251274 0 +2885 0.2166022677776669 1.02631066321107 0 +2886 0.7833977322212846 1.026310663211207 0 +2887 0.1074970413413924 1.310477656487091 0 +2888 0.6468514855092317 1.88415519239545 0 +2889 0.6550209969728054 1.044297712223042 0 +2890 0.3096126098389106 1.017393289262932 0 +2891 0.2274158805659109 1.481145629555492 0 +2892 0.5533783639811831 1.101075512822319 0 +2893 0.03606418746939674 1.19884048931426 0 +2894 0.9639358125306372 1.198840489314458 0 +2895 0.05443254946452088 1.805787267380786 0 +2896 0.2498648128212545 1.713725657657329 0 +2897 0.7438871139722667 1.25125253349348 0 +2898 0.07521216225540725 1.309841488193657 0 +2899 0.8064582494878244 1.27344700810216 0 +2900 0.2804391005947892 1.087997788968355 0 +2901 0.7195608994037967 1.087997788968832 0 +2902 0.4849116177332676 1.630282341215658 0 +2903 0.3469888981154782 1.007442197267729 0 +2904 0.5259416593806885 1.02096153025492 0 +2905 0.388925130057464 1.043003179875413 0 +2906 0.03488622832058046 1.296534486954882 0 +2907 0.4986002351729686 1.232704500037788 0 +2908 0.4109275730836957 1.296051242434567 0 +2909 0.8670153686548974 1.361326715179295 0 +2910 0.5693816089716413 1.112654299399059 0 +2911 0.5560366374406496 1.494031332844624 0 +2912 0.7122331619793438 1.826896612592065 0 +2913 0.4074619807988046 1.361064730636741 0 +2914 0.5858001539050828 1.261261927787994 0 +2915 0.1486309772180805 1.217977558481729 0 +2916 0.3803059278206488 1.36928802292461 0 +2917 0.5940556946732789 1.202868739008952 0 +2918 0.7788522726677783 1.478549569425795 0 +2919 0.209847347480915 1.236418908838099 0 +2920 0.06618227292412564 1.119043338400828 0 +2921 0.9338177270755058 1.119043338401132 0 +2922 0.383779909482824 1.118516391900252 0 +2923 0.5906078230829918 1.077531643665177 0 +2924 0.3716903728307409 1.091473085898907 0 +2925 0.3138181900313047 1.166162775024738 0 +2926 0.4503177597531201 1.578903177925705 0 +2927 0.5085934567209156 1.727568685387252 0 +2928 0.4821527048223911 1.064040821624142 0 +2929 0.04920734305025304 1.145969435633829 0 +2930 0.9507926569496949 1.145969435634112 0 +2931 0.5012906419242744 1.030662086614818 0 +2932 0.4549941012133137 1.006546547005247 0 +2933 0.3506546844418877 1.772543853306129 0 +2934 0.6661777840374016 1.22553799261101 0 +2935 0.3982190405345465 1.524002023824426 0 +2936 0.1770758229450258 1.066838406138642 0 +2937 0.8229241770541227 1.066838406138972 0 +2938 0.2647528471061499 1.05679086312177 0 +2939 0.7352471528925172 1.056790863122069 0 +2940 0.3608865379164736 1.494838367608591 0 +2941 0.5298535542892503 1.434262773301899 0 +2942 0.2292489860649035 1.073780207557802 0 +2943 0.7707510139339485 1.073780207558179 0 +2944 0.4926666647029472 1.042995680778128 0 +2945 0.6305094123637933 1.314302286959342 0 +2946 0.6122929134138689 1.236795882378532 0 +2947 0.8568907864384894 1.581635953614845 0 +2948 0.410290126613798 1.066724166509226 0 +2949 0.05499994271878899 1.594983681837827 0 +2950 0.3281937312021035 1.053462741328787 0 +2951 0.7690209952057978 1.202910363052015 0 +2952 0.6498722532733835 1.172450426166187 0 +2953 0.5361555651470896 1.008187105178369 0 +2954 0.02295216849368465 1.711554885079298 0 +2955 0.8095376807231148 1.750902471522841 0 +2956 0.9705954622239099 1.970402740307113 0 +2957 0.04889102228269866 1.493021452578355 0 +2958 0.8048512964483469 1.831204286715235 0 +2959 0.5552149808812128 1.006924991414495 0 +2960 0.08332480401566156 1.076015587247223 0 +2961 0.9166751959839765 1.076015587247557 0 +2962 0.6445181409311241 1.231796750078932 0 +2963 0.1562423358189068 1.8432869454409 0 +2964 0.139783290293122 1.413377267398353 0 +2965 0.5059168037108632 1.210966574162367 0 +2966 0.9627188401443481 1.300879784144581 0 +2967 0.6256103969305474 1.212577837401355 0 +2968 0.6396092692040855 1.280062400062568 0 +2969 0.5108549774949193 1.380762807316125 0 +2970 0.4754842164347899 1.603860222672949 0 +2971 0.5865312105343015 1.213780047669135 0 +2972 0.5197036992944831 1.550057860136427 0 +2973 0.7565197816282374 1.273245964088608 0 +2974 0.669441119550221 1.038203411750297 0 +2975 0.3540322828027791 1.684665699136207 0 +2976 0.6517581883220046 1.008492155829824 0 +2977 0.5691847589677379 1.131926591328444 0 +2978 0.8520749092523603 1.216565017547173 0 +2979 0.245041177210246 1.102009041037153 0 +2980 0.7549588227885721 1.10200904103767 0 +2981 0.1687457570057113 1.038890074445489 0 +2982 0.8312542429934928 1.038890074445692 0 +2983 0.2150117449697836 1.343560298824328 0 +2984 0.5727369439349044 1.212434662436378 0 +2985 0.1486844917117769 1.072846993073355 0 +2986 0.8513155082875328 1.072846993073695 0 +2987 0.05066018734083652 1.111583933031004 0 +2988 0.9493398126589245 1.111583933031389 0 +2989 0.4738127501998672 1.007777170474894 0 +2990 0.4638867003580509 1.23482263867288 0 +2991 0.08509556623336824 1.094025068364532 0 +2992 0.914904433766248 1.094025068364932 0 +2993 0.4083790916147616 1.241960094296454 0 +2994 0.023126928441822 1.10434887292641 0 +2995 0.9768730715581555 1.104348872926719 0 +2996 0.7585948900196794 1.316973963537439 0 +2997 0.5277256008226907 1.817768339721885 0 +2998 0.05277075708106999 1.638569102353637 0 +2999 0.4722958244960483 1.815883283342398 0 +3000 0.5919748108151146 1.248655678130806 0 +3001 0.563904581036356 1.24646745469932 0 +3002 0.5721997142445416 1.066591218563173 0 +3003 0.2411852616459803 1.317872777849692 0 +3004 0.4656511314133543 1.071543853460532 0 +3005 0.8536572713768893 1.485734191864946 0 +3006 0.04386648853438674 1.128024996133643 0 +3007 0.9561335114654953 1.128024996134196 0 +3008 0.6656225556681139 1.072308396739774 0 +3009 0.5346942907787386 1.037653085450848 0 +3010 0.8996766960574626 1.273519081010038 0 +3011 0.3760461421166644 1.14203785168324 0 +3012 0.5923730281933391 1.225773671479444 0 +3013 0.6950838193504395 1.289250989136105 0 +3014 0.9277301935827389 1.410727321862892 0 +3015 0.01425619637161279 1.337993856531098 0 +3016 0.1268847150106371 1.036729374781617 0 +3017 0.8731152849887862 1.03672937478179 0 +3018 0.007184981342944966 1.070446308651112 0 +3019 0.9928150186570717 1.070446308651146 0 +3020 0.08301135678927161 1.619174077059818 0 +3021 0.1350641264306794 1.655505290657749 0 +3022 0.343649248194673 1.031519522871835 0 +3023 0.6561529096541532 1.664717783008989 0 +3024 0.2153408786467667 1.789060710940457 0 +3025 0.5283355554849416 1.626030870171568 0 +3026 0.8086506427207933 1.459174070375985 0 +3027 0.4325026230958671 1.197699402322915 0 +3028 0.3196200499000456 1.064656542761854 0 +3029 0.4766397570759809 1.13736176667146 0 +3030 0.8962631750176243 1.367573939183772 0 +3031 0.5646001166653036 1.09699861929293 0 +3032 0.8283473967654937 1.968756677361399 0 +3033 0.2488027758056946 1.052120662120708 0 +3034 0.7511972241930638 1.052120662120992 0 +3035 0.03449560440918616 1.409590061744054 0 +3036 0.03234385620274027 1.053648608877618 0 +3037 0.9676561437971113 1.053648608877871 0 +3038 0.8243671588058238 1.211170154749401 0 +3039 0.6063319893559447 1.041302717781211 0 +3040 0.7326631503079906 1.971443705262739 0 +3041 0.2448743378295132 1.560307426103444 0 +3042 0.01031025244203183 1.259205503589445 0 +3043 0.2732763841695959 1.824579650613156 0 +3044 0.3949999999989889 1.006186390128424 0 +3045 0.06992465491520286 1.038178687399459 0 +3046 0.9300753450844766 1.038178687399638 0 +3047 0.5691927449047119 1.176963720889049 0 +3048 0.9137031986228519 1.298220106732654 0 +3049 0.5188574978259263 1.365754714061371 0 +3050 0.1808549052854008 1.078985605576947 0 +3051 0.8191450947137375 1.078985605577343 0 +3052 0.4817543709022503 1.886620100613878 0 +3053 0.1430618692927851 1.292639888679988 0 +3054 0.4896555122344977 1.110549679469188 0 +3055 0.4167122512742489 1.092077549886636 0 +3056 0.2477681380125178 1.185940834102218 0 +3057 0.7516176761805692 1.188855558619292 0 +3058 0.525159797985966 1.262896680099059 0 +3059 0.5108484182387665 1.088651374499793 0 +3060 0.09519057953687871 1.105174788481823 0 +3061 0.9048094204626493 1.105174788482245 0 +3062 0.6084193557325153 1.092149451475219 0 +3063 0.1744439120200208 1.189798286279298 0 +3064 0.8256765393983146 1.189815303228186 0 +3065 0.5333200847319234 1.133223623703243 0 +3066 0.1625126094875615 1.126211184181588 0 +3067 0.8374873905116891 1.12621118418218 0 +3068 0.9778092512520943 1.663863982149331 0 +3069 0.9890259381809722 1.259283245499479 0 +3070 0.2483610069204623 1.409895736065413 0 +3071 0.7757032537319577 1.354718911044039 0 +3072 0.5051685427161808 1.160262277088137 0 +3073 0.6015914929550168 1.471833964526196 0 +3074 0.6792252844697816 1.064084293976676 0 +3075 0.9884326960502201 1.313922519630678 0 +3076 0.0139118243533851 1.288121636845902 0 +3077 0.1342071476805902 1.39511707821149 0 +3078 0.3560261102775857 1.019788252760427 0 +3079 0.7806453492297647 1.255856604395591 0 +3080 0.5769885878843717 1.287508155013099 0 +3081 0.1173874186482801 1.084274523900702 0 +3082 0.882612581351178 1.084274523901069 0 +3083 0.00806496745244023 1.134658772172711 0 +3084 0.9919350325475937 1.134658772172714 0 +3085 0.527251628600046 1.064497557856977 0 +3086 0.4389524981478167 1.724078550811674 0 +3087 0.2673056920737841 1.01916137998082 0 +3088 0.7326950108266191 1.019163011303326 0 +3089 0.1196404715671867 1.196978877903997 0 +3090 0.8803732485876892 1.196833089850386 0 +3091 0.3402262158203494 1.613381801607067 0 +3092 0.6327965722852348 1.057805386184732 0 +3093 0.1082870743162082 1.232545634267622 0 +3094 0.8903241465952066 1.232584625306276 0 +3095 0.5160854486318447 1.199201570735223 0 +3096 0.4935952205291088 1.381116981666005 0 +3097 0.4580611159534282 1.354146572321462 0 +3098 0.3203927006214325 1.205041968754728 0 +3099 0.3369285798395966 1.51983270192779 0 +3100 0.5738957072541291 1.080892664656557 0 +3101 0.02564675784061751 1.940935266982317 0 +3102 0.5563469206617435 1.180255253164846 0 +3103 0.5342318724930822 1.177959414086585 0 +3104 0.977851952651616 1.942433433047928 0 +3105 0.9548156334290567 1.555163419917335 0 +3106 0.4935088971581665 1.573002079157671 0 +3107 0.4819207276268959 1.733425113031843 0 +3108 0.3407816120832692 1.103247199885626 0 +3109 0.6916026094480439 1.016549442489436 0 +3110 0.6786146719856003 1.201983593413454 0 +3111 0.3397275553349474 1.405309652147826 0 +3112 0.1168482866720272 1.283593747167385 0 +3113 0.5522251618207119 1.668398118713792 0 +3114 0.01866911726931404 1.541357935534568 0 +3115 0.6571871406462103 1.38011885104343 0 +3116 0.04503158955520244 1.170572547495972 0 +3117 0.9549684104449003 1.170572547496162 0 +3118 0.2557078616171862 1.039402252270771 0 +3119 0.7442921383815413 1.039402252270988 0 +3120 0.5102501236251781 1.072924854548012 0 +3121 0.1830505217902794 1.035977421339592 0 +3122 0.8169494782088537 1.035977421339776 0 +3123 0.7864855977004328 1.584813853419071 0 +3124 0.3836099480954295 1.17658714223066 0 +3125 0.9247170673415271 1.934275735722023 0 +3126 0.8216804848988943 1.579023426114137 0 +3127 0.5375476215549428 1.395942193947957 0 +3128 0.983894979504826 1.616556882338917 0 +3129 0.01361459294112605 1.312162164333579 0 +3130 0.5901184300976519 1.05033213873507 0 +3131 0.3319390836597085 1.291497935268903 0 +3132 0.2692598039677995 1.128877634537583 0 +3133 0.7307401960308807 1.128877634538257 0 +3134 0.4387981964658876 1.450306876884706 0 +3135 0.7807862651967983 1.687060803211409 0 +3136 0.811921678756286 1.246976682626123 0 +3137 0.3082237111666897 1.199540952657979 0 +3138 0.129221549014606 1.707246115945004 0 +3139 0.05753608738565197 1.062546543703425 0 +3140 0.9424639126140871 1.062546543703724 0 +3141 0.6056269987996351 1.224889647719344 0 +3142 0.6171287739428702 1.499791194399139 0 +3143 0.3908909555231866 1.489171294372845 0 +3144 0.6899962074720175 1.151597858236175 0 +3145 0.6519255697344501 1.03693816942329 0 +3146 0.5074293651199127 1.304053821727486 0 +3147 0.5215234172640134 1.047804460135949 0 +3148 0.3328287390886212 1.007314251533086 0 +3149 0.04732195063439883 1.060414287106749 0 +3150 0.9526780493653854 1.06041428710704 0 +3151 0.8867525443896362 1.556301636063413 0 +3152 0.06093920632468015 1.259535880913286 0 +3153 0.9400277719465432 1.258466329961994 0 +3154 0.2727400831869887 1.035021932662409 0 +3155 0.7272610743680831 1.035024619165739 0 +3156 0.8000458441502241 1.552048167523651 0 +3157 0.2626018840923422 1.301730190049869 0 +3158 0.5938962921612817 1.287343204782929 0 +3159 0.6144647121034461 1.054176326377833 0 +3160 0.7109935583627558 1.236642448408669 0 +3161 0.6503770169861024 1.776238969636014 0 +3162 0.3689970102233768 1.419232408619065 0 +3163 0.1991368022996508 1.128158094087197 0 +3164 0.8008631976994559 1.128158094087744 0 +3165 0.4461234879444902 1.251654153102093 0 +3166 0.3488661277688836 1.065419082809585 0 +3167 0.1084650573628514 1.929370864879122 0 +3168 0.5968960135416668 1.182282884876324 0 +3169 0.05138321987055499 1.078420724844972 0 +3170 0.9486167801292066 1.07842072484534 0 +3171 0.0768551969104051 1.044900551095555 0 +3172 0.9231448030892382 1.044900551095754 0 +3173 0.2570569366579989 1.066492380718779 0 +3174 0.7429430633407019 1.066492380719129 0 +3175 0.4462224994270425 1.180969742895069 0 +3176 0.09529286085030653 1.00589644543045 0 +3177 0.9047071391492654 1.005896445430478 0 +3178 0.7456350106586379 1.713519378105063 0 +3179 0.6324965072722788 1.616098206620357 0 +3180 0.0629597511616016 1.4078490409302 0 +3181 0.4833184993769563 1.367211055954118 0 +3182 0.1255715808812676 1.271148283596247 0 +3183 0.6057443555806847 1.24950644111779 0 +3184 0.8357602795041208 1.406631966224829 0 +3185 0.5550842866693007 1.636435289785549 0 +3186 0.09414434791989254 1.790702000193611 0 +3187 0.5157281617783732 1.923307188108359 0 +3188 0.6720638557582501 1.130779821161272 0 +3189 0.328192256142683 1.130808552033188 0 +3190 0.3517434032218137 1.424249783418309 0 +3191 0.3527477330069914 1.120507780423974 0 +3192 0.4872485957573031 1.007282680270751 0 +3193 0.03409965238293022 1.328100681348105 0 +3194 0.0954292114452118 1.504738095527319 0 +3195 0.9603647236363801 1.315972961010941 0 +3196 0.1504729406623461 1.258654812487545 0 +3197 0.1812196332426186 1.149884495876465 0 +3198 0.8187803667565179 1.149884495877156 0 +3199 0.387402898774831 1.655896828773865 0 +3200 0.0833702224214898 1.118761363533847 0 +3201 0.9166297775780697 1.118761363534233 0 +3202 0.4570467116506835 1.13890331288479 0 +3203 0.1798211720443132 1.227337100491445 0 +3204 0.2330543235285779 1.368262934601518 0 +3205 0.6684354299502232 1.244558505905119 0 +3206 0.9630821497747226 1.370609234330091 0 +3207 0.2231974482046011 1.703892597686964 0 +3208 0.3638086633157411 1.79243002479231 0 +3209 0.5144021826391417 1.125798696890056 0 +3210 0.5744828690993622 1.190910489983869 0 +3211 0.3375001410928807 1.587886584278393 0 +3212 0.1987350984166321 1.04293738526427 0 +3213 0.8012649015824096 1.042937385264484 0 +3214 0.2280888770562281 1.084588852068885 0 +3215 0.7719111229426404 1.0845888520693 0 +3216 0.4054739274688711 1.324755863999675 0 +3217 0.06792047649371237 1.554097630831343 0 +3218 0.007535419928601936 1.018047378716409 0 +3219 0.9924645800714075 1.018047378716426 0 +3220 0.3673819377160927 1.398266056710684 0 +3221 0.7818576873512124 1.936563062155973 0 +3222 0.5528943640275946 1.92910980076308 0 +3223 0.5849999999989093 1.005856846430483 0 +3224 0.3943527091754409 1.880650961906487 0 +3225 0.4015953078583649 1.255912512555445 0 +3226 0.1373548290263226 1.007265818576075 0 +3227 0.8626451709730468 1.007265818576111 0 +3228 0.09116023977412796 1.197402322467753 0 +3229 0.9088397602262499 1.197402322468015 0 +3230 0.8808737026395025 1.679065208580525 0 +3231 0.9818451098120242 1.570174690384008 0 +3232 0.6452701898085627 1.512733594267466 0 +3233 0.2109842094649221 1.128432967414724 0 +3234 0.7890157905340743 1.128432967415335 0 +3235 0.599792891143665 1.063632734623389 0 +3236 0.6484123132631934 1.971605866385381 0 +3237 0.2447919070273138 1.926088229783505 0 +3238 0.450307194806208 1.093155611215732 0 +3239 0.6100404642133814 1.681903352546578 0 +3240 0.2514389730132617 1.014925222293766 0 +3241 0.7485610269854809 1.014925222293852 0 +3242 0.100116319480411 1.278917540673539 0 +3243 0.01772922761894232 1.007325404425178 0 +3244 0.982270772380972 1.007325404425215 0 +3245 0.5228728054664999 1.490253936602415 0 +3246 0.9631620618938812 1.259157658753812 0 +3247 0.2884806280357811 1.316593915072292 0 +3248 0.108555964838203 1.763308780820249 0 +3249 0.9110456767109114 1.39566361124855 0 +3250 0.8609988706993663 1.39449186391711 0 +3251 0.6834128035072389 1.02967843855267 0 +3252 0.3942242479494591 1.100336880972016 0 +3253 0.8672750832498555 1.737373605948202 0 +3254 0.3747562945077673 1.525148240497036 0 +3255 0.5800814497723821 1.820990227185569 0 +3256 0.512191942055147 1.441723341921217 0 +3257 0.4685658406491702 1.223155864668977 0 +3258 0.3035246264202507 1.071847717736612 0 +3259 0.6964746773281726 1.071857809090415 0 +3260 0.4082320930339532 1.075297362325028 0 +3261 0.02688986498945056 1.973803112790762 0 +3262 0.6851172043158067 1.164691335073097 0 +3263 0.5173652678789619 1.037638953672481 0 +3264 0.3911657977937508 1.57747666268882 0 +3265 0.437226486899446 1.398532019878076 0 +3266 0.6655516511764876 1.091787882046644 0 +3267 0.6167967266508756 1.062772820990088 0 +3268 0.5115510027143241 1.40779010973734 0 +3269 0.4846200438021683 1.034624527229878 0 +3270 0.5225735131104832 1.007217457510104 0 +3271 0.7365809388968274 1.78872584446839 0 +3272 0.7264550942049537 1.206031009138789 0 +3273 0.3504445707876621 1.862663860251722 0 +3274 0.3176281866336297 1.078751181522546 0 +3275 0.9020423040412049 1.810672121032276 0 +3276 0.5367419398648408 1.975933810218964 0 +3277 0.6817970649120719 1.079050214642001 0 +3278 0.2818390363859189 1.634346310360678 0 +3279 0.1993363667631902 1.089043558599542 0 +3280 0.8006636332358396 1.089043558599996 0 +3281 0.08216408759383684 1.543447877111605 0 +3282 0.4876193332552141 1.39398541827866 0 +3283 0.3021254111464436 1.591664995638674 0 +3284 0.4332148415046728 1.115380684815047 0 +3285 0.8011616831837557 1.227864360594381 0 +3286 0.05150173648886018 1.365751872087153 0 +3287 0.05496532722173433 1.087790175814136 0 +3288 0.9450346727780148 1.087790175814522 0 +3289 0.8046681234373696 1.398158704725539 0 +3290 0.3716515453920619 1.132008949871995 0 +3291 0.4436253645251734 1.308932810813298 0 +3292 0.1567249985220825 1.303126721918028 0 +3293 0.2119612090454667 1.078862919788726 0 +3294 0.788038790953479 1.078862919789108 0 +3295 0.5287483998655658 1.201133640701046 0 +3296 0.1953934959633296 1.800585142953776 0 +3297 0.3329286130332294 1.069965486168997 0 +3298 0.1890305360675689 1.208790671736525 0 +3299 0.9863232835077604 1.417637323875256 0 +3300 0.8111045693236416 1.209109535736351 0 +3301 0.2952620017437567 1.73795060515094 0 +3302 0.5844577581782607 1.125248008426799 0 +3303 0.06699969367602422 1.973950957333384 0 +3304 0.6996120227799911 1.592213307705401 0 +3305 0.2710897475875159 1.212576065116549 0 +3306 0.3405034597220026 1.345869520149519 0 +3307 0.1108030029593558 1.451988335699398 0 +3308 0.500799891083604 1.049420773155815 0 +3309 0.2906510912121534 1.108637813366452 0 +3310 0.7093474260716455 1.108631973383058 0 +3311 0.2010123075764172 1.147487766175482 0 +3312 0.798987692422616 1.14748776617616 0 +3313 0.826688336333459 1.92888481794781 0 +3314 0.9795673785300706 1.87009030098262 0 +3315 0.7905473666463739 1.27220986997835 0 +3316 0.2357693226741448 1.244876444268079 0 +3317 0.2611451541911151 1.025096393635785 0 +3318 0.7388549055781257 1.025096532353825 0 +3319 0.1598032433397236 1.01564159402556 0 +3320 0.8401967566595286 1.015641594025636 0 +3321 0.5482267760596211 1.07091720347627 0 +3322 0.4603265623720626 1.10566782343086 0 +3323 0.8128238314900005 1.233334246915742 0 +3324 0.06918292525897446 1.024830488032454 0 +3325 0.9308170747407107 1.02483048803257 0 +3326 0.4891905190310432 1.501089275758627 0 +3327 0.2088923788488783 1.109401317328674 0 +3328 0.7911076211501032 1.109401317329208 0 +3329 0.4476907357909223 1.236656321651996 0 +3330 0.2384340455037524 1.015645184473918 0 +3331 0.7615659544950655 1.015645184474004 0 +3332 0.1717029994476514 1.76308633455751 0 +3333 0.09878093785477732 1.671811964238785 0 +3334 0.05852527067152707 1.893830306377398 0 +3335 0.2154333678200377 1.118672299555085 0 +3336 0.7845666321789101 1.118672299555677 0 +3337 0.7826168377499634 1.563388436481977 0 +3338 0.2399148794890117 1.139849865553041 0 +3339 0.760085120509796 1.139849865553748 0 +3340 0.3197387254935056 1.015577470125447 0 +3341 0.02290988530190512 1.127767827692133 0 +3342 0.9770901146980855 1.127767827692361 0 +3343 0.9144884833438447 1.580630296320076 0 +3344 0.7582471540832618 1.893180163732064 0 +3345 0.3958976534938686 1.336111057882065 0 +3346 0.2504290210198446 1.19685920954506 0 +3347 0.5972281283801204 1.393815674192034 0 +3348 0.3243972542043328 1.098375867099081 0 +3349 0.4364884558366192 1.176171039439213 0 +3350 0.5491557813727068 1.125180806256856 0 +3351 0.4485899667673183 1.292994584986844 0 +3352 0.4966485986285446 1.191401331987999 0 +3353 0.6769786063985447 1.602502563725125 0 +3354 0.01590092057013676 1.589100026142832 0 +3355 0.6663630627943343 1.40889341389736 0 +3356 0.4465789624835255 1.158041621658539 0 +3357 0.01096305085370147 1.204978893887839 0 +3358 0.9890332695653414 1.204983006097456 0 +3359 0.2181960273169638 1.087167666927751 0 +3360 0.7818039726819552 1.087167666928174 0 +3361 0.3819039224720535 1.678858935696413 0 +3362 0.4240970366724922 1.215193883679644 0 +3363 0.6175372411393172 1.120867798488144 0 +3364 0.4232289133408755 1.067042764364448 0 +3365 0.3552072740681218 1.229404329850605 0 +3366 0.8964261094839023 1.258096658286262 0 +3367 0.2410668958067194 1.35511889244404 0 +3368 0.7410073833120006 1.517210704860221 0 +3369 0.1015642853061831 1.077215086769173 0 +3370 0.8984357146933604 1.077215086769501 0 +3371 0.87423075168225 1.435663082966889 0 +3372 0.2180049918670429 1.227991809881748 0 +3373 0.3454827963716899 1.021250461549208 0 +3374 0.3405572513913834 1.373580185585569 0 +3375 0.9497330244707272 1.627431129941743 0 +3376 0.4843557358232279 1.075498616911013 0 +3377 0.1104334301987898 1.038999631064801 0 +3378 0.8895665698007126 1.038999631064975 0 +3379 0.5371184194812646 1.190643155657833 0 +3380 0.8674604237820186 1.40726502586251 0 +3381 0.9333976026334944 1.282300546644999 0 +3382 0.6635002694408094 1.288088041356226 0 +3383 0.3698955874986868 1.751650569587373 0 +3384 0.2478470676590287 1.266601140011721 0 +3385 0.2885465939407976 1.058533238226147 0 +3386 0.7114521347767127 1.058534591979638 0 +3387 0.6408881521849427 1.425101619183517 0 +3388 0.6205418457006967 1.784662738757029 0 +3389 0.9597931365074216 1.404995181653994 0 +3390 0.3479137315077679 1.048741248520458 0 +3391 0.6281021459750666 1.177526093208538 0 +3392 0.5087762837353165 1.479649815375283 0 +3393 0.6129725745998538 1.192891460410892 0 +3394 0.4843032540716811 1.117013150750152 0 +3395 0.5894942450144165 1.717213425674467 0 +3396 0.2811007451854533 1.328687873866109 0 +3397 0.0481970082316495 1.527638884897945 0 +3398 0.3041919914100624 1.317860170772724 0 +3399 0.465052269653499 1.151583245073708 0 +3400 0.659062180797968 1.436698428999367 0 +3401 0.4047826830865794 1.542762183560312 0 +3402 0.5811751294515943 1.578003582966232 0 +3403 0.2576136794541315 1.495479737346622 0 +3404 0.3261839495667986 1.147107492901612 0 +3405 0.2376404095466362 1.743486228457745 0 +3406 0.3144749045067853 1.146986360641986 0 +3407 0.6721234722177283 1.148186400155432 0 +3408 0.7112372582173553 1.461516486200024 0 +3409 0.5547495100789241 1.740228009198139 0 +3410 0.7014254649630004 1.242934715824348 0 +3411 0.6034081285762425 1.325486171652366 0 +3412 0.6023628438069728 1.00711733848612 0 +3413 0.0174668220678606 1.059153328591893 0 +3414 0.98253317793206 1.059153328592128 0 +3415 0.1001622034396336 1.638145707490015 0 +3416 0.5934395717344421 1.534295943842678 0 +3417 0.3514196151484461 1.035787680836533 0 +3418 0.3353368883367572 1.017092770800198 0 +3419 0.7558068228073598 1.240838779012502 0 +3420 0.3762179157166683 1.006366397263434 0 +3421 0.09814012677165353 1.354464798106319 0 +3422 0.1166734194565906 1.873407271153148 0 +3423 0.2775222016458004 1.67775024304368 0 +3424 0.5090701820652053 1.064101013467267 0 +3425 0.4380390029231114 1.068670241233897 0 +3426 0.2692417742604845 1.18480014255584 0 +3427 0.938878693099089 1.466362381175177 0 +3428 0.3289160207592189 1.480440233983258 0 +3429 0.5233518900161606 1.104746243006703 0 +3430 0.6786716270195868 1.730439760606658 0 +3431 0.4997809480034809 1.060097429096916 0 +3432 0.3429920094868641 1.148653447083821 0 +3433 0.2988580108151219 1.936614550033135 0 +3434 0.5719975625939232 1.459912075440698 0 +3435 0.4051865417124261 1.129081687748491 0 +3436 0.3800172913440857 1.439297311671019 0 +3437 0.5901655016968097 1.642448469414646 0 +3438 0.6150361718738336 1.015579681456306 0 +3439 0.7902205990961959 1.707646183607716 0 +3440 0.2227549278958273 1.42021165067592 0 +3441 0.4847904019058026 1.223755863520104 0 +3442 0.7738480593455063 1.292288261325042 0 +3443 0.2928362794077691 1.069860564226422 0 +3444 0.7071636010856959 1.069861259386334 0 +3445 0.3916900167160449 1.070950199263994 0 +3446 0.03749464110598471 1.068231659119322 0 +3447 0.9625053588938317 1.068231659119643 0 +3448 0.7480293253519303 1.378655208441889 0 +3449 0.4196103399279165 1.550893293224064 0 +3450 0.653602791360656 1.195514677654681 0 +3451 0.6473361992378349 1.408969452274825 0 +3452 0.6268843430737454 1.064253542939533 0 +3453 0.3571204019552967 1.577198709485106 0 +3454 0.1844864296369261 1.090689842400813 0 +3455 0.8155135703622025 1.09068984240127 0 +3456 0.8321671514816793 1.290544088597883 0 +3457 0.7863394973346897 1.749100410726242 0 +3458 0.6571961095490539 1.14874754959908 0 +3459 0.6680400151237824 1.569072758798816 0 +3460 0.4588826252608314 1.039093390957258 0 +3461 0.09515771641627446 1.251167921301461 0 +3462 0.08306683781945828 1.23197070986715 0 +3463 0.9174424294663507 1.231911766594472 0 +3464 0.6973989846567398 1.770303600056921 0 +3465 0.8981056792986919 1.978069544004005 0 +3466 0.01963503176068615 1.045296734671473 0 +3467 0.9803649682392119 1.045296734671636 0 +3468 0.6343198850360702 1.093982585968916 0 +3469 0.846123505726555 1.899741734412523 0 +3470 0.5875650233043492 1.34227845560329 0 +3471 0.1722428243022023 1.293884692361587 0 +3472 0.6558854873807516 1.018190495697559 0 +3473 0.1401014349488895 1.801094660770332 0 +3474 0.3149848617711298 1.808422376880731 0 +3475 0.2709654909876248 1.602613614919684 0 +3476 0.4698008433826563 1.027686334865186 0 +3477 0.4555699947156926 1.022462450882871 0 +3478 0.6501996604148074 1.247416108036392 0 +3479 0.4587301615698488 1.161785863613254 0 +3480 0.8843798766461722 1.606556369100036 0 +3481 0.9206519163356471 1.693860615479304 0 +3482 0.1395514983175823 1.890076788006392 0 +3483 0.1007648067561446 1.087211677028428 0 +3484 0.8992351932434027 1.087211677028789 0 +3485 0.5766536371225803 1.542787593440706 0 +3486 0.9425902390686477 1.790813820424234 0 +3487 0.484412341942826 1.254974000759067 0 +3488 0.5537950841653287 1.021998433999045 0 +3489 0.6753004817709786 1.097568191795797 0 +3490 0.08003973351973072 1.150321960814463 0 +3491 0.9199602664800985 1.150321960814688 0 +3492 0.437772577021237 1.007316262550134 0 +3493 0.1102449168148291 1.031450302135144 0 +3494 0.8897550831846768 1.031450302135283 0 +3495 0.6982254137443059 1.036468820878717 0 +3496 0.9049789089191164 1.893557602454206 0 +3497 0.983779307830536 1.53344595164815 0 +3498 0.3411356427147726 1.245941926817336 0 +3499 0.4380519751604537 1.138637371239702 0 +3500 0.4293840250942337 1.158378521754898 0 +3501 0.2095107000952364 1.201043462151233 0 +3502 0.7919509552403152 1.201240915608389 0 +3503 0.6352028625784758 1.340841067836265 0 +3504 0.2146664341625092 1.92655386427022 0 +3505 0.2069260770694621 1.429597418627997 0 +3506 0.7611595662710799 1.216502897994214 0 +3507 0.4776534665566543 1.202389080691948 0 +3508 0.2902820172938113 1.122729420392723 0 +3509 0.7085040987738541 1.121827602812405 0 +3510 0.3530871567915889 1.088317763317803 0 +3511 0.3349201889869245 1.031312343878436 0 +3512 0.6751625537240049 1.005798773826823 0 +3513 0.7914802485291386 1.235296651115997 0 +3514 0.3168910356000915 1.03025475684214 0 +3515 0.6441582404671261 1.564583774303305 0 +3516 0.8331273470687306 1.847890874385971 0 +3517 0.399519045865631 1.041120517708164 0 +3518 0.03473408805806461 1.162488465326634 0 +3519 0.9652659119420296 1.162488465326853 0 +3520 0.2753178141746124 1.699300463141148 0 +3521 0.7996705151115917 1.42162684192093 0 +3522 0.3948583317449131 1.832898006773385 0 +3523 0.4051899320517516 1.205023038313091 0 +3524 0.1730289932302166 1.055646907007213 0 +3525 0.8269710067689444 1.055646907007487 0 +3526 0.4167386967774511 1.142383814385919 0 +3527 0.2534335141841533 1.211534759049977 0 +3528 0.2892681033400714 1.273049070876271 0 +3529 0.6559020630407286 1.122323379276284 0 +3530 0.6461416050724172 1.94208714482203 0 +3531 0.5653779597327737 1.121405787662119 0 +3532 0.3411153733126749 1.134187790291718 0 +3533 0.8811593514390166 1.320498651465222 0 +3534 0.1627579894207498 1.043410481515311 0 +3535 0.8372420105784895 1.04341048151553 0 +3536 0.3296517228892288 1.26599735329134 0 +3537 0.2377892474125629 1.442383921569851 0 +3538 0.388485899419214 1.217082993152809 0 +3539 0.8140333817965677 1.333993414816485 0 +3540 0.1062417413395645 1.381117748752468 0 +3541 0.2058515616040358 1.040851576815887 0 +3542 0.7941484383949681 1.040851576816092 0 +3543 0.6588642651974014 1.133585379420104 0 +3544 0.2815704390999333 1.444724017359413 0 +3545 0.7317971967093438 1.183826750392547 0 +3546 0.977682835759688 1.790952244804448 0 +3547 0.3646057498401418 1.059750338621733 0 +3548 0.1140906556321777 1.10923611967774 0 +3549 0.8859093443673214 1.109236119678237 0 +3550 0.5737089219458529 1.026701930556001 0 +3551 0.01593804205633383 1.516922257314523 0 +3552 0.3542540793114067 1.057840347089792 0 +3553 0.2854878263631779 1.229561060961588 0 +3554 0.6282629366364416 1.379396311457203 0 +3555 0.9090289363014198 1.25098675650324 0 +3556 0.1741083042007428 1.01860460643868 0 +3557 0.825891695798434 1.018604606438775 0 +3558 0.03370804538886642 1.023953741796655 0 +3559 0.9662919546109878 1.023953741796745 0 +3560 0.6836072807357017 1.508910911481828 0 +3561 0.2817889717361773 1.129942981485395 0 +3562 0.7176589047751682 1.130652108074175 0 +3563 0.4677834778301914 1.112979992944748 0 +3564 0.05558686898080113 1.928352825544404 0 +3565 0.04126891334462752 1.018097398399427 0 +3566 0.9587310866551901 1.018097398399501 0 +3567 0.09700619895850418 1.123835039323161 0 +3568 0.9029938010410837 1.123835039323633 0 +3569 0.5412554796599491 1.483028221533746 0 +3570 0.06977836143942963 1.784494093273558 0 +3571 0.2482739808787649 1.061052950192396 0 +3572 0.7517260191199873 1.061052950192721 0 +3573 0.3016470822365043 1.036493794165518 0 +3574 0.4367080026693275 1.027480258100142 0 +3575 0.2427753571367029 1.383832058237941 0 +3576 0.4697954446095487 1.18416002885769 0 +3577 0.418550494264734 1.72072788459907 0 +3578 0.3767074276250206 1.297085635051434 0 +3579 0.5523045785179248 1.328583603308685 0 +3580 0.7090228145462598 1.626924018112197 0 +3581 0.7928103222533652 1.247212174813187 0 +3582 0.1201350955041923 1.469865911101082 0 +3583 0.4740929977510073 1.244521438086098 0 +3584 0.630647737843554 1.649600152279288 0 +3585 0.5068463572759233 1.276651265597622 0 +3586 0.3721498168015352 1.03775577992918 0 +3587 0.401066927702555 1.016671804325887 0 +3588 0.005923383227509598 1.005914545855086 0 +3589 0.9940766167724477 1.00591454585511 0 +3590 0.6210413740287497 1.036419165428128 0 +3591 0.1238625823073719 1.845542783648374 0 +3592 0.6380740927560531 1.073146361370302 0 +3593 0.09122703911367487 1.452502287491005 0 +3594 0.6139468223323165 1.613123690945158 0 +3595 0.4110692920437905 1.031638099411708 0 +3596 0.1330582078797185 1.097553478406364 0 +3597 0.8669417921196629 1.097553478406802 0 +3598 0.04249420581981359 1.571526887013898 0 +3599 0.983424162642857 1.7359747604416 0 +3600 0.5510487332079945 1.052480995777755 0 +3601 0.2750692880072463 1.507372080548963 0 +3602 0.05207715141902639 1.006663833637992 0 +3603 0.9479228485807419 1.00666383363803 0 +3604 0.1603978431610944 1.359059036118489 0 +3605 0.7981532595091231 1.293389720552514 0 +3606 0.2741965150060367 1.006069577356058 0 +3607 0.7258019266366019 1.006070306001924 0 +3608 0.1544166481291382 1.030787298497688 0 +3609 0.845583351870145 1.030787298497841 0 +3610 0.04499999999991076 1.005181727692826 0 +3611 0.9549999999998793 1.005181727692858 0 +3612 0.255261213941851 1.666555804920243 0 +3613 0.9320632731088294 1.882758610376341 0 +3614 0.8214165569659956 1.362972306855893 0 +3615 0.8098145951361866 1.286315323436256 0 +3616 0.1189674645655133 1.244611184042298 0 +3617 0.8000997346482217 1.917995364246386 0 +3618 0.02216819238028278 1.074351397824639 0 +3619 0.9778318076196503 1.074351397824938 0 +3620 0.06057652630742353 1.071310610022351 0 +3621 0.9394234736923081 1.071310610022691 0 +3622 0.114173890125833 1.005930176213363 0 +3623 0.8858261098736577 1.005930176213386 0 +3624 0.0168750995561915 1.834395284024228 0 +3625 0.8986538148937213 1.456154498699989 0 +3626 0.4321410576495865 1.096459156163836 0 +3627 0.3662009872095671 1.642313958192046 0 +3628 0.4840319615930496 1.929826164855367 0 +3629 0.4198440208489874 1.326853272864602 0 +3630 0.6209757878940695 1.156061567100777 0 +3631 0.4634346414820441 1.382216499943817 0 +3632 0.5372234098869028 1.02926276883579 0 +3633 0.2883335895161532 1.380955355336657 0 +3634 0.07390845062452635 1.28208204792465 0 +3635 0.06134577333507334 1.657024493986289 0 +3636 0.4638553569109516 1.642497218435722 0 +3637 0.07318727077568837 1.006462358097645 0 +3638 0.9268127292239882 1.006462358097674 0 +3639 0.1394636436600802 1.166522500867852 0 +3640 0.8605363563392858 1.166522500868656 0 +3641 0.9118112497793394 1.339165287757585 0 +3642 0.3090180435720458 1.403959173181105 0 +3643 0.6217168144006515 1.079251694787047 0 +3644 0.09064724888580444 1.178623679863882 0 +3645 0.9093527511143016 1.178623679864107 0 +3646 0.3208003819789911 1.217529921408278 0 +3647 0.6928745603043144 1.541725776519078 0 +3648 0.781538321844969 1.790851151988544 0 +3649 0.4951316152892133 0.5030339212978533 0 +3650 0.2886244732561847 0.7156007037294506 0 +3651 0.7129102494425932 0.7140884405189462 0 +3652 0.5028362279978159 0.7804563884614171 0 +3653 0.1649999999996596 0.8349872397416043 0 +3654 0.8349999999995654 0.8349872397408593 0 +3655 0.6948244514151484 0.8581668436046905 0 +3656 0.3021358388535229 0.8588201877135516 0 +3657 0.7458401323067352 0.4625011581215406 0 +3658 0.2483925999474326 0.4697850086330241 0 +3659 0.4263903316078463 0.8798418401842896 0 +3660 0.5749999999988813 0.8790036651228942 0 +3661 0.4113174879493973 0.2576047535418504 0 +3662 0.9049999999997512 0.9049247893465643 0 +3663 0.09499999999982121 0.9049247893469401 0 +3664 0.856209231079759 0.6915727704167853 0 +3665 0.1455292259684953 0.6943359142438685 0 +3666 0.7750747888379776 0.904587420203242 0 +3667 0.2249252111609158 0.9045874202037003 0 +3668 0.5749362622023186 0.6401520365981953 0 +3669 0.4231725631377143 0.6487072992818387 0 +3670 0.7676487163587822 0.231496430181216 0 +3671 0.6197102944137767 0.7738016783877293 0 +3672 0.3807239696609022 0.7752019445502463 0 +3673 0.5974694466505568 0.3307379265962302 0 +3674 0.4949999999987035 0.919157974888827 0 +3675 0.6459644411457188 0.9245255733834724 0 +3676 0.3549645649669458 0.9214844607321835 0 +3677 0.2009354758611708 0.2697683332719191 0 +3678 0.7683108648850818 0.5952571952002692 0 +3679 0.2305668487757493 0.597269547984191 0 +3680 0.845495771981678 0.9364067007132244 0 +3681 0.1545042280175968 0.9364067007135293 0 +3682 0.7149999999992493 0.9341799136392807 0 +3683 0.28499999999931 0.9341799136396252 0 +3684 0.9062209498770519 0.774631996245378 0 +3685 0.09377905012280031 0.7746319962457424 0 +3686 0.3626781676901021 0.5318016578512994 0 +3687 0.7562511088519948 0.793772176441861 0 +3688 0.2436542903674698 0.795551171640378 0 +3689 0.6257012964749211 0.5184769889189909 0 +3690 0.8698790433716355 0.5118555082708378 0 +3691 0.1157981700644633 0.5822914680550753 0 +3692 0.5545973515899792 0.9380214149930235 0 +3693 0.8563853864353832 0.3708125505471475 0 +3694 0.4149999999989309 0.9388963693766798 0 +3695 0.94524644829951 0.9454433778092888 0 +3696 0.05475355170023821 0.9454433778095569 0 +3697 0.4049452164765799 0.3991092806290063 0 +3698 0.1259927821177929 0.4570158420766265 0 +3699 0.4896666308908597 0.8493391618230737 0 +3700 0.5497090931758539 0.1706149798645513 0 +3701 0.6790408133911712 0.6176372252783328 0 +3702 0.3259072895759921 0.625382839186143 0 +3703 0.9281334621414647 0.8401317570596278 0 +3704 0.07186653785839381 0.8401317570599841 0 +3705 0.5040881717607384 0.6906147079459702 0 +3706 0.6356156820135995 0.8611114020578882 0 +3707 0.6049999999989599 0.9502933168442059 0 +3708 0.9009907905490346 0.6053878293494258 0 +3709 0.3659374286579278 0.860716479819049 0 +3710 0.8238596996029721 0.760253126623778 0 +3711 0.1725047735221046 0.762276885081815 0 +3712 0.6880575264864723 0.7883196764072731 0 +3713 0.3129788234815334 0.7883755764708607 0 +3714 0.7954272205075399 0.9505245255190962 0 +3715 0.2045727794914657 0.9505245255193356 0 +3716 0.4358748729283511 0.8112983575217714 0 +3717 0.3061004762108279 0.1516571645800894 0 +3718 0.4454651465872002 0.7431266145830052 0 +3719 0.8951235665832378 0.952551389712281 0 +3720 0.104876433416288 0.9525513897124754 0 +3721 0.4973664589306666 0.6043444702960334 0 +3722 0.635675941920802 0.6953047828117335 0 +3723 0.2903463778211808 0.3516663094691181 0 +3724 0.5636005647979639 0.8128764689249354 0 +3725 0.3631678338440074 0.7009828099912561 0 +3726 0.4650087993149511 0.9552018865863339 0 +3727 0.6749999999991446 0.9551255240219025 0 +3728 0.324999999999193 0.9551255240221453 0 +3729 0.7165942877072025 0.3433047082078004 0 +3730 0.5575658404965225 0.7329484973429717 0 +3731 0.7530698821014418 0.8517336940480875 0 +3732 0.2469301178973254 0.8517336940488369 0 +3733 0.9285652768661607 0.7041780532146942 0 +3734 0.07236531557862763 0.7049504158853144 0 +3735 0.7775720702787963 0.6758952762168193 0 +3736 0.1366028350729405 0.135360653295327 0 +3737 0.8574069800633093 0.8825602793559132 0 +3738 0.1425930199360604 0.8825602793564479 0 +3739 0.5686634993247253 0.4325369528954985 0 +3740 0.2158192146755186 0.700440318206603 0 +3741 0.5155514434375249 0.957428998120037 0 +3742 0.1164327569888408 0.3456839977593948 0 +3743 0.3758001142500348 0.9566022503131829 0 +3744 0.7527511859645537 0.9588800736655889 0 +3745 0.2472488140342155 0.9588800736658142 0 +3746 0.9524010848800437 0.8997866408091254 0 +3747 0.04759891511973552 0.8997866408095306 0 +3748 0.8612551519889815 0.1319248299662935 0 +3749 0.181782084296993 0.5246834197315848 0 +3750 0.8801413916575318 0.2644450571349767 0 +3751 0.421790745351459 0.1383711817579202 0 +3752 0.6772041500205526 0.1344991314131296 0 +3753 0.7036556660790018 0.5458578254283518 0 +3754 0.5283585586688625 0.8798219657305826 0 +3755 0.6639331689519016 0.438299996512328 0 +3756 0.4796526162310633 0.3304786862977649 0 +3757 0.5637996632371463 0.5677674687415111 0 +3758 0.8348563129955622 0.6263902654949128 0 +3759 0.4508393998825335 0.9149167069854778 0 +3760 0.1937231399367003 0.3963219546118056 0 +3761 0.4278398459595389 0.577516079733129 0 +3762 0.7294164162809222 0.8913801902987554 0 +3763 0.2705835837177522 0.8913801902992954 0 +3764 0.07060779360940994 0.6349151642951704 0 +3765 0.8135281130272947 0.8739816373222906 0 +3766 0.1864718869718131 0.8739816373228619 0 +3767 0.665591751369725 0.2518137356741437 0 +3768 0.7670539122833595 0.7381687970643054 0 +3769 0.6872565080401121 0.90177259278346 0 +3770 0.3128751529678904 0.901974716272226 0 +3771 0.3333365632516667 0.4513214142859323 0 +3772 0.2940014017147823 0.5563545863694396 0 +3773 0.9119651076512172 0.4358392627416694 0 +3774 0.1037751011725982 0.2434626961035677 0 +3775 0.8825904570425558 0.8439984571807619 0 +3776 0.1174095429570416 0.8439984571815344 0 +3777 0.6054272041488761 0.9099949909096751 0 +3778 0.1675224668898134 0.6276387001943534 0 +3779 0.6385717793163356 0.9649259206122556 0 +3780 0.2596659911204697 0.6571224768690813 0 +3781 0.3928648897728227 0.9041668459325827 0 +3782 0.7940655524770115 0.5237431836180173 0 +3783 0.5742618506961469 0.9664752325858235 0 +3784 0.07536788005301508 0.515579384356057 0 +3785 0.8255117312674655 0.4468580343445921 0 +3786 0.8248485784112995 0.9664166904418687 0 +3787 0.1751514215878712 0.966416690442044 0 +3788 0.3013227367640799 0.2556473472019965 0 +3789 0.8645213772979725 0.9682359970246354 0 +3790 0.1354786227014135 0.9682359970247754 0 +3791 0.4846287120861147 0.4249780695895251 0 +3792 0.9501429847038053 0.79618164310984 0 +3793 0.04985701529619381 0.796181643110295 0 +3794 0.8643808803855763 0.7966081801209282 0 +3795 0.1355638060890303 0.7968660911323436 0 +3796 0.4228453617372052 0.4755961821361328 0 +3797 0.8097289768620304 0.9177264886096514 0 +3798 0.1902710231370594 0.9177264886100629 0 +3799 0.4344943926561243 0.9679991229802747 0 +3800 0.7049999999992214 0.9678133445421923 0 +3801 0.294999999999281 0.9678133445423693 0 +3802 0.6613582499302223 0.7421878119695458 0 +3803 0.6450937109042678 0.8126747722640224 0 +3804 0.7902564822353814 0.8256733897962364 0 +3805 0.2097435177636063 0.8256733897970749 0 +3806 0.3540920651235021 0.8131714863801713 0 +3807 0.720257669311593 0.8193501602877338 0 +3808 0.278744454409672 0.8204085259931641 0 +3809 0.7260715717287158 0.65662305088958 0 +3810 0.3380381450712668 0.7452961044377397 0 +3811 0.9302562727283465 0.5444078473272418 0 +3812 0.9678359677135614 0.9678834693750559 0 +3813 0.03216403228629287 0.9678834693752107 0 +3814 0.6171666438772465 0.5942990561145115 0 +3815 0.5951215241491643 0.841488833808709 0 +3816 0.9249999999997995 0.9691771808678272 0 +3817 0.07499999999985285 0.9691771808679772 0 +3818 0.4763493687147465 0.885348305559029 0 +3819 0.5285532660738312 0.8357397834812883 0 +3820 0.9436188907219221 0.6516349780992643 0 +3821 0.5447918303283066 0.9699846568893785 0 +3822 0.4043557480384705 0.8417591077774624 0 +3823 0.4049999999989607 0.9702917063411154 0 +3824 0.2395470048806064 0.7425710045535132 0 +3825 0.8680277829141924 0.7431218362877513 0 +3826 0.1303675135481172 0.7414262421750296 0 +3827 0.5427557008437534 0.2584388243689164 0 +3828 0.951851718962846 0.7474464822302712 0 +3829 0.04814828103691262 0.7474464822309445 0 +3830 0.8770792412949472 0.9236344339748748 0 +3831 0.1229207587044854 0.9236344339751844 0 +3832 0.7961445410523822 0.311251754350556 0 +3833 0.7760372495275611 0.3903150853269405 0 +3834 0.7236098808148653 0.7607028599022946 0 +3835 0.4137267449730414 0.7000828130392076 0 +3836 0.7466089352857045 0.9239285263686412 0 +3837 0.2533910647130155 0.9239285263690413 0 +3838 0.9610139135484708 0.8612840077674176 0 +3839 0.0389860864514746 0.8612840077678749 0 +3840 0.5291657478040362 0.9167650420553539 0 +3841 0.8120322410643368 0.7134034415574153 0 +3842 0.3820676197677851 0.6075134610974431 0 +3843 0.4753863532713057 0.8105968310407812 0 +3844 0.5613774318451397 0.49487794408774 0 +3845 0.5835987208003524 0.6883675850041264 0 +3846 0.4496620124782539 0.848215513731984 0 +3847 0.771368009263711 0.1325824442908582 0 +3848 0.854613180076208 0.5680165409472484 0 +3849 0.05324339469079318 0.5787625499386186 0 +3850 0.3680917249003124 0.3285304657587159 0 +3851 0.07314870358487699 0.4038140150719662 0 +3852 0.4896801683500572 0.9716773319678798 0 +3853 0.3163780951507726 0.6743945688169285 0 +3854 0.9247899181541059 0.8753105967699204 0 +3855 0.07521008184553703 0.8753105967702725 0 +3856 0.9230897015045263 0.3278303519808334 0 +3857 0.7733297816745903 0.9728355458975075 0 +3858 0.2266702183242967 0.9728355458976559 0 +3859 0.4905325186655494 0.7358031001216199 0 +3860 0.3491814661591301 0.9719082358767021 0 +3861 0.6539281580892802 0.8873477425520724 0 +3862 0.3460390566922257 0.8874171313347612 0 +3863 0.9690407413969251 0.924746118751727 0 +3864 0.03095925860296628 0.9247461187520987 0 +3865 0.6276193463987503 0.6451641951516576 0 +3866 0.4726448832694249 0.2091531175878388 0 +3867 0.2774037955385593 0.7662193316932696 0 +3868 0.6049826823315074 0.7312853759709507 0 +3869 0.1171244667396665 0.6485435588172355 0 +3870 0.2346426415369918 0.5354934146053882 0 +3871 0.5464335942759053 0.7747979171718952 0 +3872 0.2191427888927727 0.186045390150349 0 +3873 0.226348199313372 0.09110089560914636 0 +3874 0.9204170524390722 0.9331290227463437 0 +3875 0.8918427989320958 0.6564182620814207 0 +3876 0.07958294756057027 0.9331290227466396 0 +3877 0.5727759534019614 0.9111161497353149 0 +3878 0.6819420966563542 0.6802744633419884 0 +3879 0.2116052887953869 0.6505623313846898 0 +3880 0.4743855051414581 0.6494219818844299 0 +3881 0.1859732665107253 0.4638199073645261 0 +3882 0.6831019552237937 0.4981411881327831 0 +3883 0.5261899353738885 0.6460107558012543 0 +3884 0.8182248838015395 0.8004852644754825 0 +3885 0.1808797841266093 0.8000075853328212 0 +3886 0.8905587696235082 0.8761404132810806 0 +3887 0.1094412303760334 0.8761404132816502 0 +3888 0.4592240634908111 0.6996017621850765 0 +3889 0.7312854314423527 0.9717321817389465 0 +3890 0.2687145685562919 0.9717321817391034 0 +3891 0.6151500988895461 0.9737799722415401 0 +3892 0.9056161833773897 0.8121727166327566 0 +3893 0.0943838166226756 0.8121727166331457 0 +3894 0.5964139947465555 0.09146604088779577 0 +3895 0.506673353631782 0.0931235652748683 0 +3896 0.4208273319235493 0.7756038681763548 0 +3897 0.7763692969201188 0.8723433624392942 0 +3898 0.2236307030788141 0.8723433624399329 0 +3899 0.275989832139486 0.6099471607436453 0 +3900 0.6806555650022809 0.824356956760762 0 +3901 0.7211515884186711 0.6072283856949062 0 +3902 0.770856838500092 0.9369655964387337 0 +3903 0.2291431614987754 0.9369655964390768 0 +3904 0.2995306711455051 0.4982552016311874 0 +3905 0.3191308017574142 0.8245094468753111 0 +3906 0.1812052894171816 0.5804763554889556 0 +3907 0.3876430579365246 0.9322186937839707 0 +3908 0.6546789176470527 0.365604784051565 0 +3909 0.9442774505310696 0.4891548680913375 0 +3910 0.6037330416931657 0.8760030756862187 0 +3911 0.8389088785928506 0.9051488575365128 0 +3912 0.161091121406404 0.9051488575369526 0 +3913 0.5344873588691672 0.3784736330348054 0 +3914 0.4015494210549199 0.7399101516384153 0 +3915 0.4723874315943569 0.546647695495009 0 +3916 0.5987772339283716 0.8078037086993788 0 +3917 0.3982968647758967 0.8072806868780432 0 +3918 0.4210818059296881 0.9104668226621264 0 +3919 0.6868353967798447 0.9291318806450595 0 +3920 0.3133716125063806 0.9297010548540732 0 +3921 0.9531283016740071 0.601615445456265 0 +3922 0.5626761204542309 0.8496821802324226 0 +3923 0.4414708587792049 0.9417158736919977 0 +3924 0.9675460547335292 0.8258954400798246 0 +3925 0.0324539452665415 0.8258954400801936 0 +3926 0.2814497900878374 0.417157182152149 0 +3927 0.1250826382746296 0.5293186015734948 0 +3928 0.1769476255748152 0.7186475757768602 0 +3929 0.9210448196398369 0.1881869237486085 0 +3930 0.7917971679822369 0.7762653160077295 0 +3931 0.2103555249655211 0.7765951653249676 0 +3932 0.3532364705802262 0.1983468898055183 0 +3933 0.3530937030899848 0.08579201745327555 0 +3934 0.8949999999997217 0.976294770997749 0 +3935 0.104999999999807 0.9762947709978431 0 +3936 0.2288242487404349 0.3348435826550285 0 +3937 0.3929760491960678 0.8749422514622009 0 +3938 0.04516197948641304 0.668366641318048 0 +3939 0.4700063955197665 0.7749159423477995 0 +3940 0.3425379730539151 0.5792950756644065 0 +3941 0.8018110375928003 0.9751091059680805 0 +3942 0.1981889624062582 0.9751091059682028 0 +3943 0.3790818396725328 0.6537317007277476 0 +3944 0.660834958366359 0.9753348669255453 0 +3945 0.715516373340834 0.4104224142853757 0 +3946 0.05848113365782839 0.4617704235136489 0 +3947 0.5807241435795072 0.9423470173288349 0 +3948 0.3482085860694553 0.391183816390297 0 +3949 0.4903088707995424 0.9436571391010395 0 +3950 0.05763525586117547 0.2940324319541971 0 +3951 0.5444962278403366 0.6959514726691052 0 +3952 0.3490441535762759 0.9425860230813619 0 +3953 0.620547232805049 0.1856387495193579 0 +3954 0.6642277708697455 0.8583498649100529 0 +3955 0.5826535338927147 0.7732921120177205 0 +3956 0.07769759500999719 0.09393096939028349 0 +3957 0.3348364976023889 0.8582279690181107 0 +3958 0.5326474058044592 0.80395688499181 0 +3959 0.0701045633760735 0.1781255038555453 0 +3960 0.8165570019248398 0.9416198694245954 0 +3961 0.1834429980742726 0.9416198694248805 0 +3962 0.4649999999987859 0.9773563295480949 0 +3963 0.624053722819608 0.9386974960475305 0 +3964 0.8449999999995869 0.9777874771794672 0 +3965 0.1549999999996889 0.9777874771795785 0 +3966 0.7524435815208094 0.7001106678710701 0 +3967 0.749528997230915 0.5468488343074716 0 +3968 0.7254939270004099 0.8617903862445928 0 +3969 0.27450607299822 0.8617903862453002 0 +3970 0.6519123606210981 0.7816798503429209 0 +3971 0.66460997957715 0.5778223874071722 0 +3972 0.8352559813665218 0.2010159976029955 0 +3973 0.9386331188501114 0.3834235154859676 0 +3974 0.6848511933763669 0.9773956861446451 0 +3975 0.1819658802735272 0.6821628049613305 0 +3976 0.9491853182037719 0.9795650237413575 0 +3977 0.05081468179599716 0.9795650237414519 0 +3978 0.3464444298436914 0.7801897858183069 0 +3979 0.9037898811988192 0.7360218014908835 0 +3980 0.09133476066318519 0.7370529710083176 0 +3981 0.3148300438636647 0.9785922770944113 0 +3982 0.4385723720112795 0.5249878922157225 0 +3983 0.6140151709784849 0.4567487060084635 0 +3984 0.8198662273904778 0.663765593350356 0 +3985 0.5493094379728428 0.8962497178983865 0 +3986 0.5481579202118432 0.6091403413767789 0 +3987 0.136805770058462 0.3976067784538805 0 +3988 0.2003602797483222 0.741464831887564 0 +3989 0.449552352917812 0.6156866242806219 0 +3990 0.6538338586789421 0.9433639064821979 0 +3991 0.4724454130763751 0.930181302231268 0 +3992 0.9168735851548003 0.08154510520896407 0 +3993 0.4263247628428187 0.3437997297618366 0 +3994 0.5250470169266888 0.4644989142298308 0 +3995 0.5241988755829053 0.9788953096104701 0 +3996 0.9388335296434006 0.9199725084444028 0 +3997 0.06116647035632636 0.9199725084447776 0 +3998 0.3836865411847476 0.978418578355855 0 +3999 0.7097390757618174 0.9075335946972667 0 +4000 0.2902609242367218 0.9075335946977523 0 +4001 0.8078856255198641 0.560785750602893 0 +4002 0.6311826055631086 0.8988274543016862 0 +4003 0.5291040925343674 0.7442036669385633 0 +4004 0.7895357646898007 0.6333944670848419 0 +4005 0.5043229919422062 0.8232918074274702 0 +4006 0.9645542000929698 0.6873818475444158 0 +4007 0.7093818579090103 0.1998306855753584 0 +4008 0.817312533223256 0.0763104559294886 0 +4009 0.7211920553034565 0.2765128821850641 0 +4010 0.1045016299822327 0.6836477120168121 0 +4011 0.5934016151322565 0.9783136699040823 0 +4012 0.2530404397524282 0.6927362582101269 0 +4013 0.5020192269822026 0.8932369018502502 0 +4014 0.7267790888599116 0.07621511994400353 0 +4015 0.8357006539495749 0.8608413962695657 0 +4016 0.1642993460496671 0.8608413962702156 0 +4017 0.7549381729174602 0.9798486679108018 0 +4018 0.2450618270813166 0.9798486679109171 0 +4019 0.3221335758301973 0.71127256682436 0 +4020 0.9767801339172379 0.9464474185312483 0 +4021 0.02321986608265552 0.9464474185315113 0 +4022 0.03510793832173042 0.7146399421618292 0 +4023 0.5310201529988398 0.9398343821624919 0 +4024 0.3040335315306726 0.7440358868866173 0 +4025 0.7256638451292878 0.5131429463324011 0 +4026 0.450884069495847 0.887880672280936 0 +4027 0.1404441900112984 0.292893795100662 0 +4028 0.6051226495039908 0.2702066890632027 0 +4029 0.6245405756697463 0.8331667819524549 0 +4030 0.3740270651896885 0.482767246039739 0 +4031 0.8948792006130712 0.7060170203332713 0 +4032 0.8510036084490654 0.3142815868935936 0 +4033 0.8780290078219277 0.8970285657248318 0 +4034 0.1219709921775037 0.897028565725295 0 +4035 0.3776920384400134 0.8312978100422318 0 +4036 0.5217653188690962 0.5428047309558556 0 +4037 0.8083411724126399 0.8466945988892474 0 +4038 0.1916588275864309 0.8466945988899407 0 +4039 0.3710933166086729 0.8865426419426667 0 +4040 0.1709284603443829 0.3400879153048332 0 +4041 0.7304222902648517 0.9537611250385332 0 +4042 0.2695777097337914 0.9537611250387831 0 +4043 0.616701106779838 0.4051094877200854 0 +4044 0.760597449504012 0.823815148382288 0 +4045 0.2394025504948221 0.8238151483831697 0 +4046 0.70023936449538 0.885299734007549 0 +4047 0.2997541015713867 0.8853067990347929 0 +4048 0.8649562915958634 0.9455194359678181 0 +4049 0.13504370840352 0.9455194359680623 0 +4050 0.8464510154484939 0.9577920130232931 0 +4051 0.153548984550803 0.9577920130234968 0 +4052 0.6909802103208807 0.7563943368492488 0 +4053 0.6746583939477759 0.3097922701641638 0 +4054 0.4653931509652491 0.2725611634256091 0 +4055 0.9742631554277045 0.8851746742297567 0 +4056 0.02573684457225862 0.8851746742301216 0 +4057 0.1655824595434258 0.2256039434254096 0 +4058 0.8704700192242447 0.4647885051350603 0 +4059 0.05521997116950423 0.3490463552934598 0 +4060 0.9471418445432391 0.2780602820843013 0 +4061 0.9079525829009025 0.8545294707958382 0 +4062 0.09204741709884703 0.8545294707963534 0 +4063 0.7576556720569849 0.8883005133851498 0 +4064 0.2423443279418391 0.8883005133857096 0 +4065 0.3823821655854145 0.5735711725136273 0 +4066 0.7974349020288207 0.8999337737578619 0 +4067 0.2025650979701839 0.8999337737583413 0 +4068 0.7152918078423299 0.7871226391309929 0 +4069 0.1417246818594895 0.06825715186294318 0 +4070 0.9264985356925385 0.9018192982049517 0 +4071 0.07350146430712162 0.9018192982053652 0 +4072 0.749519569103445 0.6335700494691513 0 +4073 0.8241594595282118 0.2621746194822492 0 +4074 0.5507871165470715 0.8700512602225086 0 +4075 0.5092414204691827 0.9357249608961486 0 +4076 0.680044873749719 0.7190672069907369 0 +4077 0.3693384260898727 0.7310026456206432 0 +4078 0.8304380897379404 0.4921945420040005 0 +4079 0.7931823468661678 0.9313279321707053 0 +4080 0.2068176531328262 0.9313279321710427 0 +4081 0.8611134226038442 0.8584049973495407 0 +4082 0.1388865773955487 0.8584049973502361 0 +4083 0.2735622613126485 0.3014304754792097 0 +4084 0.8537809566034509 0.7673508636177419 0 +4085 0.1460749507846286 0.7677270434442931 0 +4086 0.4672664617845406 0.468505371266777 0 +4087 0.6687391834199609 0.9191348962990784 0 +4088 0.3295286953357598 0.9189494977259469 0 +4089 0.896177673755532 0.565747373405344 0 +4090 0.5041050539021672 0.9822450425579017 0 +4091 0.6042858736192473 0.553687609888421 0 +4092 0.3951448024543263 0.9516765628852387 0 +4093 0.234317439844356 0.4230437345274692 0 +4094 0.5422284215259245 0.3262431394770985 0 +4095 0.8613947015174612 0.8222253710108369 0 +4096 0.1386052984819151 0.8222253710116627 0 +4097 0.9693595232429085 0.771577761770567 0 +4098 0.0307015817501409 0.7714399503855089 0 +4099 0.6947070100591117 0.9505319614252726 0 +4100 0.3053496473777573 0.9504187208782864 0 +4101 0.04052299530249664 0.5415663871479356 0 +4102 0.837847517007542 0.7341421855185098 0 +4103 0.3629267507178361 0.9818631538622864 0 +4104 0.03989874246352883 0.6134302441052675 0 +4105 0.7530683153811095 0.7625040937587992 0 +4106 0.5129499351880757 0.8581812192630389 0 +4107 0.5618147855922505 0.9824201967693187 0 +4108 0.2961620851092936 0.643809887970449 0 +4109 0.8356453498485782 0.5346303506010788 0 +4110 0.6790217475576487 0.877470256977592 0 +4111 0.9685995814597967 0.7190246785389344 0 +4112 0.3203451920146463 0.8775443870667532 0 +4113 0.152097110669405 0.4916027572177032 0 +4114 0.2185388766157459 0.4997246267070515 0 +4115 0.5982748955245324 0.9308147683294072 0 +4116 0.6360105500651638 0.9824691143577043 0 +4117 0.7889763322100682 0.4773232421416736 0 +4118 0.664784977976852 0.0678096324797476 0 +4119 0.7784266716413926 0.8482980248759897 0 +4120 0.2215733283575073 0.8482980248767409 0 +4121 0.9826766411859073 0.9827112450896717 0 +4122 0.01732335881401648 0.9827112450896797 0 +4123 0.4158862670462219 0.06531174341464539 0 +4124 0.8548875776205234 0.6560501245142085 0 +4125 0.4232485507790545 0.9827133671899215 0 +4126 0.8679514502116198 0.4186203838149137 0 +4127 0.2857749042594009 0.06563539253413279 0 +4128 0.8602422762969811 0.9086108725982511 0 +4129 0.1397577237023721 0.9086108725986387 0 +4130 0.4735233156227197 0.9073993299340167 0 +4131 0.3336823060364046 0.9821394160542336 0 +4132 0.452290271387019 0.3864884702798327 0 +4133 0.1035594595201337 0.6155783396978679 0 +4134 0.2407484597185398 0.2334195549816942 0 +4135 0.897230901368592 0.9323771494624625 0 +4136 0.1027690986309371 0.9323771494627427 0 +4137 0.6620381309879446 0.5394802410139503 0 +4138 0.8769173897430906 0.9814510083478871 0 +4139 0.1230826102563553 0.9814510083479681 0 +4140 0.3815878523538027 0.4388253737063962 0 +4141 0.1524273685825279 0.6603207406625053 0 +4142 0.6313745357945908 0.7487661614674604 0 +4143 0.8733080293537445 0.6246886341650479 0 +4144 0.9329626620355295 0.7692085526097406 0 +4145 0.06703733796432974 0.7692085526102221 0 +4146 0.1126178001660977 0.7148592657260624 0 +4147 0.3507043658025388 0.2759577611615795 0 +4148 0.7365480540803954 0.7342978823617738 0 +4149 0.2850496441467325 0.6821333664749 0 +4150 0.4351028611644084 0.4351583705713032 0 +4151 0.4812561517566297 0.1549539867072043 0 +4152 0.5817201901258277 0.6010840407883881 0 +4153 0.4488700650611264 0.9830852143403759 0 +4154 0.3664458188078803 0.938801628714077 0 +4155 0.2864723655052417 0.7952884532590866 0 +4156 0.9148803679000146 0.9513694453003954 0 +4157 0.08511963209958326 0.9513694453006001 0 +4158 0.6481087552590663 0.8411446835747254 0 +4159 0.3516452214278706 0.8411302147311492 0 +4160 0.4261539156132824 0.8539506870707509 0 +4161 0.9789879930217859 0.9054594636494556 0 +4162 0.02101200697831327 0.9054594636497532 0 +4163 0.7970725257150095 0.7480507602707177 0 +4164 0.6239561498962085 0.9183842989649225 0 +4165 0.08567710266744501 0.5555756361155488 0 +4166 0.9319489926008352 0.8138102092908305 0 +4167 0.06805100739921652 0.8138102092911406 0 +4168 0.4144667904904701 0.2056947392925472 0 +4169 0.7149999999992495 0.9827415931578174 0 +4170 0.2849999999993101 0.982741593157912 0 +4171 0.2616565246991721 0.5751602696945131 0 +4172 0.3247807326931682 0.5299340318428443 0 +4173 0.9122001489041095 0.9820094049903503 0 +4174 0.08779985109549929 0.9820094049904297 0 +4175 0.347176469727653 0.6559806936917936 0 +4176 0.8220598734827319 0.4000501291896271 0 +4177 0.4453469392568887 0.788214287023689 0 +4178 0.1486179248388603 0.5930188929197613 0 +4179 0.9561798483004957 0.4489129240204565 0 +4180 0.7818349722419444 0.7062122249717073 0 +4181 0.2025833254783888 0.6210048928004108 0 +4182 0.9201140635103675 0.676251434332563 0 +4183 0.2475305143277344 0.3795114002983948 0 +4184 0.7037418639541988 0.4524303643089364 0 +4185 0.5501786654921997 0.9173706031202171 0 +4186 0.4697420949965335 0.8636983115383005 0 +4187 0.5580501019953795 0.9568497289430657 0 +4188 0.653041187425465 0.6684380225676578 0 +4189 0.4189470857173174 0.9574438514246758 0 +4190 0.3121607265807631 0.5899502794574656 0 +4191 0.4954205747884621 0.8719822753036138 0 +4192 0.3746001987168552 0.9138713197218982 0 +4193 0.9642427727747984 0.567449305173046 0 +4194 0.3308461375764 0.9368270220730066 0 +4195 0.5532560507595492 0.6623870694946646 0 +4196 0.46947858533257 0.8358417473975678 0 +4197 0.07678573368741082 0.6698713127203624 0 +4198 0.9406697144130838 0.135919380670786 0 +4199 0.9111822936040488 0.5119950407053048 0 +4200 0.6117501189139222 0.6754370909944122 0 +4201 0.148800994187358 0.5580918393546355 0 +4202 0.03944298110645466 0.4999360485796459 0 +4203 0.4043861484784972 0.9219950972566929 0 +4204 0.8177682260848396 0.9823603729776671 0 +4205 0.1822317739143021 0.9823603729777572 0 +4206 0.05018573287253508 0.2333541202418692 0 +4207 0.8792964947067313 0.7722314518378967 0 +4208 0.1210312750670137 0.7757781122401488 0 +4209 0.5212378253639011 0.7153401793001432 0 +4210 0.3993189523506581 0.5092643407741604 0 +4211 0.6215447929455843 0.9558615499438374 0 +4212 0.7817899106112969 0.4334925735279735 0 +4213 0.3209330122588003 0.3145276898322378 0 +4214 0.2608269827239185 0.5071001087932713 0 +4215 0.9766587151824272 0.7986238105878593 0 +4216 0.02334128481753584 0.7986238105882302 0 +4217 0.5256761037587305 0.5787894945510511 0 +4218 0.8178026128082712 0.899194814775815 0 +4219 0.1821973871908463 0.8991948147763119 0 +4220 0.5876489163598397 0.8960129626470158 0 +4221 0.2354219329630357 0.6304638051482453 0 +4222 0.1088497966177338 0.4925824156507881 0 +4223 0.2890603050486202 0.4573119855372815 0 +4224 0.4347170268060512 0.6794816080849942 0 +4225 0.9463337944630184 0.8781899975460656 0 +4226 0.05366620553670987 0.8781899975465519 0 +4227 0.5781537401078798 0.2197283733095203 0 +4228 0.2717949900413541 0.7405866294768793 0 +4229 0.7785837982243997 0.8025389755972611 0 +4230 0.2190172555565114 0.8008042063326757 0 +4231 0.6249857477072267 0.8004556778475509 0 +4232 0.8154028290314947 0.8225068767308984 0 +4233 0.1845971709676346 0.822506876731719 0 +4234 0.3666236668192 0.1422922928571595 0 +4235 0.8084459013379517 0.6015972105669998 0 +4236 0.5774078150218241 0.375580701333 0 +4237 0.9661265115387374 0.9841005147175761 0 +4238 0.0338734884611159 0.9841005147176254 0 +4239 0.7768425360144945 0.9542419905654701 0 +4240 0.2231574639844001 0.9542419905657221 0 +4241 0.7274601784845142 0.9187425015230839 0 +4242 0.272539821514108 0.9187425015235092 0 +4243 0.7123039187862135 0.843576073033442 0 +4244 0.2891750433666406 0.8412353002808484 0 +4245 0.7649557352010862 0.3470911339511453 0 +4246 0.4144061693469608 0.6196748796052526 0 +4247 0.5284318275921717 0.4189717085079954 0 +4248 0.1581858591539055 0.7405140104941563 0 +4249 0.2356182000751463 0.7685307557620108 0 +4250 0.8404689079172426 0.8114271582676238 0 +4251 0.1595310920820464 0.8114271582684899 0 +4252 0.3749058911679697 0.800217907204281 0 +4253 0.4101036052345142 0.8923386518629746 0 +4254 0.7282028726225347 0.6855942601453904 0 +4255 0.8128317701772946 0.3546456262646864 0 +4256 0.8826181543782359 0.9656653926308252 0 +4257 0.1173818456212346 0.9656653926309833 0 +4258 0.9681012241022898 0.6287981430492779 0 +4259 0.9622928521181487 0.5224470399746449 0 +4260 0.6927129276204577 0.6504456434991349 0 +4261 0.3872156631590173 0.6857063390311052 0 +4262 0.8330713946194136 0.8835088728666287 0 +4263 0.1669286053798003 0.8835088728671758 0 +4264 0.1589882140904168 0.4317466522737323 0 +4265 0.8609270414630412 0.9846156340177163 0 +4266 0.1390729585363213 0.984615634017788 0 +4267 0.5913896038992233 0.8633620682394447 0 +4268 0.72725250426397 0.5723162240926558 0 +4269 0.5777770824084649 0.9836421937203268 0 +4270 0.5328575653224693 0.9570776422950392 0 +4271 0.7873034218702757 0.9833672010215657 0 +4272 0.2126965781286913 0.9833672010216515 0 +4273 0.6441606398056978 0.6132322795170921 0 +4274 0.6994356293452143 0.8096871781219145 0 +4275 0.1226475246850834 0.1875480366001286 0 +4276 0.8284606224841331 0.9248379800449589 0 +4277 0.1715393775150499 0.9248379800453225 0 +4278 0.215151586117989 0.5659056360359447 0 +4279 0.5909625304182651 0.9603385785395139 0 +4280 0.952147064860504 0.9608393396282813 0 +4281 0.04785293513927594 0.9608393396284717 0 +4282 0.2892931448533498 0.203819110741244 0 +4283 0.8837864673712319 0.8181226502148615 0 +4284 0.1162135326284134 0.818122650215849 0 +4285 0.4524714056928162 0.9660606611347801 0 +4286 0.7500348566670829 0.6702660646340582 0 +4287 0.8984699849189154 0.3884363547467543 0 +4288 0.6120136152325861 0.855481988792079 0 +4289 0.7123982478825868 0.9512484434322225 0 +4290 0.2876017521159564 0.95124844343249 0 +4291 0.3251735374695774 0.7645749675843103 0 +4292 0.6987176572202061 0.9833749515446357 0 +4293 0.2323036375657582 0.6713241195754749 0 +4294 0.6706938876578555 0.9374421594994932 0 +4295 0.6680525837539829 0.8042179040513306 0 +4296 0.3323808225580119 0.8035858973424583 0 +4297 0.4296280512866321 0.9272315192418585 0 +4298 0.9839692389031088 0.9627670939033381 0 +4299 0.01603076109681119 0.9627670939033469 0 +4300 0.9762271832776135 0.844602191326422 0 +4301 0.02377281672242474 0.8446021913268096 0 +4302 0.7363329351765777 0.8371095671086237 0 +4303 0.2636670648221165 0.8371095671094548 0 +4304 0.3606825405886664 0.7575201954927218 0 +4305 0.7422803808432308 0.8741983428270844 0 +4306 0.2577196191555026 0.8741983428277326 0 +4307 0.9307468199854612 0.9845839230804445 0 +4308 0.06925318001422211 0.9845839230805181 0 +4309 0.03066018468121775 0.6425451600761815 0 +4310 0.583584840411836 0.746125640291881 0 +4311 0.572195197005028 0.5315011239661203 0 +4312 0.6408093900688562 0.7218411301887434 0 +4313 0.4697951054252912 0.5877864378428547 0 +4314 0.8093931937911109 0.9601833427440208 0 +4315 0.1906068062079767 0.9601833427442276 0 +4316 0.4788135554551597 0.984507925044958 0 +4317 0.3385109887976677 0.4964301806522455 0 +4318 0.9127156321561187 0.6348008950957074 0 +4319 0.4369107942813762 0.7169337049851341 0 +4320 0.579938791559432 0.7175566233038171 0 +4321 0.7607839706411667 0.5034019375886101 0 +4322 0.2363149133897059 0.715485310265731 0 +4323 0.9071960248454136 0.8855578923401635 0 +4324 0.09280397515411964 0.8855578923406052 0 +4325 0.6091701709748906 0.7035264650707285 0 +4326 0.6429030743141277 0.4862127562180408 0 +4327 0.6988582300841595 0.5826643179188586 0 +4328 0.464147177301004 0.7253598773937149 0 +4329 0.3005270216020079 0.8120587996798611 0 +4330 0.300607789766402 0.9843239788964718 0 +4331 0.2456284629751048 0.140025942446175 0 +4332 0.4778640197923424 0.6789772247115572 0 +4333 0.5015117095401601 0.6618453099726923 0 +4334 0.5469573884852025 0.05836509929272661 0 +4335 0.9242334835857872 0.5823619041976059 0 +4336 0.4427068940723775 0.8678953605069092 0 +4337 0.03897824405264215 0.4255207633722623 0 +4338 0.839508223742877 0.7867970397521789 0 +4339 0.1606641257020042 0.7869872849403499 0 +4340 0.746695672353308 0.9047276844559351 0 +4341 0.2533043276454708 0.9047276844564223 0 +4342 0.7948208858180777 0.8625473633462948 0 +4343 0.2051791141809537 0.8625473633469221 0 +4344 0.5235787250849806 0.2114317069170367 0 +4345 0.38655707458157 0.8532201153420796 0 +4346 0.7411135888878527 0.8109425605399417 0 +4347 0.258886411110892 0.8109425605409118 0 +4348 0.3907323827744286 0.7148311098325104 0 +4349 0.5115005885700075 0.9112587614801924 0 +4350 0.3591099259743124 0.9015542273498706 0 +4351 0.9199724311661232 0.7938573842643601 0 +4352 0.08002756883399992 0.7938573842648261 0 +4353 0.9074424394777332 0.9662350089353547 0 +4354 0.09255756052184506 0.9662350089354927 0 +4355 0.7445598049645732 0.9415364299399196 0 +4356 0.2554401950341465 0.9415364299402307 0 +4357 0.09079282021182447 0.4394015518659876 0 +4358 0.8688124431831207 0.05587203788803644 0 +4359 0.5449999999988019 0.9855055569334812 0 +4360 0.970718127536738 0.6579886322986841 0 +4361 0.6270462974900015 0.8781641155471279 0 +4362 0.5759608309224681 0.8309285141630248 0 +4363 0.5091879395726132 0.2903089476269688 0 +4364 0.9049666550446075 0.831357416884376 0 +4365 0.09503334495522955 0.8313574168849251 0 +4366 0.4047605200544121 0.9852089478933519 0 +4367 0.7839481847743417 0.1853380952839349 0 +4368 0.6553758021859476 0.95976128939006 0 +4369 0.9530227302202041 0.8425431732731207 0 +4370 0.4898214436049057 0.7605839124387881 0 +4371 0.04697726977979349 0.8425431732735029 0 +4372 0.4226325673020617 0.8315699086329623 0 +4373 0.5503768242921083 0.8295909368041694 0 +4374 0.8895908001284538 0.7949901540555262 0 +4375 0.1104091998714518 0.7949901540561788 0 +4376 0.5300357933614327 0.5085734678144831 0 +4377 0.5930058750112064 0.1473401049883523 0 +4378 0.5648937154855328 0.789753139041754 0 +4379 0.1921525717553448 0.1380332274773228 0 +4380 0.6037688203934459 0.6264619259630432 0 +4381 0.3573165084085756 0.6268086383554263 0 +4382 0.6793492651449903 0.3967190097693571 0 +4383 0.4100546746864584 0.543175586984796 0 +4384 0.02481889649770756 0.7408862262109449 0 +4385 0.8823497211045771 0.9407385491438378 0 +4386 0.1176502788948721 0.9407385491440795 0 +4387 0.910398456065494 0.4752131980958018 0 +4388 0.6382512685484949 0.5629308340229312 0 +4389 0.983274353118995 0.8659010068470642 0 +4390 0.01672564688104667 0.8659010068473254 0 +4391 0.80359815729717 0.6892955454444958 0 +4392 0.9613529693410883 0.9400784811749527 0 +4393 0.03864703065873431 0.9400784811752438 0 +4394 0.5465440712398143 0.1152066563339837 0 +4395 0.9530129424304521 0.2219299265352334 0 +4396 0.9376239441990601 0.8586393446916988 0 +4397 0.06237605580059076 0.858639344692042 0 +4398 0.9310885812739986 0.953167967930412 0 +4399 0.06891141872568041 0.953167967930638 0 +4400 0.4368637400556633 0.900440676107684 0 +4401 0.5263685173136283 0.6745922987678168 0 +4402 0.932969170187985 0.7289481443605363 0 +4403 0.06721887853042244 0.730926206687617 0 +4404 0.3978626110153731 0.3001717868011036 0 +4405 0.1365114717813342 0.6216478897856069 0 +4406 0.7097882301942846 0.7396670020981297 0 +4407 0.7634901223069601 0.9198848337795423 0 +4408 0.2365098776918438 0.9198848337799556 0 +4409 0.9555969088656413 0.343167279548561 0 +4410 0.073521086194719 0.6053575833081043 0 +4411 0.7408817106852263 0.9848919984122476 0 +4412 0.259118289313472 0.9848919984123321 0 +4413 0.3467405722761419 0.7215469229889513 0 +4414 0.4991594070126318 0.9562564100269246 0 +4415 0.2993212860776926 0.7699112619390476 0 +4416 0.5692511537537276 0.9280866937020332 0 +4417 0.4961243376742727 0.8008597257421526 0 +4418 0.3591880362722107 0.9569904603465522 0 +4419 0.4855167214747754 0.7111180581948667 0 +4420 0.1429375181241524 0.7195379585894548 0 +4421 0.7377233863352015 0.7806642483221269 0 +4422 0.4940638999692694 0.3833932484941977 0 +4423 0.9756477061154386 0.7395627253130794 0 +4424 0.848501248433761 0.6009274416264685 0 +4425 0.5986209570029333 0.4957019118453793 0 +4426 0.4551462373220299 0.8174222746511651 0 +4427 0.6497251240118871 0.9852841310816947 0 +4428 0.772837444919662 0.2765357722692596 0 +4429 0.8319219429830258 0.9852312018038476 0 +4430 0.1680780570161887 0.9852312018039197 0 +4431 0.9838784262275327 0.9314167121411563 0 +4432 0.01612157377246597 0.9314167121415271 0 +4433 0.7892111868021847 0.9657754207795983 0 +4434 0.2107888131967959 0.9657754207797598 0 +4435 0.8299224244287199 0.6931099927529414 0 +4436 0.03553274085104305 0.3851073447217034 0 +4437 0.3828717557928699 0.3660470602145655 0 +4438 0.8607544447388072 0.9277356076050532 0 +4439 0.1392455552605421 0.9277356076053742 0 +4440 0.5320184694095568 0.8610594270077749 0 +4441 0.9196226908645392 0.9147463999850767 0 +4442 0.0803773091351562 0.9147463999854427 0 +4443 0.4607625308949944 0.5000828750898957 0 +4444 0.4994923380289608 0.6335840511710834 0 +4445 0.8689006087936391 0.715816020847875 0 +4446 0.6549047042722501 0.9056033193793724 0 +4447 0.7367859782813511 0.3771964966871399 0 +4448 0.6793901441409342 0.8436778598440744 0 +4449 0.3204894920243718 0.845131813416279 0 +4450 0.1835536431381338 0.6506583751830796 0 +4451 0.4183302060291356 0.7974950109419057 0 +4452 0.8929287800356238 0.7556929126216591 0 +4453 0.1053229141234123 0.7550045511323797 0 +4454 0.8811536865799884 0.2109621857113673 0 +4455 0.02478730192561753 0.6877491647591362 0 +4456 0.6720622581486468 0.985675867582708 0 +4457 0.881667249253515 0.6774313806213659 0 +4458 0.885735952061109 0.3445037663599173 0 +4459 0.4819246219540796 0.9569915920145833 0 +4460 0.6059368427425051 0.9859146385147458 0 +4461 0.4218249740480245 0.7512429267474314 0 +4462 0.347991275404802 0.9852700731640898 0 +4463 0.3100790472046395 0.9623724181092579 0 +4464 0.03077689675695584 0.5815712977010579 0 +4465 0.7695755707637613 0.9836357870623891 0 +4466 0.2304244292351001 0.983635787062479 0 +4467 0.8310285978986405 0.9520822175565333 0 +4468 0.1689714021005676 0.9520822175567816 0 +4469 0.7232264259265574 0.1493028537238696 0 +4470 0.3337784025460912 0.6922721991271411 0 +4471 0.4010649640659603 0.7630875734780288 0 +4472 0.3335750069720571 0.8977851369565717 0 +4473 0.320151516785479 0.4166539826071847 0 +4474 0.04525146285377688 0.1285307964486906 0 +4475 0.7029506534282881 0.9187611718790711 0 +4476 0.2970493465702106 0.9187611718794991 0 +4477 0.577458411552247 0.4650794872317074 0 +4478 0.7772780608337554 0.5637406236661064 0 +4479 0.6274458713373718 0.294737887195841 0 +4480 0.3402308032768444 0.9583271934154453 0 +4481 0.9655372861193436 0.4114729141677723 0 +4482 0.6048178866894602 0.754874035520825 0 +4483 0.2649953211046795 0.7854024814047691 0 +4484 0.5633763085672839 0.7581249308719005 0 +4485 0.6663946055386091 0.692684598080342 0 +4486 0.6898119723667749 0.9623822172674116 0 +4487 0.6633144207879084 0.2044185710599025 0 +4488 0.8915783682334831 0.9150835949353375 0 +4489 0.1084216317660134 0.9150835949356887 0 +4490 0.5656089150251524 0.3000870950981298 0 +4491 0.5240067500661805 0.7672921248304236 0 +4492 0.5880271998280873 0.9171836962947247 0 +4493 0.4418618076910997 0.766331950247692 0 +4494 0.8172304924097237 0.1443674750316388 0 +4495 0.5884288835025486 0.6603790974821879 0 +4496 0.1002129555984499 0.3779090475430751 0 +4497 0.4575145703654934 0.9403124906981405 0 +4498 0.870179726730081 0.5470319090912135 0 +4499 0.4696374371038621 0.7492340541591153 0 +4500 0.673769236679059 0.7707740597298745 0 +4501 0.5318576114014157 0.8986761314127332 0 +4502 0.5218613209853941 0.6181098395527759 0 +4503 0.1974524171120151 0.4282689812763747 0 +4504 0.4017515156303268 0.7851060138691734 0 +4505 0.04780323507972768 0.05487422002550797 0 +4506 0.4114716683571265 0.8655213683461609 0 +4507 0.7910539450715225 0.912265047637396 0 +4508 0.2089460549274409 0.9122650476378141 0 +4509 0.45455549125573 0.3061929954949973 0 +4510 0.955744098942764 0.9128874289312698 0 +4511 0.04425590105702777 0.9128874289316753 0 +4512 0.5651286167332699 0.8948699796928105 0 +4513 0.878761267586768 0.5892746125547498 0 +4514 0.1251918291821691 0.6675057899906389 0 +4515 0.4682984991708331 0.05055942938849233 0 +4516 0.8094355736479262 0.7797749969701746 0 +4517 0.1885456046065702 0.7789615847900669 0 +4518 0.4338480018221658 0.986550330973456 0 +4519 0.1051969979247443 0.3025397346545027 0 +4520 0.6145913437833852 0.937200431935502 0 +4521 0.8941486672735088 0.2960100276686933 0 +4522 0.7621025870996359 0.8701676938050237 0 +4523 0.2378974128992097 0.8701676938056849 0 +4524 0.6491833491120912 0.8691898579101669 0 +4525 0.7764985243626041 0.7581235582925057 0 +4526 0.9600903262589857 0.3059469331223119 0 +4527 0.8714236141350642 0.8705709423447079 0 +4528 0.1285763858643948 0.8705709423453192 0 +4529 0.3549997451643404 0.8687730289245701 0 +4530 0.6130778212997431 0.8929830465773411 0 +4531 0.4057401835730334 0.5876591652920559 0 +4532 0.9190243706037935 0.7559928109199173 0 +4533 0.07969592902632916 0.7570260689636483 0 +4534 0.268702415266308 0.5334974601228191 0 +4535 0.6231628467544305 0.2280738463357483 0 +4536 0.6148255008929835 0.3646583908409751 0 +4537 0.3327181895470448 0.3533069664297089 0 +4538 0.9315597177054287 0.9349740308664207 0 +4539 0.06844028229425707 0.9349740308667263 0 +4540 0.7023863291171075 0.7747467373391873 0 +4541 0.767563421434027 0.04335424820394286 0 +4542 0.1923738814054475 0.05048551798667247 0 +4543 0.2601403702200449 0.718238224122644 0 +4544 0.4524304607593893 0.6542358273700979 0 +4545 0.6684396524880638 0.8959450415307103 0 +4546 0.7423766989101752 0.3131965571740003 0 +4547 0.8025376525927528 0.8044176377594576 0 +4548 0.1973709869909074 0.8043688949906381 0 +4549 0.5514882302802985 0.6297953184120207 0 +4550 0.6025963756044175 0.8247121502737602 0 +4551 0.3928311769916887 0.9655965867857617 0 +4552 0.3819947944702387 0.7511370645146794 0 +4553 0.6218994549638804 0.9867217772533503 0 +4554 0.1067019149185636 0.05008365196551715 0 +4555 0.7448933133641312 0.9692132325529367 0 +4556 0.2551066866345851 0.9692132325531059 0 +4557 0.7049906672730077 0.2362403419329754 0 +4558 0.09229352345904224 0.6459327625225481 0 +4559 0.7188993472467858 0.9657002055969738 0 +4560 0.281093764314615 0.9656842186376928 0 +4561 0.4031792880669763 0.6409170383114769 0 +4562 0.4606803108629366 0.8998680736464936 0 +4563 0.4144422508924542 0.6721841764260461 0 +4564 0.5072947509921949 0.8396711887019627 0 +4565 0.2031565039787224 0.2282659276279122 0 +4566 0.730299327131943 0.9354447150784463 0 +4567 0.2697006728666984 0.9354447150787927 0 +4568 0.736110509560569 0.4207020054368987 0 +4569 0.714874794388057 0.6329404695623139 0 +4570 0.1919318159283765 0.3130196081427881 0 +4571 0.8011639175620224 0.6536288128406776 0 +4572 0.7789131635887725 0.8923394662573898 0 +4573 0.2210868364101498 0.8923394662579125 0 +4574 0.6522519173120341 0.6415391168732191 0 +4575 0.3256457593821224 0.9687195795588424 0 +4576 0.704293724296881 0.6980033347395105 0 +4577 0.7626264473571067 0.9665297123582485 0 +4578 0.2373735526417199 0.9665297123584335 0 +4579 0.2567150268995104 0.7615333333404951 0 +4580 0.2344645676509308 0.2949113594955596 0 +4581 0.6895207255428494 0.5180353900545109 0 +4582 0.4477248849025197 0.5511916270674926 0 +4583 0.458512750639854 0.09976236982341606 0 +4584 0.4381236946706226 0.2366187113686198 0 +4585 0.4703157961268539 0.6192038404373763 0 +4586 0.2188710135633744 0.4566059262066102 0 +4587 0.4485772014173951 0.1691320569358384 0 +4588 0.5009078481490166 0.2484561439201259 0 +4589 0.3010730508605822 0.695893693097698 0 +4590 0.5461573224448751 0.9512366431236191 0 +4591 0.817588029087444 0.7393026443411698 0 +4592 0.8035574359172624 0.9390239340707808 0 +4593 0.1964425640817874 0.9390239340710785 0 +4594 0.05377553902574608 0.6962102147243189 0 +4595 0.3575446973412431 0.6718384418780827 0 +4596 0.3936506552509297 0.8234267869553715 0 +4597 0.2019640801178211 0.7187358848503024 0 +4598 0.5980960474222152 0.7841559973351409 0 +4599 0.2000091004688817 0.6753463507162136 0 +4600 0.4946847496913059 0.9864622573437717 0 +4601 0.6981958160668515 0.8296921636075698 0 +4602 0.7250150708036874 0.9859629153449846 0 +4603 0.2749849291949257 0.9859629153450645 0 +4604 0.07941762321906853 0.4861383029383231 0 +4605 0.9644133904028225 0.9543010805490126 0 +4606 0.03558660959703946 0.9543010805492369 0 +4607 0.8461682838489979 0.9172448967858231 0 +4608 0.1538317161502788 0.9172448967862012 0 +4609 0.6583659327926346 0.9270635972431075 0 +4610 0.4429428010036467 0.8330283988417559 0 +4611 0.1888064620639478 0.4945501051057486 0 +4612 0.6631198990868146 0.8267140111677714 0 +4613 0.1840426968084858 0.7398133751899683 0 +4614 0.6335251775883236 0.1202161583586886 0 +4615 0.3367450146974876 0.826951304483424 0 +4616 0.616428729744779 0.04644741922359286 0 +4617 0.7733635198042366 0.6458078120245725 0 +4618 0.7211984903358652 0.8820832976046572 0 +4619 0.2788015096627712 0.8820832976052714 0 +4620 0.4791534119443885 0.787578150364989 0 +4621 0.162536170231705 0.3735201396869742 0 +4622 0.4309681104357922 0.9548491726490913 0 +4623 0.9376731744549708 0.966396171876972 0 +4624 0.06232682554474425 0.9663961718771367 0 +4625 0.1696840762533181 0.176595857913435 0 +4626 0.3709442894793484 0.2431212833787154 0 +4627 0.8045832888637388 0.989374059602862 0 +4628 0.1954167111353216 0.9893740596029115 0 +4629 0.7944195507668462 0.8800493777629592 0 +4630 0.2055804492321648 0.8800493777635386 0 +4631 0.2118768661757405 0.541004832766492 0 +4632 0.9337206777816904 0.6190329004581647 0 +4633 0.3233376376651838 0.5578462939970079 0 +4634 0.5139802863288074 0.9694212852097804 0 +4635 0.1656291894651775 0.6956296088971279 0 +4636 0.4871582255075413 0.9260467105996614 0 +4637 0.08785490363086111 0.5806506545499504 0 +4638 0.4894000631092195 0.5764959551055086 0 +4639 0.1976614433930418 0.7617886042226099 0 +4640 0.3029328830809087 0.8365365813296465 0 +4641 0.7688121921477635 0.7755390215497001 0 +4642 0.6737545422116287 0.9672155947472447 0 +4643 0.267394030215762 0.6288909262158033 0 +4644 0.6064630045692776 0.9657102705349869 0 +4645 0.6398808037930525 0.9493605958438921 0 +4646 0.3125833889387641 0.10839828534683 0 +4647 0.9443246291098051 0.8213818853687735 0 +4648 0.0556753708902047 0.8213818853691165 0 +4649 0.8515242230834098 0.8419582861881788 0 +4650 0.1484757769158916 0.841958286188924 0 +4651 0.5717865089234286 0.9531005438444464 0 +4652 0.2426695765718246 0.04826575958911149 0 +4653 0.4734524130993858 0.9418956252865138 0 +4654 0.4897820688570365 0.8280755129462247 0 +4655 0.09882246878988105 0.1339258624876183 0 +4656 0.03634324117345915 0.3184878662393518 0 +4657 0.3737585788213664 0.9700197811360203 0 +4658 0.6829676893902019 0.7370922600338261 0 +4659 0.04077267648994397 0.2630329368382108 0 +4660 0.343616855403062 0.6031794897426037 0 +4661 0.5813878641110238 0.8001235296171295 0 +4662 0.5864782415471743 0.5751817370522 0 +4663 0.7609643196880868 0.9426518533527931 0 +4664 0.239035680310721 0.9426518533531025 0 +4665 0.5422980710746017 0.7202354270875634 0 +4666 0.1764786830590726 0.6051687894537738 0 +4667 0.890843946629132 0.8562218752622501 0 +4668 0.1091560533704969 0.8562218752628983 0 +4669 0.8877760725127395 0.728646069155289 0 +4670 0.4479592964604158 0.9277338408656963 0 +4671 0.6278304184349093 0.9703980071566377 0 +4672 0.8217129226401849 0.861886585195078 0 +4673 0.1782870773589861 0.8618865851957012 0 +4674 0.0922954587565132 0.7146573383997523 0 +4675 0.6452412588685267 0.7572654487724414 0 +4676 0.2186900212288417 0.3669804641294163 0 +4677 0.6243541570411193 0.4339104362760116 0 +4678 0.83777548351273 0.5839086172065586 0 +4679 0.3455099528682801 0.9091510094998272 0 +4680 0.383703095754286 0.9451462378648988 0 +4681 0.3212793524608306 0.6503362796174167 0 +4682 0.4004672814002893 0.9384855423848155 0 +4683 0.5519806990747315 0.8021602196877113 0 +4684 0.7788397127860316 0.9217230683022447 0 +4685 0.221160287212863 0.9217230683026205 0 +4686 0.3457546923314817 0.9310873864003271 0 +4687 0.5722852877663713 0.8598796120811396 0 +4688 0.6874945940947382 0.3638331845871921 0 +4689 0.5090506451233625 0.8784735388166433 0 +4690 0.5479808399402115 0.5375866836472826 0 +4691 0.5219087240804288 0.8236005122856793 0 +4692 0.5425099358730595 0.9300225465712653 0 +4693 0.4907260774864399 0.9040897167538066 0 +4694 0.9005109503369915 0.5326836724779357 0 +4695 0.983269406890333 0.8220426412891244 0 +4696 0.01673059310975603 0.8220426412890948 0 +4697 0.4754761064838336 0.5276316190376414 0 +4698 0.3903250466780014 0.889951621884964 0 +4699 0.9506880020002371 0.9306407753960131 0 +4700 0.04931199799953104 0.9306407753963561 0 +4701 0.3018522923177177 0.3888463629861081 0 +4702 0.3839839453798468 0.03665051767711594 0 +4703 0.8883539441947487 0.9872728831254562 0 +4704 0.1116460558047455 0.9872728831255082 0 +4705 0.286330095349761 0.5822026134988346 0 +4706 0.5393782117661581 0.7521160984954444 0 +4707 0.208811572854605 0.5924179073997022 0 +4708 0.7939853943914685 0.7235596100738861 0 +4709 0.2210470374894082 0.7594670820354784 0 +4710 0.03603616253243968 0.1880924726119536 0 +4711 0.3036796513565139 0.5220898252418664 0 +4712 0.5154613282918912 0.9883354811796519 0 +4713 0.6421464707708889 0.9341440850859943 0 +4714 0.117452466995229 0.5507304602602908 0 +4715 0.6667936216912146 0.4601533587484602 0 +4716 0.5531844556502952 0.3985222892166186 0 +4717 0.3168893924154402 0.9428790527534245 0 +4718 0.5204551633336221 0.9264992532641136 0 +4719 0.3022006552686977 0.6212168087779859 0 +4720 0.9152424296816811 0.2344292618557473 0 +4721 0.3760773062836893 0.9878999879005104 0 +4722 0.7837266766510144 0.9432940125264874 0 +4723 0.2162733233479274 0.9432940125267799 0 +4724 0.4076799512619956 0.4437178662111513 0 +4725 0.4975859594470461 0.4761749825917119 0 +4726 0.324463251956238 0.04499581125375135 0 +4727 0.4146976236798355 0.7246908303003929 0 +4728 0.9538862700152066 0.04633049007705144 0 +4729 0.3774636998957664 0.8716225704949093 0 +4730 0.9583353223241859 0.1653748879855031 0 +4731 0.9015805130137894 0.9862109090065347 0 +4732 0.09841948698576823 0.9862109090065951 0 +4733 0.414401146771723 0.8157852015133236 0 +4734 0.9203846424827297 0.8262823021023205 0 +4735 0.07961535751721931 0.8262823021027366 0 +4736 0.9061103537776959 0.1512129276506391 0 +4737 0.318637931874537 0.7309484800611064 0 +4738 0.9757102624061534 0.6070918659185583 0 +4739 0.2601411949091204 0.4320170794257248 0 +4740 0.7029467824269312 0.666954002396377 0 +4741 0.8715399292135444 0.9537452019357051 0 +4742 0.1284600707858677 0.9537452019359143 0 +4743 0.03660690144360458 0.4699482155651072 0 +4744 0.02115234061974883 0.6692755019580447 0 +4745 0.9392678820399233 0.6857310314867427 0 +4746 0.3739279011555624 0.4088167583692774 0 +4747 0.9530437810158608 0.9878883726563873 0 +4748 0.04695621898392399 0.987888372656445 0 +4749 0.8383715861939796 0.9651150884316164 0 +4750 0.1616284138052659 0.9651150884317923 0 +4751 0.9041974549634386 0.9435387285717887 0 +4752 0.09580254503611618 0.9435387285720216 0 +4753 0.4729540853753477 0.9707305604282104 0 +4754 0.7447637073575042 0.6046028284871913 0 +4755 0.5903072527419406 0.8809361827323285 0 +4756 0.7067970866651814 0.8649089851688362 0 +4757 0.2930248105820971 0.8667797075364094 0 +4758 0.1668991986014853 0.2583439151100742 0 +4759 0.1159014052448029 0.4208624844767714 0 +4760 0.8423494568515422 0.7131331252418645 0 +4761 0.7506363308139662 0.1986024027847505 0 +4762 0.6992252775687888 0.6117943730113155 0 +4763 0.5680277529825999 0.7009693496938558 0 +4764 0.1847974711280001 0.7018055607606748 0 +4765 0.4586745832089438 0.9857874070075663 0 +4766 0.7069727181665433 0.4806830738716628 0 +4767 0.3229818500318972 0.9870453585554235 0 +4768 0.7263537345733269 0.5370698933246615 0 +4769 0.2522338917591772 0.6037235717123212 0 +4770 0.3706660890842341 0.590267948045446 0 +4771 0.8532324282846449 0.8967909500031076 0 +4772 0.1467675717146815 0.8967909500035701 0 +4773 0.7720480490902275 0.09989864346685573 0 +4774 0.9502876830119171 0.705325885770417 0 +4775 0.462039299277943 0.8767269808360537 0 +4776 0.1838676898238972 0.1058650212504526 0 +4777 0.9717567890806549 0.09477842776969694 0 +4778 0.9874823599908193 0.918832877969032 0 +4779 0.01251764000922085 0.918832877969071 0 +4780 0.6426485491875844 0.7952646019017354 0 +4781 0.3898005155208747 0.1084151561917851 0 +4782 0.9701357849872999 0.4739650487699505 0 +4783 0.0977519534936709 0.5245453271723145 0 +4784 0.9071216418035936 0.917995343198596 0 +4785 0.09287835819602877 0.917995343198915 0 +4786 0.6464134764729039 0.9714459192604341 0 +4787 0.2634062269380283 0.3349741214895251 0 +4788 0.5453065797168508 0.849228923250815 0 +4789 0.3243487085257435 0.2162313851964586 0 +4790 0.7004522986424968 0.3086582563520808 0 +4791 0.6904468816706001 0.9166571339239435 0 +4792 0.3094264538322506 0.9173364158356385 0 +4793 0.5351297449746113 0.9897865846011558 0 +4794 0.4591462733673363 0.7986743435425099 0 +4795 0.46624237337618 0.3514937657393399 0 +4796 0.4498796212907062 0.9491382590605051 0 +4797 0.3948725543899022 0.9894898432300012 0 +4798 0.08416083710533308 0.3291235883042632 0 +4799 0.6434825029665128 0.4017990504140753 0 +4800 0.9132336404005781 0.712345722184566 0 +4801 0.154011185808148 0.5336151742399392 0 +4802 0.3184332630961052 0.4709599927192966 0 +4803 0.1755076067365019 0.5517458006067848 0 +4804 0.6817007472810082 0.9450435357394182 0 +4805 0.8249884979852271 0.9109757754319345 0 +4806 0.1750115020139618 0.9109757754323851 0 +4807 0.8415933286254386 0.7524374246490647 0 +4808 0.7577450468202758 0.7184948859545455 0 +4809 0.8947739750908076 0.8936729836457905 0 +4810 0.1052260249087004 0.8936729836461729 0 +4811 0.6932236066475181 0.03473555838166742 0 +4812 0.5234212839220425 0.7867992677044451 0 +4813 0.8547459436581936 0.9650644923130818 0 +4814 0.1452540563411435 0.9650644923132412 0 +4815 0.97870877781248 0.6998854029806129 0 +4816 0.1558351086076337 0.4607026532243549 0 +4817 0.6989510646762392 0.8971903548871293 0 +4818 0.3010679240579274 0.8972323457263673 0 +4819 0.7013210049668487 0.9366044382436403 0 +4820 0.2986789950316359 0.9366044382439699 0 +4821 0.2266617024085076 0.7300499024592004 0 +4822 0.753107886442509 0.5729437332047816 0 +4823 0.6579763470566573 0.5041898843185321 0 +4824 0.8534118492987305 0.2359225900825024 0 +4825 0.08787294656800879 0.2120803019339342 0 +4826 0.2566664254068449 0.1780281697207023 0 +4827 0.8610660654085907 0.9569944779369624 0 +4828 0.1389339345907797 0.9569944779371602 0 +4829 0.5168416413228664 0.8957043087359037 0 +4830 0.6849406413491419 0.9919741862487816 0 +4831 0.7369806690829535 0.7154714355237344 0 +4832 0.6352713520513373 0.3361783905295457 0 +4833 0.6631799426860425 0.8755872493841583 0 +4834 0.3343288417891963 0.8757371426646688 0 +4835 0.9212291821833167 0.4057688694454099 0 +4836 0.864533335745074 0.1749122852578967 0 +4837 0.8336401401452128 0.9351325024402659 0 +4838 0.1663598598539914 0.9351325024405801 0 +4839 0.9105719078738415 0.6933988211279581 0 +4840 0.1424700919425121 0.3244341106681659 0 +4841 0.3581436736382321 0.796085658259623 0 +4842 0.9866134916948113 0.8930276506698603 0 +4843 0.01338650830528441 0.8930276506700876 0 +4844 0.8854192215159641 0.4876464359684089 0 +4845 0.5112520014175465 0.7590561206453793 0 +4846 0.6739313214184883 0.5969003856142566 0 +4847 0.3962959242549647 0.1634103260995631 0 +4848 0.8418447288494723 0.6762392938320727 0 +4849 0.9812569543096901 0.7848086677942459 0 +4850 0.01881372307979026 0.784729680474942 0 +4851 0.5137882628568271 0.3448366643845642 0 +4852 0.6887412027995981 0.2799340431496175 0 +4853 0.3622576993715632 0.5558428502585545 0 +4854 0.8056540770659428 0.2255853336345931 0 +4855 0.7189541380423627 0.8983786304157029 0 +4856 0.2810458619562458 0.8983786304162266 0 +4857 0.4071422309509173 0.9066984365929293 0 +4858 0.3794908868929149 0.815528868683733 0 +4859 0.3906917424510144 0.9182645475537514 0 +4860 0.7643327580337487 0.8396289482675536 0 +4861 0.2356672419650704 0.8396289482683506 0 +4862 0.594179502331774 0.9422974148993919 0 +4863 0.2381319771190976 0.6541169956965004 0 +4864 0.04976822784603793 0.6470641056222776 0 +4865 0.2696311499596786 0.2655317962671416 0 +4866 0.6855808341411013 0.4264429487141561 0 +4867 0.2792984786222473 0.4855304016234051 0 +4868 0.8653692909073772 0.8937983944388876 0 +4869 0.1346307090919995 0.8937983944393508 0 +4870 0.4646445080823403 0.9171635523180393 0 +4871 0.3390732559792228 0.1653333860733532 0 +4872 0.8818116651006314 0.09635827041908013 0 +4873 0.0710724602790857 0.2589720601952441 0 +4874 0.9669330412288966 0.8970193946804021 0 +4875 0.03306695877102058 0.897019394680634 0 +4876 0.8581159660750072 0.4888105791675406 0 +4877 0.343137009468495 0.4136362236236475 0 +4878 0.4300069976316885 0.9407615544179262 0 +4879 0.92183722061317 0.3566452204022475 0 +4880 0.5411570884081236 0.8832889544571457 0 +4881 0.3804137415704192 0.8985971720481861 0 +4882 0.5884998556684197 0.8189499213621407 0 +4883 0.6210106433351182 0.7201595945534632 0 +4884 0.9392482389685999 0.8913670476919378 0 +4885 0.06075176103109051 0.8913670476923846 0 +4886 0.5973277905118165 0.4385653140347797 0 +4887 0.6437692556791206 0.5921337346343518 0 +4888 0.580827871199326 0.8463249746306249 0 +4889 0.0207555340205806 0.5614069667224633 0 +4890 0.5676780410388665 0.5864898067351718 0 +4891 0.409165948070006 0.9508379929917182 0 +4892 0.9120701699761391 0.8688189869949596 0 +4893 0.0879298300234842 0.8688189869954061 0 +4894 0.8216741780674429 0.6430362163340165 0 +4895 0.9567557391353608 0.8142238572030772 0 +4896 0.04324426086468629 0.814223857203475 0 +4897 0.8452598851269453 0.9919788388723468 0 +4898 0.1547401148723363 0.9919788388723856 0 +4899 0.3012535695097676 0.7270220639585969 0 +4900 0.08519945312496757 0.6879541386102408 0 +4901 0.1212305375370554 0.6058311120064905 0 +4902 0.6798516998739077 0.8621277019237192 0 +4903 0.5063825376103249 0.7303727346379085 0 +4904 0.5173529196371808 0.8098411763964857 0 +4905 0.319858397357064 0.8614580706638379 0 +4906 0.5831218997312944 0.1823005388706544 0 +4907 0.5844274985768679 0.9257511830330689 0 +4908 0.4329034356593415 0.9135254494244904 0 +4909 0.9882447928851326 0.9515333211752529 0 +4910 0.01175520711475586 0.9515333211753346 0 +4911 0.7614647789325117 0.9072063927657334 0 +4912 0.2385352210663179 0.9072063927662035 0 +4913 0.6555658412948502 0.1712422902539469 0 +4914 0.2269349892538937 0.7851895024128966 0 +4915 0.2689394213876476 0.1062987817639553 0 +4916 0.7741688335458601 0.6170553067630911 0 +4917 0.8504232472537413 0.868568429519886 0 +4918 0.1495767527456071 0.8685684295205204 0 +4919 0.5553371157468618 0.9668903932523448 0 +4920 0.9504543417442475 0.7792295477871676 0 +4921 0.04955584242121347 0.7792065792234086 0 +4922 0.6390229153025938 0.8868952957083898 0 +4923 0.4393717364242948 0.6384980245982943 0 +4924 0.792000395902256 0.5886133219622913 0 +4925 0.8381583179030774 0.4219285671945029 0 +4926 0.9593761323240499 0.8843205818270767 0 +4927 0.04062386767575279 0.8843205818274329 0 +4928 0.5562683127146044 0.8834025456384866 0 +4929 0.8244651952184097 0.29510496941279 0 +4930 0.4270495583709386 0.6016844574337572 0 +4931 0.7709771901304896 0.691126737716119 0 +4932 0.6740535670200983 0.6627558843658486 0 +4933 0.7935021997556228 0.8408471559206453 0 +4934 0.2064978002433695 0.8408471559214012 0 +4935 0.5016369650488244 0.9700546122985526 0 +4936 0.5181429392166683 0.9452174919567924 0 +4937 0.5617586118445117 0.3533195127368686 0 +4938 0.9391004011153563 0.9037031976277033 0 +4939 0.06089959888436425 0.903703197628116 0 +4940 0.3612740057620218 0.9704312148077653 0 +4941 0.9357428002652518 0.5218856282729798 0 +4942 0.6289323365825634 0.8162332087032099 0 +4943 0.6636577287111055 0.8422217773575574 0 +4944 0.8389930540837744 0.3486254496723106 0 +4945 0.5521091244585765 0.4716962774820758 0 +4946 0.0160768216810224 0.7567231012665407 0 +4947 0.5327758515931108 0.9693305123988698 0 +4948 0.06140322785685506 0.55434875509074 0 +4949 0.5949999999989318 0.9896743306675176 0 +4950 0.8526507761503672 0.9459727691155227 0 +4951 0.1473492238489647 0.9459727691157815 0 +4952 0.6059897866569937 0.648221616418463 0 +4953 0.1147971940073089 0.7334704318800198 0 +4954 0.5583796942184404 0.9064835979423049 0 +4955 0.3363217241385607 0.842436546283304 0 +4956 0.03850236423959316 0.09223241709515365 0 +4957 0.423912494962583 0.3739676787543106 0 +4958 0.122613343865234 0.6948602717497976 0 +4959 0.01739095052503276 0.7240122910365234 0 +4960 0.6596385946464987 0.9884823983635385 0 +4961 0.891609952070811 0.6351941172933716 0 +4962 0.9701233425486937 0.3855839624186008 0 +4963 0.6608684790487522 0.7237568407611457 0 +4964 0.8506599925225098 0.2774471178430595 0 +4965 0.9575392037037951 0.9719460787129743 0 +4966 0.04246079629601784 0.9719460787131006 0 +4967 0.4165234454691434 0.9685284732413898 0 +4968 0.6126997242297176 0.918753344013894 0 +4969 0.9243124297470835 0.9450027394415761 0 +4970 0.07568757025256428 0.9450027394418223 0 +4971 0.469412428443719 0.9873305421820943 0 +4972 0.9206785601418177 0.9883261835303713 0 +4973 0.07932143985782412 0.9883261835304251 0 +4974 0.8120596512818863 0.9716240029911875 0 +4975 0.1879403487172224 0.9716240029913346 0 +4976 0.770818961999802 0.5407847038476805 0 +4977 0.6780513723973082 0.556559581606751 0 +4978 0.8978800267028546 0.9650858097316245 0 +4979 0.1021199732966838 0.9650858097317708 0 +4980 0.2814583273623882 0.6605158687020138 0 +4981 0.6976630200450493 0.7251208411348475 0 +4982 0.9840376089994251 0.7566061775203701 0 +4983 0.2858278448269874 0.7508807873504714 0 +4984 0.4967057804983742 0.5403417806675415 0 +4985 0.0502412847724172 0.7290836029317831 0 +4986 0.4619733789950513 0.6833897821083876 0 +4987 0.1265196311941812 0.1052868787407596 0 +4988 0.5078650324906274 0.920853151620471 0 +4989 0.6384852374803074 0.9066750780921067 0 +4990 0.7364731746683442 0.9634558221396033 0 +4991 0.26352682533033 0.9634558221398006 0 +4992 0.6891160658765612 0.095586999814881 0 +4993 0.5037471252528016 0.03896728383413605 0 +4994 0.7409006006397647 0.1146974479522675 0 +4995 0.5846151771762893 0.4074213038568516 0 +4996 0.4356922089734407 0.2825480949955279 0 +4997 0.5657721700122448 0.6792269593696305 0 +4998 0.3290380934332648 0.7877825393167952 0 +4999 0.6008386672399046 0.5294596771608022 0 +5000 0.8349443019474909 0.1155078734206416 0 +5001 0.5023860274722214 0.4469952352949974 0 +5002 0.2703961986714706 0.7021330932908022 0 +5003 0.8131925906621872 0.5408623304963612 0 +5004 0.1297273817789141 0.3724489656835632 0 +5005 0.4246599612086099 0.892802538746626 0 +5006 0.7763100154696981 0.8175158354587705 0 +5007 0.224388566535772 0.8143499829202114 0 +5008 0.7387215804611236 0.8599480188863123 0 +5009 0.2612784195375815 0.8599480188870301 0 +5010 0.8738488187496469 0.9103083738585536 0 +5011 0.1261511812497844 0.9103083738589435 0 +5012 0.7640515782274189 0.9545568547767385 0 +5013 0.2359484217714112 0.9545568547769883 0 +5014 0.831373130403257 0.558973945333673 0 +5015 0.8680757780772883 0.7609818948504242 0 +5016 0.1294638476459006 0.7621854941318609 0 +5017 0.3110613243373024 0.9887124541688382 0 +5018 0.9220427250238703 0.8606626323998143 0 +5019 0.07795727497578882 0.8606626324000337 0 +5020 0.9417861678840085 0.9882404659601929 0 +5021 0.05821383211572397 0.9882404659602515 0 +5022 0.9508270654451244 0.6682004222911797 0 +5023 0.3576787744724399 0.880599975592869 0 +5024 0.539802939757584 0.559770182072023 0 +5025 0.9510671300938625 0.7283624091990097 0 +5026 0.3640675996448079 0.7801075237679895 0 +5027 0.7261385643689831 0.9048692713818269 0 +5028 0.2738614356296784 0.904869271382306 0 +5029 0.6894460039748181 0.8872028865297157 0 +5030 0.9767714993954091 0.5425049972617094 0 +5031 0.9890027316946549 0.989000540458386 0 +5032 0.01099726830529886 0.9890005404584415 0 +5033 0.2625865754587793 0.6781752340475971 0 +5034 0.6179101965904941 0.9044299794826774 0 +5035 0.8132547235347167 0.9300743709896309 0 +5036 0.1867452764643688 0.9300743709899744 0 +5037 0.524406284522958 0.6934598319220648 0 +5038 0.3782615092491156 0.6349084305757908 0 +5039 0.6626652689566008 0.9506616219228358 0 +5040 0.6357162801957256 0.7785853647002019 0 +5041 0.8079114243299492 0.4258195863764619 0 +5042 0.310669965047068 0.8874551173656591 0 +5043 0.5549999999988277 0.9901655800605581 0 +5044 0.4959856217483723 0.9347314385464558 0 +5045 0.8299251139348738 0.8494739936103051 0 +5046 0.1700748860643388 0.8494739936109762 0 +5047 0.9081341703779142 0.04199459703658354 0 +5048 0.4142142758511766 0.9901135727327277 0 +5049 0.6378346716925686 0.2716722621385447 0 +5050 0.3673172576599544 0.9254441912547576 0 +5051 0.341527304482369 0.7627282999896445 0 +5052 0.4572721953121752 0.4155414208131247 0 +5053 0.5079572227263804 0.9500590199160572 0 +5054 0.2376816224658554 0.5742879074884594 0 +5055 0.9745244879306684 0.9902246194537165 0 +5056 0.02547551206921556 0.9902246194537441 0 +5057 0.6470587007778921 0.8555032461852675 0 +5058 0.5673889778672723 0.9406226592572706 0 +5059 0.6337581749228091 0.8463703739453378 0 +5060 0.5680323270783914 0.619191751873434 0 +5061 0.3538035277627635 0.8554430117307273 0 +5062 0.9014051075500746 0.6745583420229271 0 +5063 0.362466098917026 0.5049490863164018 0 +5064 0.3032603398106136 0.2865897644662442 0 +5065 0.1668815528163587 0.4039936364586142 0 +5066 0.1149500146128309 0.2772232090223813 0 +5067 0.1038851676812076 0.4651185606369614 0 +5068 0.4167324326882833 0.9260644692142805 0 +5069 0.7260181865851827 0.8040003642686325 0 +5070 0.3667160608091209 0.8457082816651672 0 +5071 0.3375061969047695 0.9705560191777511 0 +5072 0.7709624176420664 0.860802271390925 0 +5073 0.2290375823568365 0.8608022713916104 0 +5074 0.3960363219438788 0.3418465616041335 0 +5075 0.8119044025164397 0.6225464764590295 0 +5076 0.7444478833547234 0.6530663121773012 0 +5077 0.9900870695089854 0.9740975766235083 0 +5078 0.009912930491006593 0.9740975766234434 0 +5079 0.6376626905082672 0.5421582446319432 0 +5080 0.882375713780329 0.4401770692029364 0 +5081 0.4233996334594649 0.501888588002483 0 +5082 0.5428061534853096 0.81528977011626 0 +5083 0.8418724173188554 0.4677704237995647 0 +5084 0.4991339399869228 0.1840936993494534 0 +5085 0.8145705633159045 0.4724900903893299 0 +5086 0.8794684170086874 0.8824090096761323 0 +5087 0.1205315829908034 0.882409009676679 0 +5088 0.8050354954308878 0.4975883164856864 0 +5089 0.539473507225385 0.9071666360462252 0 +5090 0.361841210997004 0.4619573963603034 0 +5091 0.6331763645938775 0.6755800527522283 0 +5092 0.3859019818705427 0.5452656141405366 0 +5093 0.7404097078117062 0.749567729670761 0 +5094 0.02426725050262713 0.5169077631239762 0 +5095 0.7350939361304537 0.2515185926560914 0 +5096 0.6944706543320254 0.8731269822252588 0 +5097 0.7549999999993506 0.9903290090863985 0 +5098 0.2449999999994267 0.9903290090864517 0 +5099 0.3049534398688937 0.8734395338209101 0 +5100 0.935015700045758 0.4650474016749379 0 +5101 0.9681883080967127 0.496159786458995 0 +5102 0.7574164732983483 0.9304000256103756 0 +5103 0.2425835267004221 0.9304000256107443 0 +5104 0.6679466562036168 0.7865025630812479 0 +5105 0.8676661591069351 0.8445424800436135 0 +5106 0.1323338408925055 0.8445424800443757 0 +5107 0.3965123040782078 0.9774344107467947 0 +5108 0.4633280914129501 0.9659574602560177 0 +5109 0.7434656305206264 0.8237742245075967 0 +5110 0.2564873184514615 0.8238014769213915 0 +5111 0.9875230391491112 0.877410239057554 0 +5112 0.01247696085091714 0.8774102390575679 0 +5113 0.9344352611065331 0.7862586582770836 0 +5114 0.06556643625437983 0.7862548301835087 0 +5115 0.07285218411704038 0.3743053252397239 0 +5116 0.5690688878614443 0.9884829867286287 0 +5117 0.918905279245612 0.6006463948797403 0 +5118 0.4884531609779322 0.8842874628335226 0 +5119 0.9385202869210686 0.426289076893779 0 +5120 0.3158454751715092 0.8108558668298599 0 +5121 0.2342772624585029 0.6977847790370839 0 +5122 0.1375560793509955 0.2412083549386412 0 +5123 0.8449277634710357 0.5122831048780057 0 +5124 0.3046490019366623 0.9736185977841556 0 +5125 0.4752514563070881 0.8493880381711767 0 +5126 0.8542636486616962 0.6358716960267065 0 +5127 0.159698607478097 0.6789674547320546 0 +5128 0.643179236437199 0.4570935370095192 0 +5129 0.9144916963961325 0.894988459585855 0 +5130 0.08550830360344575 0.8949884595862676 0 +5131 0.9794660158838493 0.6753535209176129 0 +5132 0.8759631735047175 0.8567867564461413 0 +5133 0.1240368264947878 0.8567867564468286 0 +5134 0.1065252412336773 0.6639520236739958 0 +5135 0.2729260486338548 0.8062375519545395 0 +5136 0.8247815631215808 0.873716394453576 0 +5137 0.1752184368776253 0.8737163944541487 0 +5138 0.1897958296536132 0.3628880831336247 0 +5139 0.2499765241256236 0.7778883417090875 0 +5140 0.4071588647271394 0.8786305850592516 0 +5141 0.9128290240514687 0.841612734318911 0 +5142 0.08717097594838139 0.8416127343193748 0 +5143 0.02021287514756727 0.6235310925027717 0 +5144 0.6833829303666863 0.809024993201573 0 +5145 0.7853851154229555 0.3637018413143718 0 +5146 0.9813855232682474 0.5824742374836429 0 +5147 0.6102487421769622 0.8404201126373591 0 +5148 0.8733887577610135 0.6452625804511727 0 +5149 0.6608307860632888 0.3404079451449157 0 +5150 0.7983154869289883 0.789749236217539 0 +5151 0.2007968431690567 0.788833209365527 0 +5152 0.2073358737309552 0.4751016105422445 0 +5153 0.4803674957188557 0.8717115947124536 0 +5154 0.4426179569882082 0.4599504285728154 0 +5155 0.3619259225591073 0.8272109728864515 0 +5156 0.3554589461253074 0.9900837727039768 0 +5157 0.7767623535846901 0.990415880856788 0 +5158 0.223237646414211 0.9904158808568384 0 +5159 0.3975313790813489 0.4854341553029497 0 +5160 0.7150576304248653 0.9214683325151571 0 +5161 0.2849423695736952 0.9214683325155684 0 +5162 0.8543899416175985 0.4433571639152616 0 +5163 0.5819498798337325 0.9738230202218257 0 +5164 0.8063587237214788 0.7648135803400234 0 +5165 0.6958502305517058 0.8432078684934278 0 +5166 0.8360303725091969 0.04260653122301998 0 +5167 0.02621771837397401 0.3610286017234519 0 +5168 0.8696606899499334 0.9876609965077148 0 +5169 0.1303393100494757 0.9876609965077693 0 +5170 0.3341959893916868 0.9486358002402255 0 +5171 0.7436449067316085 0.4855718594521251 0 +5172 0.3569968154737739 0.9340834567269148 0 +5173 0.9681340456894977 0.9120110262325437 0 +5174 0.03186595431037328 0.9120110262330162 0 +5175 0.5435345226335198 0.4426095664459463 0 +5176 0.7487429352657344 0.5232106718544247 0 +5177 0.8207130038585 0.9548641209837042 0 +5178 0.179286996140646 0.9548641209839337 0 +5179 0.1584010394322435 0.7570371930364312 0 +5180 0.836825997525934 0.7723228680179753 0 +5181 0.2218523669649008 0.3962223316466019 0 +5182 0.7949999999994575 0.9908505882277465 0 +5183 0.204999999999543 0.9908505882277991 0 +5184 0.5417726202450382 0.7377555063450446 0 +5185 0.4383769047755908 0.8865817051417482 0 +5186 0.574555457092024 0.253403247818946 0 +5187 0.4621625070830343 0.440425029850484 0 +5188 0.9654227948826408 0.7877030491989589 0 +5189 0.03457720511725808 0.7877030491994333 0 +5190 0.1299790940145652 0.5034814486219871 0 +5191 0.4324054644828936 0.6996879538674258 0 +5192 0.1503559531774301 0.6394734883506403 0 +5193 0.2158534875305875 0.631746834386633 0 +5194 0.7090517307547576 0.3877709622683964 0 +5195 0.5858872264027336 0.9518754441734321 0 +5196 0.8565320932108919 0.7289850511565991 0 +5197 0.6136706840905868 0.8112392689471736 0 +5198 0.238115062702037 0.5139247698001013 0 +5199 0.8479069533546687 0.8549830104588492 0 +5200 0.1520930466446317 0.8549830104595373 0 +5201 0.5998767784867676 0.8904142414672902 0 +5202 0.5393277206267002 0.2916538515410138 0 +5203 0.805406002837185 0.8880715436557264 0 +5204 0.1945939971618714 0.8880715436562626 0 +5205 0.7772375961066424 0.8326297504502471 0 +5206 0.2228788342266912 0.8321021083611582 0 +5207 0.7668174442982527 0.8953508027249155 0 +5208 0.2331825557006116 0.8953508027254293 0 +5209 0.3424333137446891 0.5447217240797586 0 +5210 0.8205157561758523 0.837770214397819 0 +5211 0.1794842438232944 0.8377702143985475 0 +5212 0.8830028126541827 0.9533135146173488 0 +5213 0.1169971873452824 0.953313514617556 0 +5214 0.6946959043004026 0.9732307495146565 0 +5215 0.9360700638310563 0.7541472982841549 0 +5216 0.06392993616873585 0.7541472982846772 0 +5217 0.9398624986830005 0.5679549047713051 0 +5218 0.604177370866272 0.9764943476788297 0 +5219 0.8075491772361133 0.9048501113102634 0 +5220 0.1924508227629801 0.904850111310748 0 +5221 0.6228517738349927 0.6153168780852104 0 +5222 0.6326261579810137 0.928989566485664 0 +5223 0.7325960785849788 0.6219702714708674 0 +5224 0.8655585003149177 0.7778912400931604 0 +5225 0.9725535201360531 0.2644936684104823 0 +5226 0.1340196201633001 0.7789068587190143 0 +5227 0.9123430118126139 0.6563632945374235 0 +5228 0.3066298334747891 0.4362124759365882 0 +5229 0.2876192961424149 0.7338896847984326 0 +5230 0.4899992370050863 0.8142186915778594 0 +5231 0.706640242026236 0.9896319271960345 0 +5232 0.4303730967458493 0.7334833483198295 0 +5233 0.4767325465510325 0.9188784391144473 0 +5234 0.1380501193463946 0.5770252616307264 0 +5235 0.7632434635873423 0.8070239328148443 0 +5236 0.2372674749412016 0.80792183957368 0 +5237 0.255890201332829 0.4069164996566152 0 +5238 0.9282844235472367 0.9234016550842052 0 +5239 0.07171557645245262 0.9234016550845409 0 +5240 0.06528799927785493 0.4321214479949496 0 +5241 0.1766576888140433 0.289418804722693 0 +5242 0.7381690690418989 0.7955703565711139 0 +5243 0.617133428762052 0.8683853705007987 0 +5244 0.6939368945041369 0.1655306827226897 0 +5245 0.9260218840901469 0.3042453150095754 0 +5246 0.4481709195167204 0.5725819029032552 0 +5247 0.3728307874487243 0.7130280791519489 0 +5248 0.3897098822756728 0.839463962290024 0 +5249 0.3997821941353723 0.8555453845629071 0 +5250 0.1734993245506493 0.7763202093516812 0 +5251 0.742090131877999 0.9527379781504277 0 +5252 0.2579098681207102 0.9527379781506824 0 +5253 0.4821141852373999 0.2993129867789612 0 +5254 0.6720144972011768 0.7522723838228981 0 +5255 0.2330008762300516 0.2650899754366022 0 +5256 0.3725386845480658 0.3006344296584365 0 +5257 0.9042231491361261 0.7906231814785331 0 +5258 0.09577685086426178 0.7906231814790546 0 +5259 0.7939879977744374 0.2530369670517942 0 +5260 0.4536162473940435 0.8629012401679013 0 +5261 0.5212963154573466 0.1479593060513403 0 +5262 0.3246227488556793 0.926806955121945 0 +5263 0.8295458623780985 0.822029597332318 0 +5264 0.1704541376211094 0.8220295973331414 0 +5265 0.8558333757387951 0.8100727688163639 0 +5266 0.1441666242605573 0.8100727688171691 0 +5267 0.5196161522255479 0.4857737107830746 0 +5268 0.9843223995624026 0.7258518574591921 0 +5269 0.7018759523124585 0.7939921553216581 0 +5270 0.676016027205901 0.9285733367812452 0 +5271 0.9121452537933256 0.1154766126173065 0 +5272 0.755506620061819 0.7468307549357028 0 +5273 0.791575985934839 0.6088052663168417 0 +5274 0.2932798691915852 0.3224156276309679 0 +5275 0.5014369278155451 0.7134163020473379 0 +5276 0.82055080693794 0.5168836380138582 0 +5277 0.387533404737324 0.4621781094202846 0 +5278 0.05128400282736953 0.6287660496602137 0 +5279 0.03460714025316028 0.7533105507590314 0 +5280 0.3547544968696508 0.7399693958856419 0 +5281 0.2917601711017395 0.8254443557111342 0 +5282 0.9726322943127157 0.9357436505850862 0 +5283 0.02736770568715017 0.9357436505854155 0 +5284 0.4319654918597311 0.4059044408715901 0 +5285 0.6374361150961025 0.8284247037188236 0 +5286 0.5842379231280559 0.9913808476309784 0 +5287 0.7318062065405314 0.04257993922016536 0 +5288 0.02560615814477491 0.4468887657156778 0 +5289 0.4986757965944968 0.8595530560050555 0 +5290 0.3208581990273301 0.7499468631500931 0 +5291 0.3667655241511759 0.9508356120394291 0 +5292 0.4438340101402932 0.9597111088665262 0 +5293 0.7215801773459848 0.9436219837406786 0 +5294 0.2784198226526156 0.9436219837409818 0 +5295 0.9724657072513837 0.9580652277035442 0 +5296 0.02753429274847044 0.9580652277037225 0 +5297 0.8743623928258926 0.6977804221688909 0 +5298 0.7390161943571905 0.9136827936003996 0 +5299 0.2609838056415124 0.913682793600846 0 +5300 0.6323683379588645 0.7650808499292807 0 +5301 0.5235770841298011 0.9644236794299238 0 +5302 0.3322781282562632 0.246424902754788 0 +5303 0.3362405006770613 0.6713257412845458 0 +5304 0.9653690432395339 0.752528991473117 0 +5305 0.06287379901263582 0.6823045802867499 0 +5306 0.5372380963099356 0.7899851607455221 0 +5307 0.488660190545861 0.7758712787315541 0 +5308 0.8295298767544619 0.6054598431927647 0 +5309 0.09861230779935171 0.4038324746533998 0 +5310 0.4260518047415123 0.9922554152506118 0 +5311 0.5479763164510143 0.5863650408115094 0 +5312 0.6156685722985329 0.9472141273537935 0 +5313 0.7439761071343213 0.8897848336536878 0 +5314 0.2932919100414421 0.989676164650255 0 +5315 0.4563707391893222 0.7578789286387759 0 +5316 0.2560238928644302 0.8897848336542448 0 +5317 0.8717969861646168 0.9339535054886334 0 +5318 0.1282030138347887 0.9339535054889141 0 +5319 0.8361768973837429 0.6554329636143147 0 +5320 0.7721624882666293 0.4588009708542097 0 +5321 0.5629026383329533 0.8713537182590174 0 +5322 0.8477826548123145 0.8253913162917281 0 +5323 0.1522173451869763 0.8253913162925205 0 +5324 0.7076512537799944 0.7577794910488506 0 +5325 0.04985800291065232 0.5187901115382257 0 +5326 0.1969458240082952 0.6379959699686648 0 +5327 0.8739637297515515 0.8301474550132382 0 +5328 0.1260362702480043 0.8301474550141574 0 +5329 0.2411084893359467 0.4915948658299173 0 +5330 0.05406934188593593 0.710873543811207 0 +5331 0.5205186921204459 0.8697505543382205 0 +5332 0.2992074363023617 0.7843096476177206 0 +5333 0.8391046103578389 0.9468483478565857 0 +5334 0.1608953896414053 0.9468483478568449 0 +5335 0.1326735152528321 0.4791030194502448 0 +5336 0.5782782945324014 0.03281011326078123 0 +5337 0.4331656003184197 0.8416986674405361 0 +5338 0.1193585575141014 0.627472096040024 0 +5339 0.1595749620294631 0.7225253270156037 0 +5340 0.5389371993396629 0.9785569788626045 0 +5341 0.8078987044531767 0.950450476079024 0 +5342 0.1921012955458976 0.9504504760792704 0 +5343 0.8332403724215742 0.9742950945472981 0 +5344 0.1667596275776417 0.9742950945474309 0 +5345 0.3005307110320618 0.6645627141193889 0 +5346 0.5528369841890404 0.200441119057688 0 +5347 0.333818693788437 0.9918800823870025 0 +5348 0.7984870750002189 0.4524640829390401 0 +5349 0.7043617156350563 0.9566814952842739 0 +5350 0.2956689779394535 0.9566667840744669 0 +5351 0.8501845749080758 0.5479999732698959 0 +5352 0.9667778087269882 0.8723416609109442 0 +5353 0.03322219127293674 0.8723416609113666 0 +5354 0.397527838157975 0.6587464652802268 0 +5355 0.2834394819298297 0.6294922007435116 0 +5356 0.9178851767126699 0.5634088981991857 0 +5357 0.3226749168688524 0.8925151407023098 0 +5358 0.4027322168879597 0.9595759795357398 0 +5359 0.9416535657805366 0.9564428482482203 0 +5360 0.05834643421919553 0.956442848248432 0 +5361 0.5626690688892846 0.9183533116767988 0 +5362 0.5040859806015298 0.9916483304279144 0 +5363 0.8242849437424929 0.9906661568585273 0 +5364 0.1757150562566803 0.990666156858572 0 +5365 0.4325924217735703 0.7997492653317997 0 +5366 0.7997594736677044 0.9647470368919362 0 +5367 0.2002405263313317 0.9647470368921155 0 +5368 0.748687952595754 0.3997769667168176 0 +5369 0.9911302423176741 0.9390922546065326 0 +5370 0.008869757682275665 0.9390922546065725 0 +5371 0.5714276628474043 0.9780006191820558 0 +5372 0.4433513220044225 0.9910327184680642 0 +5373 0.02015509372546234 0.6011519107966657 0 +5374 0.1439101602146169 0.7508992823778862 0 +5375 0.6200939568871903 0.495286374946537 0 +5376 0.7274671818591365 0.848618449177415 0 +5377 0.2727440984472645 0.8482840530705651 0 +5378 0.6432544585052481 0.9900823207530784 0 +5379 0.3153442691296976 0.694139756825239 0 +5380 0.9128592016723825 0.2650902204886492 0 +5381 0.159984940955406 0.5758437202644342 0 +5382 0.7294863198714179 0.4465398443906924 0 +5383 0.03461466629849055 0.1569858678871573 0 +5384 0.3613033254546371 0.6445112137838246 0 +5385 0.1334747748295909 0.02819049858993528 0 +5386 0.01790504874113764 0.702903562862193 0 +5387 0.9638436100438381 0.8493952299419711 0 +5388 0.03615638995619053 0.8493952299423869 0 +5389 0.5104005688117166 0.5621606324279075 0 +5390 0.8485868936240687 0.3966638118287534 0 +5391 0.5822303777291926 0.551840157152456 0 +5392 0.3896076587326887 0.7913513153744456 0 +5393 0.6557923262270001 0.5578656295603011 0 +5394 0.6595613792812094 0.03087241957436808 0 +5395 0.455504869897236 0.832624089615408 0 +5396 0.430714586001322 0.9776977862790156 0 +5397 0.799015161172609 0.1139131715989302 0 +5398 0.3851924111465771 0.7342781241716263 0 +5399 0.9034115375009615 0.5855272665524046 0 +5400 0.9764633969399683 0.9714069577921862 0 +5401 0.02353660305993209 0.9714069577922384 0 +5402 0.9531856159126337 0.5451151946066675 0 +5403 0.5487345072633101 0.961641795492898 0 +5404 0.8550343707089232 0.991776536605103 0 +5405 0.1449656292904133 0.991776536605143 0 +5406 0.4095949693588038 0.8289658212092419 0 +5407 0.4707303367122314 0.2409402960610944 0 +5408 0.5116778845128261 0.5209975387284586 0 +5409 0.948700266946599 0.8652870429023096 0 +5410 0.05129973305320887 0.865287042902818 0 +5411 0.9557371753874487 0.9505996627925604 0 +5412 0.04426282461235116 0.9505996627928017 0 +5413 0.1900236045152789 0.2014261015874716 0 +5414 0.2516284256076846 0.5518628555944721 0 +5415 0.9049794834358502 0.956094044602073 0 +5416 0.0950205165637143 0.9560940446022459 0 +5417 0.7681526419839217 0.8822088838987264 0 +5418 0.2318473580149775 0.882208883899302 0 +5419 0.5517268935602417 0.9778392527422712 0 +5420 0.6095762548360281 0.5757632011835339 0 +5421 0.2782029378296607 0.2333285166087189 0 +5422 0.6038489335833827 0.7696910382109408 0 +5423 0.4554255657372077 0.9750238720835673 0 +5424 0.9217295542616711 0.7784756679481339 0 +5425 0.07827044573818411 0.7784756679486401 0 +5426 0.0569601898251524 0.6001080891940431 0 +5427 0.4534125120337798 0.1302057070658049 0 +5428 0.6785963509219842 0.9114897634988686 0 +5429 0.3214061824293293 0.9117030942611279 0 +5430 0.4479623742868082 0.8064744358316329 0 +5431 0.8700984782890788 0.8137393843248892 0 +5432 0.1298923027896278 0.8137823694942454 0 +5433 0.4070815336303174 0.5654014298713061 0 +5434 0.7982598870229242 0.920321011049468 0 +5435 0.2017401129760916 0.9203210110498637 0 +5436 0.3857889824962508 0.9568775252875303 0 +5437 0.8848042540411134 0.9750300667917142 0 +5438 0.1151957459583681 0.9750300667918295 0 +5439 0.7253672985631581 0.7444894453126124 0 +5440 0.7527173491819946 0.7796494565293146 0 +5441 0.9872643412536091 0.8360765319164613 0 +5442 0.0127356587464564 0.8360765319165909 0 +5443 0.5287487670019972 0.6004036303680786 0 +5444 0.4808491252312598 0.8967814592917207 0 +5445 0.8678887159904536 0.9773520719736983 0 +5446 0.1321112840089478 0.9773520719737979 0 +5447 0.8192413871692132 0.3270026798228309 0 +5448 0.8638986199260621 0.6770711066966006 0 +5449 0.656204751589869 0.9171708035957218 0 +5450 0.5613968859314671 0.7178427538203647 0 +5451 0.3162860952187156 0.9534833546138048 0 +5452 0.9243821805439771 0.8876907521736959 0 +5453 0.07561781945555764 0.8876907521741054 0 +5454 0.4439904574488259 0.4837494057208029 0 +5455 0.9812861975764479 0.6444857608277688 0 +5456 0.5040518698055525 0.4072939322662622 0 +5457 0.9220248530003212 0.9789342745811602 0 +5458 0.07797514699932542 0.9789342745812564 0 +5459 0.3362454457205817 0.1364889235546019 0 +5460 0.6646363417622405 0.9616263158970001 0 +5461 0.8354770044636219 0.916642079652676 0 +5462 0.5124672831166733 0.3170587371434307 0 +5463 0.1645229955356069 0.9166420796530689 0 +5464 0.6238916654382763 0.1531285795124489 0 +5465 0.7258991531483955 0.7750745506790402 0 +5466 0.3547141826196981 0.9792354562160113 0 +5467 0.8244141452760534 0.786149925585413 0 +5468 0.973824239619818 0.1984025237068864 0 +5469 0.5355102918854342 0.8715862303386365 0 +5470 0.3992839138922143 0.423239544475723 0 +5471 0.8206785076320313 0.8855775897074072 0 +5472 0.179321492367065 0.8855775897079745 0 +5473 0.8306744156839141 0.3751187999339283 0 +5474 0.9783512938703238 0.4346122874217232 0 +5475 0.9172992289072569 0.9621424837448881 0 +5476 0.08270077109235154 0.9621424837450498 0 +5477 0.4001678712280089 0.230635202175927 0 +5478 0.4292998355157529 0.8671609473071182 0 +5479 0.1701821508099538 0.6634286421819208 0 +5480 0.247214064599999 0.6690028371423605 0 +5481 0.474156470872927 0.6968213298219663 0 +5482 0.4883150042224449 0.3577933131781256 0 +5483 0.412271820788034 0.978136483673458 0 +5484 0.5185841181777961 0.8460022047843235 0 +5485 0.3637151209785919 0.912414423065845 0 +5486 0.9875734095010726 0.8542684724506094 0 +5487 0.01242659049910741 0.8542684724511194 0 +5488 0.100511394919102 0.6996254430150955 0 +5489 0.7503382237584979 0.8380481260152999 0 +5490 0.2496577753026152 0.8380504433981615 0 +5491 0.2014169844112082 0.3377436573696709 0 +5492 0.5531569511646668 0.8565583799784826 0 +5493 0.4447277549192254 0.9718957447137397 0 +5494 0.4614441745561382 0.6355003880692289 0 +5495 0.6847274382406103 0.6980859559490433 0 +5496 0.7980349165654693 0.2830942889728254 0 +5497 0.1290944461567794 0.7254461656483194 0 +5498 0.6472823288500297 0.7401083712785121 0 +5499 0.5862164631575041 0.7872753559023691 0 +5500 0.2170874585175655 0.716929277910235 0 +5501 0.1654909251600364 0.5085407896377312 0 +5502 0.3427872021021098 0.5200518285611331 0 +5503 0.8931274780412557 0.4136760383474667 0 +5504 0.8826239133720408 0.6091383870402014 0 +5505 0.05512825854499203 0.4838924275225751 0 +5506 0.6025994566539512 0.8644099993815014 0 +5507 0.2025651896243367 0.517104509009425 0 +5508 0.6851286599849921 0.9544998592213767 0 +5509 0.9320254351915518 0.9125040260230997 0 +5510 0.06797456480816653 0.9125040260234771 0 +5511 0.6095727311115193 0.7955262168751213 0 +5512 0.6022291934170609 0.6079738681031719 0 +5513 0.5980513429054879 0.7158983730613524 0 +5514 0.7234828937860174 0.9749331108982547 0 +5515 0.2765112018378619 0.9749194077902736 0 +5516 0.8241442473431402 0.7222453924264128 0 +5517 0.08634811767546006 0.6246035470102169 0 +5518 0.2556039592254978 0.7331266849260504 0 +5519 0.8754091968977979 0.5683376994277278 0 +5520 0.5519899413063067 0.5151485986008262 0 +5521 0.3430120655897429 0.9180536178825442 0 +5522 0.7055621899557852 0.5036702695973312 0 +5523 0.1955162804181866 0.5593828193001724 0 +5524 0.3600993968138387 0.6084896762581748 0 +5525 0.6309560170600991 0.9903573671516475 0 +5526 0.4488138620908716 0.9019382044842005 0 +5527 0.8299395747802094 0.8958353723292591 0 +5528 0.1700604252189947 0.895835372329749 0 +5529 0.771397184777298 0.9626497230096579 0 +5530 0.228602815221576 0.9626497230098636 0 +5531 0.7065210512995371 0.9776079155013749 0 +5532 0.8932936812599979 0.9413711074049326 0 +5533 0.1067063187395054 0.941371107405171 0 +5534 0.8980455169959847 0.843831670788858 0 +5535 0.1019544830037617 0.8438316707894635 0 +5536 0.8050067055518557 0.8326398088189563 0 +5537 0.1949932944472085 0.832639808819734 0 +5538 0.3396222096135629 0.4743375182876715 0 +5539 0.7546081962905744 0.1609839255644582 0 +5540 0.646367974758885 0.8990595550920751 0 +5541 0.5698755214619183 0.6606633870827534 0 +5542 0.1018274594523262 0.5950627439094738 0 +5543 0.2943039602534593 0.03313300207850058 0 +5544 0.2936310974782322 0.9777487270260797 0 +5545 0.4138212484669979 0.853749800033322 0 +5546 0.7987998981243964 0.7035997931868684 0 +5547 0.6201333796481213 0.6897487412572012 0 +5548 0.6009772632235473 0.6898912965369468 0 +5549 0.0882474807336209 0.3552069909803561 0 +5550 0.6143653959373696 0.9918316291630067 0 +5551 0.7912958077068686 0.3379126920930478 0 +5552 0.6499788438696997 0.6847590643604184 0 +5553 0.6327737113553942 0.956018515036325 0 +5554 0.8142949455562949 0.990409154555366 0 +5555 0.1857050544428209 0.990409154555411 0 +5556 0.4490198137376751 0.7273791444548212 0 +5557 0.7859054755000703 0.9018702341464622 0 +5558 0.2140945244988759 0.9018702341469291 0 +5559 0.3662989776733219 0.9899456238814075 0 +5560 0.5978325853579562 0.3032378723962288 0 +5561 0.5630154741940725 0.834949414765835 0 +5562 0.4532040188948471 0.775278687603895 0 +5563 0.697491071819567 0.6316999923397607 0 +5564 0.765887355442626 0.4817344895192572 0 +5565 0.5643632399795069 0.7735864450170581 0 +5566 0.7630030612773886 0.9764162541827136 0 +5567 0.2369969387214363 0.9764162541828451 0 +5568 0.4861044648225901 0.9910605548669137 0 +5569 0.5440187388397529 0.679466649092621 0 +5570 0.7664265480015803 0.3185765770388265 0 +5571 0.5707127519308206 0.3287573528605409 0 +5572 0.735527211140387 0.5894881064469477 0 +5573 0.4652586864521719 0.8879547084384811 0 +5574 0.7428285016305737 0.6855814511632351 0 +5575 0.3767599687823334 0.9349228122196115 0 +5576 0.3966783031688147 0.6993529464389833 0 +5577 0.6299201480454028 0.08746983622959485 0 +5578 0.3205470307177469 0.509284833171848 0 +5579 0.3521598484829305 0.3649425332737182 0 +5580 0.9386405262629913 0.9767560094307524 0 +5581 0.06135947373672658 0.9767560094308649 0 +5582 0.2451734544584768 0.3551138205655557 0 +5583 0.9906167689414833 0.9054532307891855 0 +5584 0.009383231058563705 0.9054532307891696 0 +5585 0.8865601448130269 0.9280841893294803 0 +5586 0.1134398551864527 0.9280841893297784 0 +5587 0.5225160948168954 0.9051365041407811 0 +5588 0.8794828897303075 0.9905552958070397 0 +5589 0.1205171102691472 0.9905552958070787 0 +5590 0.9510112255093535 0.7623564390258363 0 +5591 0.04899668659908214 0.7624599022489653 0 +5592 0.731113380295755 0.2216943434317518 0 +5593 0.7042869216244008 0.5678088629612119 0 +5594 0.918296938923728 0.80999636280986 0 +5595 0.08170306107631969 0.8099963628102523 0 +5596 0.9734387484768483 0.330816886964073 0 +5597 0.7225660869521737 0.7289274327375396 0 +5598 0.6379930068830233 0.8743322142146083 0 +5599 0.04134040972553626 0.563531191320163 0 +5600 0.2416144533652757 0.2049782977121427 0 +5601 0.8903307821610366 0.83159361138696 0 +5602 0.1096692178386882 0.8315936113876854 0 +5603 0.5742191367664858 0.7323936820953709 0 +5604 0.4307607965198856 0.03492660532162211 0 +5605 0.2829940031220662 0.5146474639777092 0 +5606 0.6157212794759834 0.742869901313584 0 +5607 0.02295083619549485 0.4067945811825622 0 +5608 0.2762487276516506 0.3906565698017028 0 +5609 0.3476739243606682 0.3071742442054349 0 +5610 0.8560265446014178 0.7529779244282659 0 +5611 0.078454428380867 0.5379034559996492 0 +5612 0.8453343505435607 0.8819958745556085 0 +5613 0.154665649455739 0.8819958745561592 0 +5614 0.1549117642048917 0.6123324107586591 0 +5615 0.9047360963435397 0.9750734105147547 0 +5616 0.0952639036560315 0.9750734105148575 0 +5617 0.02485109251083974 0.2899634880629488 0 +5618 0.4798874025895896 0.4886179221020566 0 +5619 0.307553803437068 0.5707564723501792 0 +5620 0.5244685195060483 0.9918272270684152 0 +5621 0.5357562856066952 0.6609737936555258 0 +5622 0.6950816584228044 0.991538335237184 0 +5623 0.6881609861511118 0.774288212906092 0 +5624 0.7351223828329303 0.9255015436884411 0 +5625 0.2648776171657347 0.925501543688836 0 +5626 0.3844940081412865 0.9918572373248629 0 +5627 0.104841889231163 0.1634152657378594 0 +5628 0.8782104458943975 0.7883276213819681 0 +5629 0.1217717656205278 0.7889014535299383 0 +5630 0.9335879310885734 0.8272998166261402 0 +5631 0.06641206891143331 0.8272998166264541 0 +5632 0.4584009204248881 0.9282631364137195 0 +5633 0.4960860681864642 0.9778873734090581 0 +5634 0.8926282565937668 0.7810532432688617 0 +5635 0.1086961397042765 0.7822015501782453 0 +5636 0.715319296161902 0.8563520324162497 0 +5637 0.2869584729050301 0.8561391975214327 0 +5638 0.8731370006986421 0.6624466908729536 0 +5639 0.9429043876555258 0.8092393497831563 0 +5640 0.05709561234453187 0.8092393497835376 0 +5641 0.4479377480630258 0.593694371490467 0 +5642 0.4848540082160493 0.8609454062589457 0 +5643 0.415754291572059 0.524495435895465 0 +5644 0.6494081906263591 0.7064424458104452 0 +5645 0.8083789441133744 0.8599676125747259 0 +5646 0.1916210558857173 0.8599676125753584 0 +5647 0.792284430123237 0.97484351844215 0 +5648 0.2077155698757742 0.9748435184422732 0 +5649 0.636270171850507 0.91650259045765 0 +5650 0.478161351628365 0.6040906380114676 0 +5651 0.7536100405101145 0.9158603216260431 0 +5652 0.2463899594886387 0.9158603216264947 0 +5653 0.1979038530928969 0.6604801444407856 0 +5654 0.5544801722847624 0.9274499912239706 0 +5655 0.6557079243174428 0.7988774055155315 0 +5656 0.775466436776811 0.7217222282242217 0 +5657 0.5763129503630114 0.9002951606983298 0 +5658 0.2731093681482079 0.6435556180974022 0 +5659 0.5309213678141723 0.9280610103125875 0 +5660 0.3419889128291569 0.6365303120478183 0 +5661 0.7934999531109665 0.4073675566198928 0 +5662 0.5363075739331393 0.8265115119200217 0 +5663 0.7345353427068382 0.9915542455509796 0 +5664 0.2654646572918293 0.9915542455510284 0 +5665 0.673498512292387 0.640661165231164 0 +5666 0.3237312920371785 0.6064303417992554 0 +5667 0.0188904012586162 0.4881643682618284 0 +5668 0.986840727094501 0.8075395053988763 0 +5669 0.01315927290552379 0.8075395053990693 0 +5670 0.733800902361639 0.6710063941543147 0 +5671 0.5820945738670994 0.5090397463907573 0 +5672 0.5502031157503957 0.2303147842513927 0 +5673 0.6610749378533124 0.6112375530763443 0 +5674 0.6185302139304856 0.9640171076040016 0 +5675 0.6986415875284411 0.9086518935142287 0 +5676 0.3013608599444918 0.9087461176206528 0 +5677 0.7232763853023411 0.8343799130739408 0 +5678 0.2773465229006703 0.8334796634544416 0 +5679 0.4662555949707989 0.6660297115845553 0 +5680 0.316319565802419 0.1869117667150414 0 +5681 0.1712160025009183 0.4803641428891834 0 +5682 0.9593509296824188 0.9223401495664639 0 +5683 0.04064907031739734 0.9223401495668508 0 +5684 0.7809901404495652 0.9307770982753808 0 +5685 0.2190098595493483 0.930777098275726 0 +5686 0.9126674545891106 0.9911963842983404 0 +5687 0.08733254541049518 0.9911963842983812 0 +5688 0.7826456042217502 0.5016268476264603 0 +5689 0.3669954571119478 0.8117113537338474 0 +5690 0.9079301712654129 0.9306496427479585 0 +5691 0.09206982873418536 0.9306496427482477 0 +5692 0.848343019849975 0.797443490349548 0 +5693 0.984479959087691 0.5627433166781165 0 +5694 0.1516471907959069 0.7975812900444379 0 +5695 0.9702205646687428 0.1329513057597193 0 +5696 0.3994118808700374 0.8950313412379606 0 +5697 0.8672292744643417 0.9189676233377002 0 +5698 0.1327707255350525 0.9189676233380514 0 +5699 0.3856455322968532 0.2767127648113841 0 +5700 0.7171041834116039 0.9920455254111091 0 +5701 0.2828845085984948 0.9920528983201806 0 +5702 0.3183672662906253 0.3699548828646443 0 +5703 0.5652047437355159 0.9635038682834358 0 +5704 0.3787112716857889 0.6980351690481456 0 +5705 0.8529442797658244 0.08277991971001927 0 +5706 0.4249036642187699 0.09808823558435482 0 +5707 0.425113256323624 0.9645103179311729 0 +5708 0.01311842530219071 0.7724737752075255 0 +5709 0.6841937018737366 0.4700699344350898 0 +5710 0.9251172889849526 0.4937512967062907 0 +5711 0.6371096357747819 0.9742053082590525 0 +5712 0.8556911934990434 0.9752220435181923 0 +5713 0.1443088065002922 0.9752220435183079 0 +5714 0.9392180843585147 0.7170599506555986 0 +5715 0.3245709269867547 0.9785831457316732 0 +5716 0.3486247035365549 0.7055071908804142 0 +5717 0.4871753723415304 0.1171744845165799 0 +5718 0.7884393552248558 0.6895639663170379 0 +5719 0.8894424778101472 0.9044430378030883 0 +5720 0.1105575221893087 0.9044430378034706 0 +5721 0.1331576949810652 0.7093141020158765 0 +5722 0.152214994391188 0.7086714845677322 0 +5723 0.3423985976085572 0.7945399983220308 0 +5724 0.4203744391332991 0.6869379174903053 0 +5725 0.7702263344684953 0.7916279071764292 0 +5726 0.5872484378754894 0.6222465869208643 0 +5727 0.2743793960346719 0.5600637208659758 0 +5728 0.2824310437581604 0.7790679273646406 0 +5729 0.3025783709367531 0.7988276069997851 0 +5730 0.4653146134565291 0.7864692235816284 0 +5731 0.5957053779905515 0.9053911342004082 0 +5732 0.6197799267211501 0.9288634677683001 0 +5733 0.3010727791933318 0.6813659223930525 0 +5734 0.1036585208243812 0.5649995266905909 0 +5735 0.9593916913688569 0.6442914917684753 0 +5736 0.5163656339564909 0.8335644992680263 0 +5737 0.2180165137655565 0.6125711436457545 0 +5738 0.5642083830749228 0.08911452190210944 0 +5739 0.6335126772728986 0.3817153093189032 0 +5740 0.733907968214052 0.8814786769480133 0 +5741 0.2660920317846421 0.881478676948618 0 +5742 0.2666982716877803 0.5921969584636639 0 +5743 0.4565655555525419 0.5334135539030858 0 +5744 0.8915358484190428 0.5111133322870078 0 +5745 0.1666273869692737 0.3140938996803629 0 +5746 0.9357375909487601 0.8705750120172491 0 +5747 0.06426240905089375 0.870575012017592 0 +5748 0.477726833745713 0.8235813610470327 0 +5749 0.3821138342579893 0.9654638141507843 0 +5750 0.7117941372878264 0.8045981886876605 0 +5751 0.3496566335994697 0.9618524638623698 0 +5752 0.3088195831889372 0.5442480262142994 0 +5753 0.03302271920423716 0.7287130295118605 0 +5754 0.8988172765641084 0.8660491361958964 0 +5755 0.1011827234355179 0.8660491361965285 0 +5756 0.9356762041656268 0.9450799036951482 0 +5757 0.06432379583407653 0.9450799036954112 0 +5758 0.8328647281208765 0.7986170911366302 0 +5759 0.1666503121640761 0.7990890091024248 0 +5760 0.1665568646619832 0.6462470320333548 0 +5761 0.01730383871726389 0.5391175803055884 0 +5762 0.4911781353708693 0.9622231139097221 0 +5763 0.6652765037026522 0.6774622664899423 0 +5764 0.8111164654299874 0.7528636815850559 0 +5765 0.798800081478778 0.6724848260035462 0 +5766 0.9523912520600085 0.5812942046490402 0 +5767 0.85788686107659 0.5301084469586086 0 +5768 0.5263548119830593 0.730449546430344 0 +5769 0.8135151556243996 0.1741955696415289 0 +5770 0.1364137650088493 0.6557089518425971 0 +5771 0.3921417618247485 0.6218382296567389 0 +5772 0.7865315193467698 0.9563880255474124 0 +5773 0.2134684806521884 0.956388025547636 0 +5774 0.7829302114052632 0.7380273203574916 0 +5775 0.3343248874522498 0.8869320910840024 0 +5776 0.5971519440285791 0.9680190515632603 0 +5777 0.9869308173104048 0.7724937501990174 0 +5778 0.7059455025447856 0.5261106044132892 0 +5779 0.4207333508141078 0.9482312270342557 0 +5780 0.8896050699271094 0.1839231487121193 0 +5781 0.5995305814673159 0.9186378981525803 0 +5782 0.3883105209905833 0.1904644224526155 0 +5783 0.287462701505919 0.8101205630321379 0 +5784 0.3263992754062334 0.5752542691373633 0 +5785 0.2320688680167728 0.7545729520423226 0 +5786 0.5184837287018034 0.9172160245785843 0 +5787 0.4352462079156247 0.7776490961601032 0 +5788 0.681785779863135 0.9617322558633097 0 +5789 0.2692894659167162 0.7553985603155705 0 +5790 0.4947779644675904 0.6778871106131925 0 +5791 0.7919397533795589 0.5500696810187932 0 +5792 0.8776986272069293 0.3207765272598251 0 +5793 0.7702568184722193 0.9466725879298774 0 +5794 0.2297431815266432 0.9466725879301743 0 +5795 0.7085272043045806 0.1226387059284735 0 +5796 0.8871704667827915 0.7421703647636975 0 +5797 0.3113436478892448 0.6347748720807382 0 +5798 0.50020612946761 0.908944852134233 0 +5799 0.07987419213962249 0.4586490783559408 0 +5800 0.2522434238575103 0.07948177443351009 0 +5801 0.5415786053037565 0.9407960622614164 0 +5802 0.9331420833268562 0.6641245265424456 0 +5803 0.3810126347414035 0.5186291995675811 0 +5804 0.1438607736078048 0.7342151955389079 0 +5805 0.3355149208449427 0.9277555878076584 0 +5806 0.02211572315856301 0.2358939775783405 0 +5807 0.09223175253205791 0.6732335063434889 0 +5808 0.7599033719639825 0.3715333504150437 0 +5809 0.5995692400997168 0.2408739025300914 0 +5810 0.7830551798210126 0.8612924856028388 0 +5811 0.2169448201779424 0.8612924856035027 0 +5812 0.6776613247615246 0.890373820801498 0 +5813 0.6933113309810272 0.3323618314027602 0 +5814 0.5952053395950058 0.9519066973265372 0 +5815 0.9736122170673833 0.8603332804919868 0 +5816 0.02638778293263773 0.8603332804923969 0 +5817 0.6808486381224306 0.4494793205437941 0 +5818 0.8513459454615592 0.6186457227348777 0 +5819 0.7341139351207745 0.5556981051826374 0 +5820 0.7655314740312021 0.6624049016300149 0 +5821 0.6451327353080236 0.9573186858847409 0 +5822 0.7449999999993338 0.9927120732159392 0 +5823 0.2549999999993979 0.9927120732159823 0 +5824 0.4449784759399323 0.2074205898756936 0 +5825 0.8740592910126415 0.3925499832940853 0 +5826 0.484580825750938 0.6634833603835271 0 +5827 0.6575903116893793 0.1075945392018394 0 +5828 0.4391007508986882 0.8569704027041999 0 +5829 0.08943960062781542 0.2805826408067499 0 +5830 0.5085452610560132 0.7938207820548214 0 +5831 0.2569419247028543 0.7973989730929767 0 +5832 0.8960900985259521 0.8063387424727755 0 +5833 0.1039099014740091 0.8063387424734364 0 +5834 0.3153147127174971 0.7755538187753493 0 +5835 0.1792310087597208 0.4417308426595597 0 +5836 0.06072535405899064 0.6640729147489484 0 +5837 0.6206325287592378 0.8467760081032563 0 +5838 0.4622092110676207 0.8487781567703898 0 +5839 0.4279059638538463 0.556589080626524 0 +5840 0.2986543209773786 0.847729528704124 0 +5841 0.4701379061707204 0.7112541817151093 0 +5842 0.8034147295675705 0.3818665064415744 0 +5843 0.4195700815575562 0.31372873746437 0 +5844 0.3068100201616368 0.8234780264000474 0 +5845 0.76536461239919 0.4161188910239795 0 +5846 0.9147837944387931 0.9722619606057226 0 +5847 0.0852162055608176 0.9722619606058439 0 +5848 0.5400292433539486 0.490094818833005 0 +5849 0.7207248656391616 0.9564425094990727 0 +5850 0.2792743143073836 0.9564406062898528 0 +5851 0.6599636873311245 0.7671003822809508 0 +5852 0.8500823110558664 0.9079631910568343 0 +5853 0.1499176889434395 0.9079631910572471 0 +5854 0.144418972257271 0.3512350258205863 0 +5855 0.8946050667908398 0.4604408144929691 0 +5856 0.1717992616636571 0.7474099628857297 0 +5857 0.6900653700526629 0.9376001650009549 0 +5858 0.9186106947445905 0.5307268193373686 0 +5859 0.921411928757037 0.7412771594526796 0 +5860 0.07648379325506376 0.7422534133409329 0 +5861 0.3295690879899254 0.2899422239441532 0 +5862 0.7941258958493993 0.9412821573017069 0 +5863 0.2058741041496009 0.9412821573019844 0 +5864 0.9731196284616547 0.9807369034574984 0 +5865 0.02688037153823319 0.9807369034575448 0 +5866 0.1853170079013104 0.6232042527506025 0 +5867 0.5965833297369094 0.852859160227655 0 +5868 0.2198134734566503 0.1555739740111867 0 +5869 0.7050610217075344 0.9474972330407966 0 +5870 0.2949564484938552 0.947471642689616 0 +5871 0.2680712631760345 0.3642557843263953 0 +5872 0.6659053493383351 0.906852208538613 0 +5873 0.559582504054297 0.9472262052749172 0 +5874 0.3202374067131224 0.96212631921998 0 +5875 0.09520617761490985 0.5081646441595635 0 +5876 0.5743380701902594 0.8155981715978979 0 +5877 0.3788793548987375 0.6697326107327828 0 +5878 0.8749926717867279 0.9719883855229426 0 +5879 0.125007328212707 0.9719883855230687 0 +5880 0.6799809986706793 0.2185852994509519 0 +5881 0.08102688062798041 0.7247346907080441 0 +5882 0.6959440627980849 0.7102771085540105 0 +5883 0.01393060078296705 0.6466353742591123 0 +5884 0.6406736849166699 0.6572267537602462 0 +5885 0.9405514767394725 0.8470345876176629 0 +5886 0.0594485232603594 0.8470345876180176 0 +5887 0.2156047220440743 0.1171917870968121 0 +5888 0.3675093728813748 0.1718046550766263 0 +5889 0.2967998303279936 0.6018667093799732 0 +5890 0.3081716571855894 0.9397050566521117 0 +5891 0.9334780302306691 0.1646445745051381 0 +5892 0.3657940250776894 0.8727138066672783 0 +5893 0.7902950581236463 0.8115448760897821 0 +5894 0.2094063211042025 0.8107199819949026 0 +5895 0.4858912704661862 0.9136013004892511 0 +5896 0.477458730661367 0.3999747739663564 0 +5897 0.976125216170173 0.91750365142822 0 +5898 0.02387478382978671 0.9175036514285241 0 +5899 0.7220402339121654 0.6993218587547123 0 +5900 0.7408782272172971 0.3561630964232372 0 +5901 0.240189544823903 0.4486127600517274 0 +5902 0.7110692775805528 0.5900504184368129 0 +5903 0.1340561631839129 0.5474000840717419 0 +5904 0.4077354001266836 0.9312696471709843 0 +5905 0.525464565562591 0.9523664692890907 0 +5906 0.5092123458915061 0.6472077621671612 0 +5907 0.9850195368169783 0.6265068015884395 0 +5908 0.3969208562913407 0.9286027602275783 0 +5909 0.9623607770783329 0.991309655917764 0 +5910 0.03763922292149697 0.991309655917797 0 +5911 0.1233673968097447 0.2135807151456949 0 +5912 0.1369691255938854 0.4376106802763087 0 +5913 0.7066515205636987 0.8191767091122729 0 +5914 0.723208068784003 0.9280577172778528 0 +5915 0.6613182848443586 0.2837440154635884 0 +5916 0.2767919312145935 0.9280577172782347 0 +5917 0.265198511184416 0.7714857906376555 0 +5918 0.750355059298372 0.8654254983047884 0 +5919 0.2496449407003984 0.8654254983054921 0 +5920 0.439053657320135 0.9322964016033675 0 +5921 0.3917395593863565 0.9418817592297308 0 +5922 0.3867192940402129 0.075425044124037 0 +5923 0.4798559038361584 0.7240008185817973 0 +5924 0.4490751758047421 0.8759868703503105 0 +5925 0.7673351628557599 0.7065936059491414 0 +5926 0.8008541371329791 0.03328852495823897 0 +5927 0.5625510559105686 0.1425954542760814 0 +5928 0.6001140902385795 0.3843994291584766 0 +5929 0.3484151502694347 0.8994812124838365 0 +5930 0.97236244152937 0.8113872864472376 0 +5931 0.02763755847065458 0.8113872864475333 0 +5932 0.1051963364094066 0.08164167196955435 0 +5933 0.5780617784668967 0.1175119694131741 0 +5934 0.5072176073548792 0.9619091011785712 0 +5935 0.6962732042401358 0.7427065597143415 0 +5936 0.4239237277882271 0.6330456871361846 0 +5937 0.3404190062889704 0.9401052355688574 0 +5938 0.1595808509474345 0.7725413264421446 0 +5939 0.7781137847106661 0.9806905428332851 0 +5940 0.2218862152882485 0.9806905428333886 0 +5941 0.07237563488626353 0.6530571950377947 0 +5942 0.9317662350899292 0.8008485588733055 0 +5943 0.06823383854971179 0.8008483927929941 0 +5944 0.3233024883520073 0.07621960694554006 0 +5945 0.6049834279654349 0.940028894214041 0 +5946 0.05158373249865376 0.3998402309829594 0 +5947 0.3016401461451921 0.4769034822517369 0 +5948 0.3420058071031243 0.9785473060589752 0 +5949 0.07284368471032507 0.5698874601806692 0 +5950 0.578788424781387 0.8893942280030481 0 +5951 0.5182709323407245 0.6606776938068708 0 +5952 0.589700555541551 0.7313300658649046 0 +5953 0.8686250949154513 0.8835672868363571 0 +5954 0.1313749050839766 0.8835672868368744 0 +5955 0.9144791926789964 0.9415017214749696 0 +5956 0.08552080732060202 0.9415017214752124 0 +5957 0.6314181589591346 0.7339875560741045 0 +5958 0.4975129180236609 0.2225865226868212 0 +5959 0.8148196830168506 0.6979266157629154 0 +5960 0.4596395907747728 0.7398161307389599 0 +5961 0.5906979025430606 0.3545080692510018 0 +5962 0.5688568270355644 0.745786369977856 0 +5963 0.5394530512486402 0.9188565391701985 0 +5964 0.7322180483592269 0.8263006250201956 0 +5965 0.2677819516394559 0.8263006250210895 0 +5966 0.9339088150678342 0.9922861096903196 0 +5967 0.06609118493186165 0.9922861096903597 0 +5968 0.1136663994720509 0.5131436261076319 0 +5969 0.4732608652174386 0.9610678497214648 0 +5970 0.8129522597134929 0.8107640754782732 0 +5971 0.1870115233819858 0.81056971734937 0 +5972 0.5526771246162976 0.7863160914254096 0 +5973 0.725354291418228 0.4681791047836801 0 +5974 0.1495204715769518 0.1964046293829141 0 +5975 0.8084935066535299 0.9809821227525511 0 +5976 0.1915064933455585 0.9809821227526392 0 +5977 0.1701100810460653 0.7337820502724637 0 +5978 0.3290565840859141 0.8173928084449686 0 +5979 0.2290727330028929 0.4735707996617625 0 +5980 0.2144156550494219 0.02960728998999813 0 +5981 0.8027418312081038 0.8179244441122672 0 +5982 0.1971871357759242 0.8177464449472398 0 +5983 0.6178797463087852 0.5403636706571301 0 +5984 0.670718308893248 0.8166976620330939 0 +5985 0.623795387219708 0.8899070802891178 0 +5986 0.9750996478380473 0.3562043219994103 0 +5987 0.6060233796328509 0.2104383245883918 0 +5988 0.3266758144612943 0.8339178256448804 0 +5989 0.5762167786791453 0.9927012056159867 0 +5990 0.5574145194242478 0.6477621970465243 0 +5991 0.3882249912262127 0.593067756123303 0 +5992 0.8507022733418599 0.9839549402300524 0 +5993 0.1492977266574481 0.9839549402301297 0 +5994 0.379590257427455 0.8458689080427849 0 +5995 0.2540918374068041 0.6392984913533328 0 +5996 0.8797986131751181 0.3679683753114548 0 +5997 0.9556420684286639 0.6182699349748231 0 +5998 0.507522007331726 0.5883319500496261 0 +5999 0.3669615586924611 0.9625121653156957 0 +6000 0.5773937164428997 0.7595359077096012 0 +6001 0.9623770245639214 0.7374555987913516 0 +6002 0.6585936852341076 0.8129247414519322 0 +6003 0.5111944662766876 0.6765085185032176 0 +6004 0.7859937304145656 0.9927092396041839 0 +6005 0.2140062695843854 0.9927092396042214 0 +6006 0.9047282741236936 0.7618374229382117 0 +6007 0.09400508981689661 0.7610988812589408 0 +6008 0.4877051489401004 0.981257921883385 0 +6009 0.8400904797621292 0.9261287232485922 0 +6010 0.1599095202371158 0.926128723248941 0 +6011 0.9814505319220542 0.5176986880877729 0 +6012 0.3315676704501845 0.9617105671580536 0 +6013 0.7105503321369375 0.4300546909360749 0 +6014 0.6755717697240684 0.992367773124794 0 +6015 0.6732232727567716 0.8346200160518531 0 +6016 0.2653365328047783 0.4599360908307733 0 +6017 0.3842604141680298 0.9100568192953374 0 +6018 0.5212139634614129 0.4397198931965354 0 +6019 0.8222429937602591 0.9744241416187831 0 +6020 0.1777570062389003 0.9744241416189194 0 +6021 0.2458460297637566 0.3137669413778819 0 +6022 0.579694132734485 0.485620053675856 0 +6023 0.3583942299401184 0.9460742529461267 0 +6024 0.9746519099441702 0.2361252064380428 0 +6025 0.2741813676895234 0.7252120373885802 0 +6026 0.5389129104064975 0.02641361821164382 0 +6027 0.499359150385416 0.7494049222389207 0 +6028 0.8747291481465567 0.9454540414306687 0 +6029 0.1252708518528662 0.9454540414309053 0 +6030 0.9606160872226495 0.9052590337497591 0 +6031 0.03938391277717437 0.9052590337501273 0 +6032 0.4324284955643811 0.6610171970054517 0 +6033 0.3357868963228318 0.7290631630345411 0 +6034 0.534642264835455 0.706819051638236 0 +6035 0.8586047292978233 0.9372251305885142 0 +6036 0.1413952707015403 0.9372251305888047 0 +6037 0.737048590898945 0.9008889546781209 0 +6038 0.2629514090997688 0.900888954678623 0 +6039 0.4466525841454734 0.6909967793747119 0 +6040 0.5882686156722914 0.8312599975081422 0 +6041 0.5539037903242234 0.3749073370304704 0 +6042 0.5632812820447248 0.452113963273801 0 +6043 0.5354172468099235 0.9478317280038863 0 +6044 0.3417361359934372 0.8154858736224386 0 +6045 0.7469852513260367 0.9775921399053573 0 +6046 0.2530147486726942 0.9775921399054848 0 +6047 0.5069849080877348 0.8676018051971637 0 +6048 0.3713144197467877 0.7635276926974567 0 +6049 0.7653129675173599 0.9915443593876709 0 +6050 0.2346870324814776 0.9915443593877172 0 +6051 0.6376700830224332 0.6287307101860051 0 +6052 0.7110843076245685 0.6498024691067386 0 +6053 0.7371157348474366 0.7663135256467741 0 +6054 0.7801437881467291 0.9646237917586475 0 +6055 0.2198562118521989 0.9646237917588385 0 +6056 0.8350560660841873 0.9929028832131668 0 +6057 0.1649439339150396 0.992902883213197 0 +6058 0.5325705541058079 0.6314683705676722 0 +6059 0.2489281413638863 0.588298348073478 0 +6060 0.9759874829314902 0.8332057209124479 0 +6061 0.02401251706857941 0.833205720912702 0 +6062 0.7533794835504859 0.9703323602215927 0 +6063 0.3811624496743616 0.9227509386027708 0 +6064 0.2466205164482812 0.9703323602217651 0 +6065 0.1660965874313645 0.1253958098709973 0 +6066 0.5329767779797843 0.5257507174322078 0 +6067 0.8181418837435779 0.6821369778577213 0 +6068 0.6339172958458963 0.7096120850238526 0 +6069 0.2386523498123639 0.6126439496252499 0 +6070 0.840678494114118 0.8929685771942868 0 +6071 0.1593215058851523 0.8929685771947551 0 +6072 0.6737543942714278 0.9765149554089092 0 +6073 0.249657797212896 0.7087321070379677 0 +6074 0.946626190904131 0.9684467626969058 0 +6075 0.05337380909562391 0.9684467626970573 0 +6076 0.94253088096721 0.8351085591460683 0 +6077 0.05746911903274707 0.8351085591464276 0 +6078 0.7827145036490796 0.7865319635749157 0 +6079 0.9924602202594454 0.9631633092707892 0 +6080 0.007539779740514728 0.9631633092707489 0 +6081 0.5334487583651037 0.08946206854258755 0 +6082 0.6894186379469862 0.6661151340012738 0 +6083 0.6916640188181041 0.8193493948944759 0 +6084 0.6245459463545125 0.7864345050577258 0 +6085 0.7117259308503492 0.9613067999310975 0 +6086 0.2882730949050722 0.9612972305285632 0 +6087 0.6265034274168045 0.9794256430266859 0 +6088 0.1415511435222283 0.1684734918578223 0 +6089 0.3936277129866246 0.138122239226607 0 +6090 0.3035191994010185 0.991871606663514 0 +6091 0.8951267611802318 0.9936037422066379 0 +6092 0.1048732388192967 0.9936037422066649 0 +6093 0.2301962283808523 0.5537109292981514 0 +6094 0.6849740809481368 0.53586973501941 0 +6095 0.648892635677049 0.5216421575519716 0 +6096 0.7982459475171733 0.982421099335826 0 +6097 0.2017540524818577 0.9824210993359128 0 +6098 0.85677934009576 0.9181769826165878 0 +6099 0.1432206599035732 0.9181769826169642 0 +6100 0.753242697183084 0.878520189722136 0 +6101 0.4010175221881389 0.3765066526817589 0 +6102 0.2467573028157132 0.878520189722755 0 +6103 0.4175406268011867 0.9006141271660033 0 +6104 0.9164715750631049 0.7270578899573277 0 +6105 0.4920721766717148 0.6485242613722678 0 +6106 0.9455180594229355 0.3258037804881802 0 +6107 0.5126553370038303 0.9786720747303744 0 +6108 0.7297657007974148 0.641328770445992 0 +6109 0.7415526976250986 0.8473062839734422 0 +6110 0.2177567596484214 0.6629438532471479 0 +6111 0.2584769137122045 0.8472588441562796 0 +6112 0.4762978965207471 0.7611412865492767 0 +6113 0.4145643715031359 0.7633444665688245 0 +6114 0.8035634424065891 0.9281301409476823 0 +6115 0.1964365575924535 0.9281301409480363 0 +6116 0.4511034978896756 0.7114009119380598 0 +6117 0.9305150286630632 0.6434613191208091 0 +6118 0.7050189967160302 0.8532423605433292 0 +6119 0.3116728686190677 0.7606063639647452 0 +6120 0.2006776740089859 0.6917315289554939 0 +6121 0.4123890621395721 0.9164689045175711 0 +6122 0.6198168709202319 0.6601627696951616 0 +6123 0.06415570238450652 0.6186080279189353 0 +6124 0.7129463435374412 0.9715947059360859 0 +6125 0.2865848597557287 0.9717007536138151 0 +6126 0.2808828539877822 0.4389979948397529 0 +6127 0.5842575165038532 0.8685640348407331 0 +6128 0.4109017492923664 0.9618436270439571 0 +6129 0.6284603497761718 0.9480426702145747 0 +6130 0.6837668185152687 0.5771982406426943 0 +6131 0.8983410681088493 0.8202898858520401 0 +6132 0.101658931891008 0.8202898858526577 0 +6133 0.8403845305876942 0.8468291073989506 0 +6134 0.1596154694115428 0.8468291073996581 0 +6135 0.3514247048817024 0.6878909075615158 0 +6136 0.8286146628532224 0.74775915386074 0 +6137 0.5994341047606676 0.590860380648361 0 +6138 0.0705224666787935 0.1452280442414606 0 +6139 0.8091049173971572 0.7275906187298408 0 +6140 0.866595397213899 0.02809463322952799 0 +6141 0.5768244695703487 0.9201061044522033 0 +6142 0.8058511142465226 0.6384957109955478 0 +6143 0.2203035730548622 0.6833076696259877 0 +6144 0.4017303348316094 0.7264986756852039 0 +6145 0.388543626409067 0.8639597222088391 0 +6146 0.5410634153904144 0.9618542500399609 0 +6147 0.3447734367147904 0.9927855543965766 0 +6148 0.8973279413537358 0.8851838040622987 0 +6149 0.4832911731607651 0.7483636029796277 0 +6150 0.102672058645772 0.8851838040627591 0 +6151 0.1186941066627285 0.7503979337760223 0 +6152 0.6668339351257925 0.8871463325229625 0 +6153 0.250783105567388 0.5283757217832104 0 +6154 0.4768660897437963 0.9925798044187932 0 +6155 0.6494064998388401 0.8271058589444203 0 +6156 0.960994001942449 0.9621286375560276 0 +6157 0.03900599805737477 0.9621286375562085 0 +6158 0.8141739908486749 0.5812807196745918 0 +6159 0.4312352223162026 0.6207422449152583 0 +6160 0.07794199600031501 0.2344169236235391 0 +6161 0.4393343537440644 0.9797101529591542 0 +6162 0.3610023733517941 0.8920735867844714 0 +6163 0.06037143606145581 0.5010963669953038 0 +6164 0.2230057880223868 0.7726222468193082 0 +6165 0.06030772680310362 0.3244185268954665 0 +6166 0.06867223439416163 0.03161467466601323 0 +6167 0.5804573581167721 0.06364063891340119 0 +6168 0.3687072339564204 0.7471388311721157 0 +6169 0.6356194069323952 0.8061039485041007 0 +6170 0.4654783357601118 0.9455406282670094 0 +6171 0.9406065369970951 0.2449785957933524 0 +6172 0.7898952600133466 0.8525044383882412 0 +6173 0.2101047399856279 0.8525044383889124 0 +6174 0.5864733001002883 0.9833668124289462 0 +6175 0.3135842909621652 0.3403868163461301 0 +6176 0.4182873415163392 0.841948998694046 0 +6177 0.03411098028126403 0.6570746517310893 0 +6178 0.9288435382823192 0.8514536013512092 0 +6179 0.07115646171729698 0.8514536013515622 0 +6180 0.7102336765742419 0.8314466501351953 0 +6181 0.5824653335684215 0.9612624131018678 0 +6182 0.7650377462243295 0.8516610900858951 0 +6183 0.2349622537745091 0.8516610900866263 0 +6184 0.6140421587884111 0.9826784543515501 0 +6185 0.1371908145675958 0.6762226361180055 0 +6186 0.4048942500074748 0.686199550265696 0 +6187 0.8827586560568216 0.8672545640812841 0 +6188 0.1172413439426994 0.8672545640819133 0 +6189 0.4711417240742283 0.8963930030879652 0 +6190 0.6179735446526763 0.75918061080497 0 +6191 0.7904246276360621 0.1536105133948216 0 +6192 0.2136538169728937 0.7890691292790731 0 +6193 0.4284033520069242 0.7646174755338483 0 +6194 0.8612500027132991 0.8723361007259691 0 +6195 0.1387499972860968 0.8723361007265521 0 +6196 0.2193379506288386 0.5819353645816845 0 +6197 0.510154167953475 0.7027885145667746 0 +6198 0.9127438611589369 0.6164702875500475 0 +6199 0.6615419037490012 0.937958579330215 0 +6200 0.2873463940740646 0.7003658115585099 0 +6201 0.276652285110633 0.1394132517902294 0 +6202 0.5248898817347779 0.2381602397455254 0 +6203 0.7833977322212805 0.9736893367887923 0 +6204 0.2166022677776676 0.9736893367889278 0 +6205 0.8925029586583025 0.6895223435118569 0 +6206 0.353148514485599 0.1158448076049724 0 +6207 0.6903873901595079 0.9826067107369563 0 +6208 0.772584119432536 0.518854370441254 0 +6209 0.372361291908708 0.9798035882369907 0 +6210 0.9639358125305347 0.8011595106851861 0 +6211 0.03606418746944241 0.8011595106856063 0 +6212 0.9455674505354765 0.1942127326192239 0 +6213 0.7501351871750819 0.2862743423399968 0 +6214 0.2561128860264494 0.7487474665077173 0 +6215 0.9247878377442644 0.690158511805293 0 +6216 0.1935417505113115 0.7265529918991327 0 +6217 0.7195608994038013 0.912002211031175 0 +6218 0.2804391005947867 0.9120022110316345 0 +6219 0.5150883822618911 0.3697176587867824 0 +6220 0.6530111018827388 0.9925578027322287 0 +6221 0.611074869940518 0.9569968201243511 0 +6222 0.9651137716792937 0.7034655130443146 0 +6223 0.5013997648243036 0.767295499961054 0 +6224 0.5890724269142634 0.7039487575651426 0 +6225 0.132984631344333 0.638673284822342 0 +6226 0.4989462369416074 0.9449186878146298 0 +6227 0.4439633625583302 0.5059686671553132 0 +6228 0.2877668380187623 0.1731033874096143 0 +6229 0.5925380191999835 0.6389352693642592 0 +6230 0.4141998460928692 0.7387380722134986 0 +6231 0.8513690227812767 0.7820224415172572 0 +6232 0.6196940721760775 0.6307119770762134 0 +6233 0.4059443053244709 0.7971312609922974 0 +6234 0.2211477273309704 0.5214504305776917 0 +6235 0.790152652518135 0.763581091160737 0 +6236 0.9338177270755383 0.8809566615987512 0 +6237 0.06618227292408516 0.8809566615991293 0 +6238 0.6162200905151866 0.8814836080990938 0 +6239 0.6283096271673346 0.9085269141005804 0 +6240 0.6861818099671169 0.8338372249743476 0 +6241 0.5496822402421278 0.4210968220732841 0 +6242 0.4914065432757073 0.2724313146183496 0 +6243 0.9507926569496075 0.8540305643656967 0 +6244 0.04920734305026959 0.8540305643661071 0 +6245 0.5450067547351533 0.9934788718087424 0 +6246 0.6493453155538043 0.2274561466850132 0 +6247 0.3338222159608659 0.7744620073899825 0 +6248 0.6017809594629139 0.4759979761751326 0 +6249 0.8229241770541235 0.9331615938610278 0 +6250 0.1770758229450199 0.9331615938613506 0 +6251 0.7352471528925193 0.9432091368779265 0 +6252 0.2647528471061498 0.9432091368782309 0 +6253 0.6391134620819892 0.5051616323908145 0 +6254 0.4701464457101454 0.5657372266963648 0 +6255 0.7707510139339434 0.9262197924418167 0 +6256 0.2292489860649021 0.9262197924421942 0 +6257 0.3694905876350827 0.6856977130404813 0 +6258 0.3877070865836759 0.7632041176218606 0 +6259 0.1431092135607851 0.4183640463878613 0 +6260 0.5897098733840711 0.9332758334904041 0 +6261 0.9450000572816862 0.4050163181612534 0 +6262 0.6718062687962219 0.9465372586709312 0 +6263 0.2309790047931109 0.7970896369490053 0 +6264 0.473434190590788 0.978672327047075 0 +6265 0.3501277467248544 0.8275495738347486 0 +6266 0.9770478315062525 0.2884451149200871 0 +6267 0.1904623192762926 0.2490975284805339 0 +6268 0.0294045377762178 0.02959725969311588 0 +6269 0.4048353357559047 0.9931587242713624 0 +6270 0.9511089777172913 0.5069785474203021 0 +6271 0.1951487035500393 0.1687957132889462 0 +6272 0.916675195983971 0.9239844127524361 0 +6273 0.08332480401567864 0.9239844127527572 0 +6274 0.3554818590671066 0.7682032499220097 0 +6275 0.843757664182059 0.1567130545575639 0 +6276 0.860216709706748 0.5866227325999558 0 +6277 0.4940831962869077 0.7890334258373437 0 +6278 0.03728115985546097 0.6991202158559817 0 +6279 0.3743896030675613 0.7874221625997162 0 +6280 0.3603907307941058 0.7199375999380527 0 +6281 0.4891450225028585 0.6192371926809567 0 +6282 0.5245157835587241 0.3961397773281161 0 +6283 0.4134687894635406 0.7862199523321439 0 +6284 0.4802963007022407 0.4499421398691045 0 +6285 0.2434802183704529 0.7267540359127134 0 +6286 0.6459677171914076 0.3153343008603139 0 +6287 0.1479250907470507 0.7834349824537639 0 +6288 0.7549588227885647 0.8979909589623255 0 +6289 0.245041177210246 0.8979909589628448 0 +6290 0.8312542429934946 0.9611099255543043 0 +6291 0.1687457570057134 0.9611099255545085 0 +6292 0.3684933305390807 0.9016874772868441 0 +6293 0.7849882550292935 0.6564397011738609 0 +6294 0.399255992864848 0.913475677939648 0 +6295 0.4272630560626632 0.7875653375651045 0 +6296 0.399995089341152 0.8861788903014705 0 +6297 0.4554863310926411 0.9575322777794214 0 +6298 0.8513155082875326 0.927153006926299 0 +6299 0.1486844917117745 0.9271530069266358 0 +6300 0.9493398126589279 0.8884160669685514 0 +6301 0.05066018734082217 0.888416066968975 0 +6302 0.5361132996394085 0.7651773613257943 0 +6303 0.914904433766243 0.9059749316350647 0 +6304 0.0850955662333738 0.9059749316354354 0 +6305 0.5916209083824751 0.7580399057028374 0 +6306 0.9768730715581154 0.8956511270731936 0 +6307 0.02312692844191717 0.8956511270736178 0 +6308 0.2414051099791601 0.683026036464064 0 +6309 0.4722743991700892 0.1822316602731825 0 +6310 0.9472292429192057 0.3614308976457151 0 +6311 0.5277041754965801 0.1841167166542531 0 +6312 0.4080251891830439 0.7513443218698448 0 +6313 0.4360954189601112 0.7535325453026841 0 +6314 0.7588147383528037 0.6821272221486563 0 +6315 0.1463427286226025 0.514265808137232 0 +6316 0.9561335114654507 0.8719750038657822 0 +6317 0.0438664885343836 0.8719750038663552 0 +6318 0.4168631266204208 0.883584590695379 0 +6319 0.100323303942943 0.7264809189898758 0 +6320 0.6239538578813865 0.8579621483159885 0 +6321 0.4076269718054026 0.7742263285210982 0 +6322 0.3049161806478616 0.7107490108649943 0 +6323 0.0722698064169819 0.5892726781384632 0 +6324 0.9857438036283286 0.6620061434680213 0 +6325 0.8731152849887825 0.9632706252182064 0 +6326 0.1268847150106414 0.9632706252183723 0 +6327 0.9928150186570481 0.9295536913487324 0 +6328 0.007184981342997674 0.9295536913485567 0 +6329 0.9169886432108587 0.3808259229389908 0 +6330 0.8649358735685633 0.3444947093407081 0 +6331 0.6563507518035588 0.968480477127994 0 +6332 0.3438470903451125 0.3352822169930034 0 +6333 0.7846591213531124 0.2109392890570578 0 +6334 0.4716644445157288 0.3739691298315787 0 +6335 0.4228418704013837 0.9332384780626863 0 +6336 0.1913493572774412 0.5408259296261344 0 +6337 0.567497376901861 0.8023005976760258 0 +6338 0.6803799500983272 0.9353434572378061 0 +6339 0.1037368249816808 0.6324260608175785 0 +6340 0.1716526032355223 0.03124332263960176 0 +6341 0.7511972241930672 0.947879337879003 0 +6342 0.439231919655537 0.9492351937372094 0 +6343 0.2488027758056975 0.9478793378792872 0 +6344 0.965504395590802 0.5904099382547773 0 +6345 0.967656143797107 0.9463513911221308 0 +6346 0.03234385620274456 0.9463513911223895 0 +6347 0.1756328411933805 0.7888298452515716 0 +6348 0.2673368496914528 0.02855629473711189 0 +6349 0.7551256621693062 0.4396925738925491 0 +6350 0.9896897475579267 0.7407944964099441 0 +6351 0.7267236158279676 0.1754203493847873 0 +6352 0.60499999999896 0.9938136098715409 0 +6353 0.9300753450844781 0.9618213126003649 0 +6354 0.06992465491520206 0.9618213126005473 0 +6355 0.4308538677866365 0.823036644090902 0 +6356 0.08629680137655263 0.7017798932678577 0 +6357 0.4811425021713306 0.6342452859358905 0 +6358 0.8191450947137391 0.9210143944226546 0 +6359 0.1808549052853985 0.9210143944230458 0 +6360 0.4358754931824698 0.8754198430916027 0 +6361 0.5182456290933604 0.1133798993822902 0 +6362 0.4825766282604916 0.838280330421889 0 +6363 0.8569381307064738 0.7073601113187453 0 +6364 0.5832877487235149 0.9079224501128582 0 +6365 0.752231861986284 0.8140591658968384 0 +6366 0.2483823238182461 0.8111444413816651 0 +6367 0.4748402020100503 0.73710331990127 0 +6368 0.9048094204626707 0.894825211517737 0 +6369 0.09519057953687157 0.8948252115181392 0 +6370 0.8255560879791803 0.8102017137198089 0 +6371 0.1743234606008982 0.810184696772691 0 +6372 0.8374873905116903 0.8737888158178195 0 +6373 0.1625126094875677 0.873788815818403 0 +6374 0.02219074874827395 0.3361360178525911 0 +6375 0.01097406181900513 0.7407167545006317 0 +6376 0.7516389930781849 0.590104263932285 0 +6377 0.2242967462670181 0.6452810889575507 0 +6378 0.4950459221766449 0.8392376099085417 0 +6379 0.3984085070442243 0.5281660354725078 0 +6380 0.01156730394974344 0.6860774803697711 0 +6381 0.986088175646557 0.7118783631533852 0 +6382 0.8657928523191034 0.6048829217868834 0 +6383 0.6439738897205766 0.9802117472394645 0 +6384 0.2193546507692148 0.7441433956056558 0 +6385 0.4230114121143904 0.7124918449873375 0 +6386 0.8826125813511808 0.9157254760989224 0 +6387 0.1173874186482778 0.915725476099269 0 +6388 0.991935032547563 0.8653412278269981 0 +6389 0.008064967452546848 0.8653412278266347 0 +6390 0.5610475018447693 0.2759214491862425 0 +6391 0.7326943079248691 0.9808386200190709 0 +6392 0.2673049891720315 0.9808369886967832 0 +6393 0.8803595284324484 0.803021122095158 0 +6394 0.1196267514121767 0.803166910150332 0 +6395 0.6597737841749968 0.3866181983904248 0 +6396 0.8917129256836749 0.7674543657317815 0 +6397 0.1096758534052287 0.7674153746936733 0 +6398 0.4839145513669044 0.8007984292649675 0 +6399 0.5064047794691722 0.6188830183316061 0 +6400 0.3774680246301512 0.8568493462621382 0 +6401 0.4233496355085098 0.9193483215721483 0 +6402 0.5419388840466115 0.6458534276784453 0 +6403 0.4734843705643608 0.9516200192284684 0 +6404 0.6796072993769848 0.7949580312441312 0 +6405 0.6630714201582779 0.4801672980704125 0 +6406 0.4269094953232503 0.9031369541496919 0 +6407 0.9743532421595236 0.05906473301752724 0 +6408 0.443653079336315 0.8197447468355771 0 +6409 0.4657093661322229 0.8224210496016053 0 +6410 0.02214804734856063 0.05756656695233538 0 +6411 0.04518436657069848 0.4448365800852037 0 +6412 0.4405349621675056 0.9212857727421284 0 +6413 0.5064911028343402 0.4269979208493212 0 +6414 0.5180792723670946 0.26657488697015 0 +6415 0.6592183879149851 0.8967528001138083 0 +6416 0.3213853280128152 0.7980164065876637 0 +6417 0.6602724446633699 0.5946903478502504 0 +6418 0.8831517133273188 0.7164062528314563 0 +6419 0.4477748381769112 0.3316018812847127 0 +6420 0.9813308827307092 0.4586420644641646 0 +6421 0.3428128593505421 0.6198811489552538 0 +6422 0.9549684104447458 0.829427452503545 0 +6423 0.0450315895552819 0.8294274525039227 0 +6424 0.7442921383815286 0.9605977477290166 0 +6425 0.255707861617196 0.9605977477292245 0 +6426 0.8169494782088523 0.9640225786602186 0 +6427 0.1830505217902751 0.9640225786604086 0 +6428 0.2135144022972898 0.4151861465824672 0 +6429 0.6163900519025433 0.8234128577684396 0 +6430 0.07528293265938624 0.06572426427804209 0 +6431 0.4974849890435264 0.884518857940666 0 +6432 0.1783195150987345 0.4209765738893247 0 +6433 0.4624523784436013 0.6040578060504072 0 +6434 0.01610502049553615 0.3834431176626261 0 +6435 0.9863854070588522 0.687837835665606 0 +6436 0.668060916338608 0.7085020647296366 0 +6437 0.7307401960308779 0.8711223654617439 0 +6438 0.2692598039678006 0.8711223654624148 0 +6439 0.5612018035338324 0.5496931231158786 0 +6440 0.2192137348029672 0.3129391967918615 0 +6441 0.1880783212429075 0.7530233173750209 0 +6442 0.6917762888318028 0.8004590473409308 0 +6443 0.8707784509831099 0.2927538840522453 0 +6444 0.9424639126140864 0.9374534562962801 0 +6445 0.0575360873856474 0.9374534562965848 0 +6446 0.3943730011985056 0.7751103522812213 0 +6447 0.382871226056025 0.5002088056001663 0 +6448 0.6091090444747299 0.5108287056275148 0 +6449 0.3100037925264222 0.8484021417646592 0 +6450 0.3252183999055006 0.9459716334558994 0 +6451 0.4925706348767705 0.6959461782716664 0 +6452 0.6671712609096726 0.9926857484668705 0 +6453 0.9526780493653846 0.9395857128929652 0 +6454 0.0473219506343954 0.9395857128932652 0 +6455 0.1132474556098102 0.4436983639391849 0 +6456 0.3222277501958591 0.9351453518882539 0 +6457 0.9390607936751252 0.7404641190859708 0 +6458 0.05997222805311914 0.7415336700381997 0 +6459 0.7272599168116305 0.9649780673374029 0 +6460 0.2727389256305353 0.9649753808344428 0 +6461 0.1999541558485375 0.4479518324789303 0 +6462 0.7373981159063427 0.698269809948557 0 +6463 0.4061037078376427 0.7126567952167566 0 +6464 0.2890064416359076 0.7633575515923605 0 +6465 0.3816596342374201 0.8830867314211348 0 +6466 0.3496229830130909 0.2237610303636746 0 +6467 0.6310029897735626 0.5807675913836314 0 +6468 0.8008631976994398 0.8718419059122373 0 +6469 0.199136802299661 0.8718419059127852 0 +6470 0.5538765120528422 0.7483458468966543 0 +6471 0.6511338722293347 0.9345809171900535 0 +6472 0.8915349426378543 0.0706291351205115 0 +6473 0.4031160674648214 0.8176972637217608 0 +6474 0.948616780129208 0.9215792751546641 0 +6475 0.05138321987055019 0.9215792751550497 0 +6476 0.9231448030892424 0.9550994489042466 0 +6477 0.07685519691040049 0.955099448904446 0 +6478 0.7429430633407066 0.9335076192808667 0 +6479 0.2570569366579983 0.9335076192812193 0 +6480 0.5537775005705127 0.8190302571040196 0 +6481 0.9047071391492656 0.9941035545695236 0 +6482 0.0952928608503061 0.9941035545695517 0 +6483 0.2543649893409036 0.2864806218974359 0 +6484 0.367503492728272 0.3839017933794195 0 +6485 0.937040248838351 0.5921509590686868 0 +6486 0.5166815006210972 0.6327889440440619 0 +6487 0.4822659178825715 0.947641572415893 0 +6488 0.8744284191183327 0.7288517164025466 0 +6489 0.3942556444174026 0.7504935588824091 0 +6490 0.1642397204950825 0.5933680337771168 0 +6491 0.44491571333083 0.3635647102158801 0 +6492 0.9058556520810827 0.2092979998065003 0 +6493 0.484271838214974 0.07669281189071092 0 +6494 0.3279361442400701 0.8692201788394408 0 +6495 0.6718077438556329 0.8691914479660977 0 +6496 0.6482565967760561 0.5757502165820171 0 +6497 0.6472522669911857 0.8794922195753708 0 +6498 0.9659003476169516 0.6718993186510462 0 +6499 0.904570788554885 0.4952619044713598 0 +6500 0.3543321397630168 0.9108800353864378 0 +6501 0.039635276363372 0.684027038989784 0 +6502 0.8495270593370046 0.7413451875113606 0 +6503 0.818780366756519 0.8501155041228401 0 +6504 0.181219633242622 0.8501155041235309 0 +6505 0.6125971012221488 0.3441031712309218 0 +6506 0.9166297775781016 0.8812386364656923 0 +6507 0.08337022242144665 0.881238636466144 0 +6508 0.5419545231780555 0.85948349595415 0 +6509 0.820178827954873 0.7726628995074729 0 +6510 0.5169352583644371 0.8853409982614923 0 +6511 0.7669456764703165 0.6317370653967171 0 +6512 0.3315645700482455 0.755441494095845 0 +6513 0.03691785022490375 0.6293907656708468 0 +6514 0.7768025517928405 0.2961074023118325 0 +6515 0.6361913366756571 0.2075699752013102 0 +6516 0.4255237898544705 0.8090895621572111 0 +6517 0.6624998589034812 0.4121134157190283 0 +6518 0.8012649015824076 0.957062614735515 0 +6519 0.1987350984166322 0.95706261473573 0 +6520 0.7719111229426365 0.9154111479306939 0 +6521 0.2280888770562273 0.9154111479311084 0 +6522 0.5945260725293604 0.6752441360005569 0 +6523 0.932079523506292 0.4459023691673281 0 +6524 0.9924645800713839 0.981952621283539 0 +6525 0.007535419928645174 0.9819526212835147 0 +6526 0.6326180622816568 0.6017339432895102 0 +6527 0.2181423126502171 0.06343693784746979 0 +6528 0.447105635968423 0.07089019923720694 0 +6529 0.4836027436856314 0.9373589646968054 0 +6530 0.6056472908183124 0.1193490380907222 0 +6531 0.5984046921388022 0.7440874874441638 0 +6532 0.8626451709730444 0.9927341814238891 0 +6533 0.1373548290263262 0.9927341814239249 0 +6534 0.9088397602258639 0.8025976775316572 0 +6535 0.09116023977425322 0.8025976775321431 0 +6536 0.1191262973600911 0.3209347914226852 0 +6537 0.4349999999988727 0.9941552206075657 0 +6538 0.01815489018788463 0.4298253096181582 0 +6539 0.3547298101904591 0.4872664057324401 0 +6540 0.7890157905340676 0.8715670325846575 0 +6541 0.2109842094649293 0.8715670325852649 0 +6542 0.3515876867366073 0.02839413361440976 0 +6543 0.7552080929691375 0.07391177022056089 0 +6544 0.5493353262272169 0.9068176387517832 0 +6545 0.3899595357852842 0.3180966474541168 0 +6546 0.7485610269854814 0.9850747777061489 0 +6547 0.2514389730132615 0.9850747777062335 0 +6548 0.8998836805192718 0.7210824593254657 0 +6549 0.9822707723809743 0.9926745955747883 0 +6550 0.01772922761894392 0.992674595574826 0 +6551 0.4771271945320248 0.509746063399322 0 +6552 0.03683793810592608 0.7408423412466355 0 +6553 0.7115193719627968 0.6834060849261692 0 +6554 0.8914440351618993 0.2366912191799572 0 +6555 0.08895432328866296 0.6043363887531636 0 +6556 0.1390011292999405 0.6055081360847195 0 +6557 0.318309354538049 0.9211087202726524 0 +6558 0.6057757520484961 0.8996631190274398 0 +6559 0.4909907908416776 0.9521901396904053 0 +6560 0.1327249167498417 0.2626263940550653 0 +6561 0.6252437054897088 0.474851759502124 0 +6562 0.4199185502209736 0.179009772817637 0 +6563 0.4878080579447625 0.5582766580784662 0 +6564 0.4949999999987035 0.9942153735171784 0 +6565 0.5314341593483533 0.7768441353297862 0 +6566 0.696475373578205 0.9281522822630039 0 +6567 0.3032441884255999 0.9287111735585016 0 +6568 0.5917679069639291 0.9247026376745592 0 +6569 0.9731101350107194 0.02619688720905929 0 +6570 0.3148827956826251 0.835308664927797 0 +6571 0.3157021579034817 0.9701536603195067 0 +6572 0.6088342022035876 0.4225233373108579 0 +6573 0.5627735131002845 0.6014679801226143 0 +6574 0.4884489972850536 0.592209890261098 0 +6575 0.3355135004633637 0.9080559978255061 0 +6576 0.2634190611023387 0.2112741555344346 0 +6577 0.2735449057935789 0.7939689908622549 0 +6578 0.6495554292062764 0.1373361397480107 0 +6579 0.6823718133647538 0.9212488184770301 0 +6580 0.09795769595890089 0.1893278789693392 0 +6581 0.463258060134103 0.0240661897796562 0 +6582 0.7181609636110693 0.3656536896347532 0 +6583 0.8006636332358388 0.9109564413999995 0 +6584 0.1993363667631913 0.9109564414004461 0 +6585 0.9178359124061537 0.4565521228870605 0 +6586 0.5123806667437912 0.6060145817196241 0 +6587 0.6978745888510598 0.4083350043559402 0 +6588 0.5667851584924556 0.8846193151840043 0 +6589 0.1988383168153688 0.7721356394067485 0 +6590 0.9484982635110809 0.6342481279118024 0 +6591 0.9450346727780163 0.9122098241854697 0 +6592 0.05496532722173066 0.9122098241858743 0 +6593 0.1953318765616371 0.6018412952763572 0 +6594 0.307937130920569 0.981509796236226 0 +6595 0.6283484546060126 0.8679910501272823 0 +6596 0.5563746354730387 0.6910671891851237 0 +6597 0.8432750014771186 0.6968732780804576 0 +6598 0.788038790953478 0.9211370802108884 0 +6599 0.2119612090454656 0.9211370802112625 0 +6600 0.5106167362319163 0.902856265668272 0 +6601 0.4712516001327157 0.7988663592987729 0 +6602 0.8046065040368635 0.1994148570440221 0 +6603 0.6670713869650707 0.9300345138306279 0 +6604 0.810969463931562 0.791209328262486 0 +6605 0.01367671649217349 0.5823626761259285 0 +6606 0.1888954306755098 0.79089046426461 0 +6607 0.7047379982519035 0.262049394844344 0 +6608 0.9330003063243931 0.0260490426663518 0 +6609 0.4490464874401406 0.9365766670555711 0 +6610 0.300387977216402 0.4077866922967438 0 +6611 0.7289102524111556 0.787423934882345 0 +6612 0.6594965402763332 0.6541304798492144 0 +6613 0.8891969970408153 0.5480116642992943 0 +6614 0.7093489087864021 0.8913621866329743 0 +6615 0.2906525739269096 0.8913680266175124 0 +6616 0.5224110482582377 0.9363101409879142 0 +6617 0.7989876924226123 0.8525122338238309 0 +6618 0.2010123075764199 0.8525122338245069 0 +6619 0.3504096282457654 0.9528293085959256 0 +6620 0.1733116636687725 0.07111518205423216 0 +6621 0.02043262147040368 0.129909699018045 0 +6622 0.2094526333527911 0.7277901300230397 0 +6623 0.4816432939004696 0.9664404227849315 0 +6624 0.7642306773248015 0.7551235557306384 0 +6625 0.7388548458075705 0.974903606364071 0 +6626 0.2611450944205587 0.9749034676463211 0 +6627 0.8401967566595296 0.9843584059743631 0 +6628 0.1598032433397239 0.9843584059744401 0 +6629 0.5391350882055082 0.893797280458878 0 +6630 0.1871761685091415 0.7666657530853439 0 +6631 0.9308170747407088 0.9751695119674313 0 +6632 0.06918292525897424 0.9751695119675508 0 +6633 0.5108094809672132 0.4989107242431162 0 +6634 0.7911076211501007 0.8905986826707868 0 +6635 0.2088923788488809 0.8905986826713153 0 +6636 0.5523092642064863 0.7633436783467096 0 +6637 0.7615659544950641 0.9843548155259948 0 +6638 0.2384340455037515 0.9843548155260819 0 +6639 0.8282970005507495 0.2369136654426892 0 +6640 0.9012190621443177 0.3281880357583806 0 +6641 0.9414747293286048 0.1061696936223508 0 +6642 0.7845666321789095 0.8813277004443212 0 +6643 0.2154333678200397 0.8813277004449072 0 +6644 0.2173831622482459 0.4366115635205965 0 +6645 0.7600851205097953 0.860150134446251 0 +6646 0.2399148794890137 0.8601501344469591 0 +6647 0.6802612745048597 0.9844225298744657 0 +6648 0.9770901146980364 0.8722321723074611 0 +6649 0.02290988530195938 0.8722321723077556 0 +6650 0.08551151665569097 0.4193697036825962 0 +6651 0.2417528459155418 0.1068198362699198 0 +6652 0.6041023465046114 0.6638889421181564 0 +6653 0.749570978978953 0.8031407904539349 0 +6654 0.4027718716169566 0.6061843258053174 0 +6655 0.6756027457940095 0.901624132900392 0 +6656 0.5635115441612308 0.8238289605599803 0 +6657 0.5514100332309702 0.7070054150113123 0 +6658 0.5032689494629519 0.8084064366397579 0 +6659 0.3230213936014273 0.3974974362755433 0 +6660 0.9840990794299644 0.4108999738560447 0 +6661 0.3336369372013982 0.5911065861016576 0 +6662 0.5534215020630087 0.8419582270587656 0 +6663 0.4632283530058339 0.993128708047006 0 +6664 0.9890369491462321 0.795021106111624 0 +6665 0.01096673043453134 0.7950169939024253 0 +6666 0.7818039726819528 0.9128323330718211 0 +6667 0.2181960273169647 0.9128323330722391 0 +6668 0.6180960775241193 0.3211410643028442 0 +6669 0.5759029633252564 0.7848061163192063 0 +6670 0.5767710866569102 0.9329572356351843 0 +6671 0.6447927259300555 0.7705956701481573 0 +6672 0.4920707506303865 0.8931632314955096 0 +6673 0.4535657012785081 0.9923629698145433 0 +6674 0.1035738905163261 0.7419033417138603 0 +6675 0.7589331041921556 0.6448811075543798 0 +6676 0.2589926166868647 0.4827892951420782 0 +6677 0.5233618025110964 0.8559212489707267 0 +6678 0.8984357146933586 0.9227849132304884 0 +6679 0.1015642853061893 0.922784913230797 0 +6680 0.1257692483172366 0.5643369170351394 0 +6681 0.7819950081319638 0.7720081901171176 0 +6682 0.6545172036265318 0.978749538450675 0 +6683 0.6594427486070474 0.6264198144126385 0 +6684 0.05026697552918476 0.3725688700601562 0 +6685 0.8895665698007109 0.9610003689350206 0 +6686 0.110433430198788 0.9610003689351907 0 +6687 0.46287458511524 0.8094021376383657 0 +6688 0.52623086104219 0.891101987263157 0 +6689 0.1325395762173428 0.5927349741393546 0 +6690 0.0666023973662442 0.7176994533555564 0 +6691 0.336499730557603 0.7119119586440044 0 +6692 0.6301044124957059 0.2483494304044573 0 +6693 0.7521529323398101 0.7333988599868804 0 +6694 0.7114534060577399 0.9414667617735508 0 +6695 0.2885480795022679 0.9414645857235606 0 +6696 0.3591118478107062 0.5748983808146626 0 +6697 0.3794581542969546 0.215337261244833 0 +6698 0.04020686349237851 0.5950048183471306 0 +6699 0.6520862684904453 0.9512587514792796 0 +6700 0.3718978540230424 0.8224739067924446 0 +6701 0.4912237162632543 0.5203501846261633 0 +6702 0.3869477057984436 0.8067183202712913 0 +6703 0.4105057549863959 0.2827865743266195 0 +6704 0.7188992548130976 0.6713121261323364 0 +6705 0.9518029917683537 0.4723611151007208 0 +6706 0.6958080085884265 0.682139829225727 0 +6707 0.3174699357598571 0.9933846345230167 0 +6708 0.532929919802712 0.8492498010239146 0 +6709 0.3409378191974214 0.5633015709998594 0 +6710 0.5952173169110354 0.4572378164393982 0 +6711 0.4188248705478702 0.4219964170354077 0 +6712 0.7423863205436088 0.5045202626503871 0 +6713 0.3737432113843632 0.9450101173682854 0 +6714 0.6738160504315371 0.852892507097576 0 +6715 0.7623595904511784 0.256513771540922 0 +6716 0.6855250954916079 0.853013639357209 0 +6717 0.3278765277805963 0.851813599845383 0 +6718 0.2887627417805465 0.5384835137986849 0 +6719 0.445250489921874 0.2597719908003852 0 +6720 0.2985745350355736 0.7570652841767203 0 +6721 0.3965918714231317 0.6745138283471713 0 +6722 0.9825331779320585 0.9408466714078552 0 +6723 0.01746682206786064 0.9408466714080721 0 +6724 0.8998377965604341 0.3618542925084314 0 +6725 0.4065604282643566 0.4657040561570563 0 +6726 0.6485803848497385 0.9642123191632734 0 +6727 0.6646631116615228 0.9829072291997077 0 +6728 0.2441931771914914 0.759161220988726 0 +6729 0.6237820842813855 0.99363360273653 0 +6730 0.901859873228126 0.6455352018923922 0 +6731 0.8833265805442831 0.1265927288464145 0 +6732 0.7224777983477447 0.3222497569524588 0 +6733 0.5618969147919434 0.9313568900528848 0 +6734 0.7307582257381997 0.8151998574431921 0 +6735 0.06112130690077722 0.5336376188265215 0 +6736 0.671083979239405 0.5195597660151929 0 +6737 0.3213283729808458 0.2695602393956572 0 +6738 0.6570079905113704 0.8513465529153551 0 +6739 0.7011419891802748 0.06338544996809298 0 +6740 0.4280024374052326 0.540087924558 0 +6741 0.5948134582854714 0.8709183122508209 0 +6742 0.6199827086546055 0.5607026883303017 0 +6743 0.4098344983046094 0.3575515305845621 0 +6744 0.4581440599172949 0.9092610320808461 0 +6745 0.2097794009036742 0.2923538163955446 0 +6746 0.7772450721031398 0.5797883493216154 0 +6747 0.5152095980918072 0.7762441364787964 0 +6748 0.2261519406534068 0.707711738676303 0 +6749 0.7071637205907428 0.9301394357732056 0 +6750 0.2929104965171199 0.9301982692601207 0 +6751 0.6083099832819225 0.9290498007356207 0 +6752 0.9625053588938423 0.9317683408803619 0 +6753 0.03749464110598044 0.9317683408806964 0 +6754 0.2519706746465499 0.6213447915594859 0 +6755 0.5803896600689098 0.449106706775037 0 +6756 0.3463972086376353 0.8044853223463491 0 +6757 0.352663800758624 0.5910305477234539 0 +6758 0.6428795980413851 0.4228012905138283 0 +6759 0.8155135703622042 0.9093101575987248 0 +6760 0.1844864296369316 0.909310157599179 0 +6761 0.1678328485177288 0.7094559114035998 0 +6762 0.2136605026644176 0.2508995892772614 0 +6763 0.342822623894377 0.8512571567537235 0 +6764 0.3319599848745503 0.4309272411997039 0 +6765 0.9048422835836263 0.7488320786978414 0 +6766 0.916933162180348 0.7680292901322764 0 +6767 0.08255757053370799 0.7680882334054386 0 +6768 0.3026010153428899 0.2296963999450379 0 +6769 0.1018943207013485 0.021930455996072 0 +6770 0.9803649682392158 0.9547032653283458 0 +6771 0.01963503176067325 0.9547032653284789 0 +6772 0.4173579675547279 0.8735478603315705 0 +6773 0.1538764942748083 0.1002582655892602 0 +6774 0.4124349766942169 0.6577215443962121 0 +6775 0.8277571756969513 0.706115307637001 0 +6776 0.8598985650529303 0.1989053392290047 0 +6777 0.6850151382346902 0.1915776231253989 0 +6778 0.7290345090116577 0.3973863850750134 0 +6779 0.4586735315647807 0.949545108478282 0 +6780 0.349800339583509 0.7525838919642293 0 +6781 0.5410296781911862 0.8383132905313038 0 +6782 0.1156201233532829 0.3934436309027852 0 +6783 0.07934808366443438 0.3061393845230359 0 +6784 0.4046361612299036 0.97776788716368 0 +6785 0.8604485016841972 0.1099232119932427 0 +6786 0.8992351932434026 0.9127883229711975 0 +6787 0.100764806756148 0.9127883229715283 0 +6788 0.4233463628764834 0.4572124065595486 0 +6789 0.05740976093161634 0.2091861795772333 0 +6790 0.5155876580543718 0.7450259992394939 0 +6791 0.3252089519402985 0.9024068172035483 0 +6792 0.9199602664800051 0.8496780391850802 0 +6793 0.08003973351974161 0.8496780391854616 0 +6794 0.5622274229764801 0.9926837374498252 0 +6795 0.8897550831846748 0.9685496978647115 0 +6796 0.1102449168148263 0.9685496978648502 0 +6797 0.3017745862541619 0.9635311791214831 0 +6798 0.09502109108185126 0.1064423975467702 0 +6799 0.01622069216939914 0.4665540483538027 0 +6800 0.6588643572833839 0.7540580731813238 0 +6801 0.5619516540036378 0.8613614469056544 0 +6802 0.5706159749036831 0.8416214782444965 0 +6803 0.7904892999037734 0.7989565378477912 0 +6804 0.2080490447587144 0.7987590843925634 0 +6805 0.3647971374189607 0.6591589321628462 0 +6806 0.7853335658370393 0.07344613572966954 0 +6807 0.7930739229299689 0.5704025813694049 0 +6808 0.2388404337277757 0.7834971020069456 0 +6809 0.5223465334403157 0.7976109193073198 0 +6810 0.5049206049707629 0.8498228797023026 0 +6811 0.7097179827047446 0.877270579606622 0 +6812 0.2914959012247091 0.8781723971882532 0 +6813 0.6469128432066 0.9116822366817108 0 +6814 0.6650798110113629 0.9686876561214044 0 +6815 0.2085197514699737 0.764703348885112 0 +6816 0.6831089643982893 0.9697452431576961 0 +6817 0.3558417595316684 0.4354162256956124 0 +6818 0.1668726529308726 0.1521091256173084 0 +6819 0.4807050737686537 0.9755477481927397 0 +6820 0.6004809541322915 0.9588794822916107 0 +6821 0.9652659119419035 0.8375115346728885 0 +6822 0.03473408805813526 0.8375115346732529 0 +6823 0.7246821858193367 0.3006995368549166 0 +6824 0.2003294848873986 0.5783731580813557 0 +6825 0.6051416682464565 0.1671019932227034 0 +6826 0.5948100679461268 0.7949769616858279 0 +6827 0.8269710067689453 0.9443530929925135 0 +6828 0.1730289932302107 0.9443530929927816 0 +6829 0.5832613032204457 0.8576161856133688 0 +6830 0.7465664858146459 0.7884652409489441 0 +6831 0.7107318966585251 0.7269509291223657 0 +6832 0.3449100714118967 0.8777188562822584 0 +6833 0.423727675336217 0.9732642585492053 0 +6834 0.3538583949258162 0.0579128551780216 0 +6835 0.3402079553212328 0.9859243904577776 0 +6836 0.6588846266855704 0.8658122097075471 0 +6837 0.1188406485604429 0.6795013485358388 0 +6838 0.4436694132091898 0.8941034159572521 0 +6839 0.8372420105784895 0.9565895184844666 0 +6840 0.1627579894207511 0.9565895184846849 0 +6841 0.6703482771090359 0.7340026467072673 0 +6842 0.7622107525866266 0.5576160784273916 0 +6843 0.6115141005787006 0.7829170068460762 0 +6844 0.4004278830130605 0.8672879591025466 0 +6845 0.1859666182025478 0.66600658518501 0 +6846 0.8937582586603162 0.6188822512461543 0 +6847 0.7941484383949626 0.9591484231839131 0 +6848 0.2058515616040369 0.9591484231841161 0 +6849 0.3425890733058139 0.9494190361620773 0 +6850 0.341010704633642 0.8668499970500529 0 +6851 0.7184295608991159 0.5552759826384506 0 +6852 0.2682028032893441 0.8161732496084024 0 +6853 0.02231716424032599 0.2090477551965585 0 +6854 0.6353942501579778 0.9402496613779421 0 +6855 0.8859093443673145 0.8907638803217609 0 +6856 0.1140906556321759 0.8907638803222396 0 +6857 0.9840619579436671 0.4830777426841575 0 +6858 0.6457459206867735 0.9421596529098932 0 +6859 0.7145121736354604 0.7704389390371577 0 +6860 0.3717370633605831 0.6206036885405819 0 +6861 0.09097106369837873 0.7490132434965469 0 +6862 0.8258916957984384 0.9813953935612247 0 +6863 0.1741083042007426 0.98139539356132 0 +6864 0.9662919546109843 0.9760462582032425 0 +6865 0.03370804538887689 0.9760462582033287 0 +6866 0.3163927192646488 0.4910890885180618 0 +6867 0.7182110282624843 0.8700570185138722 0 +6868 0.4422994197913842 0.9094916100692993 0 +6869 0.282341095223438 0.8693478919265135 0 +6870 0.9444131310194506 0.07164717445536233 0 +6871 0.9587310866551868 0.9819026016004961 0 +6872 0.04126891334463132 0.981902601600569 0 +6873 0.324999999999193 0.9947434832496781 0 +6874 0.9029938010410632 0.8761649606763136 0 +6875 0.09700619895847593 0.876164960676818 0 +6876 0.4587445203388341 0.5169717784668301 0 +6877 0.9302216385609372 0.2155059067264443 0 +6878 0.7517260191199886 0.9389470498072769 0 +6879 0.2482739808787671 0.9389470498076 0 +6880 0.698352917761956 0.9635062058342826 0 +6881 0.5632955086964034 0.9725215938025416 0 +6882 0.757224642862057 0.6161679417604867 0 +6883 0.5302045553881035 0.8158399711420513 0 +6884 0.5814495057280464 0.2792721153958804 0 +6885 0.6232925723728394 0.7029143649470239 0 +6886 0.4476954214836478 0.6714163966906638 0 +6887 0.2909771854514417 0.3730759818895937 0 +6888 0.2071896777457166 0.7527878251878825 0 +6889 0.8798649044958593 0.5301340888974828 0 +6890 0.5259070022463388 0.7554785619125164 0 +6891 0.3693522621584778 0.35039984772135 0 +6892 0.4931536427206055 0.7233487344005428 0 +6893 0.6278501831965418 0.9622442200706115 0 +6894 0.4997962661269922 0.9264832997263849 0 +6895 0.598933072295362 0.9833281956740179 0 +6896 0.4721360591828087 0.8766964959106855 0 +6897 0.9940766167724617 0.9940854541448928 0 +6898 0.005923383227486876 0.9940854541449153 0 +6899 0.8761374176936352 0.1544572163509063 0 +6900 0.908772960886491 0.5474977125077283 0 +6901 0.3860531776682846 0.3868763090548055 0 +6902 0.588930707954072 0.9683619005881137 0 +6903 0.8669417921196676 0.9024465215931896 0 +6904 0.1330582078797185 0.9024465215936135 0 +6905 0.957505794180068 0.4284731129848685 0 +6906 0.0165758373571964 0.2640252395595565 0 +6907 0.7249307119908435 0.4926279194479312 0 +6908 0.9479228485807385 0.9933361663619699 0 +6909 0.05207715141902278 0.9933361663620051 0 +6910 0.839602156838228 0.6409409638797224 0 +6911 0.2018467404899029 0.706610279448832 0 +6912 0.7258034849925826 0.9939304226439105 0 +6913 0.2741959262936019 0.9939308064896882 0 +6914 0.8455833518701452 0.9692127015021581 0 +6915 0.1544166481291392 0.969212701502308 0 +6916 0.9549999999998791 0.9948182723071408 0 +6917 0.04499999999991076 0.9948182723071696 0 +6918 0.7447387860532401 0.3334441950757261 0 +6919 0.06793672689257146 0.1172413896250261 0 +6920 0.1785834430330775 0.6370276931458337 0 +6921 0.1901854048629482 0.7136846765650714 0 +6922 0.8810325354342584 0.7553888159567144 0 +6923 0.1999002653539884 0.08200463575744571 0 +6924 0.9778318076196332 0.9256486021750443 0 +6925 0.022168192380318 0.9256486021753272 0 +6926 0.9394234736923056 0.9286893899773139 0 +6927 0.06057652630741465 0.9286893899776602 0 +6928 0.885826109873656 0.9940698237866175 0 +6929 0.1141738901258306 0.9940698237866371 0 +6930 0.4201834143411851 0.8624802984511563 0 +6931 0.9831249004438398 0.1656047159753248 0 +6932 0.1013461851060371 0.5438455013019815 0 +6933 0.5678589423476813 0.9035408438357887 0 +6934 0.633799012783411 0.3576860418045682 0 +6935 0.515968038399224 0.07017383514301968 0 +6936 0.580155979149661 0.6731467271356988 0 +6937 0.5365653585170682 0.6177835000554653 0 +6938 0.711666410482567 0.61904464466156 0 +6939 0.9260915493752686 0.7179179520745446 0 +6940 0.9386542266650957 0.3429755060131074 0 +6941 0.5361446430829958 0.3575027815654246 0 +6942 0.9268127292239782 0.9935376419023252 0 +6943 0.07318727077568925 0.9935376419023575 0 +6944 0.8605363563392761 0.8334774991313469 0 +6945 0.139463643660086 0.8334774991321354 0 +6946 0.08818875022026124 0.6608347122434403 0 +6947 0.6909819564264047 0.5960408268170451 0 +6948 0.9093527511140528 0.8213763201355837 0 +6949 0.09064724888587261 0.821376320136006 0 +6950 0.67919961801942 0.7824700785904976 0 +6951 0.4654583305452509 0.9372386365793303 0 +6952 0.3071254396940266 0.4582742234811892 0 +6953 0.2184616781543798 0.2091488480151026 0 +$EndNodes +$Elements +13766 +1 1 2 14 7 4 239 +2 1 2 14 7 239 240 +3 1 2 14 7 240 241 +4 1 2 14 7 241 242 +5 1 2 14 7 242 243 +6 1 2 14 7 243 244 +7 1 2 14 7 244 245 +8 1 2 14 7 245 246 +9 1 2 14 7 246 247 +10 1 2 14 7 247 248 +11 1 2 14 7 248 249 +12 1 2 14 7 249 250 +13 1 2 14 7 250 251 +14 1 2 14 7 251 252 +15 1 2 14 7 252 253 +16 1 2 14 7 253 254 +17 1 2 14 7 254 255 +18 1 2 14 7 255 256 +19 1 2 14 7 256 257 +20 1 2 14 7 257 258 +21 1 2 14 7 258 259 +22 1 2 14 7 259 260 +23 1 2 14 7 260 261 +24 1 2 14 7 261 262 +25 1 2 14 7 262 263 +26 1 2 14 7 263 264 +27 1 2 14 7 264 265 +28 1 2 14 7 265 266 +29 1 2 14 7 266 267 +30 1 2 14 7 267 268 +31 1 2 14 7 268 269 +32 1 2 14 7 269 270 +33 1 2 14 7 270 271 +34 1 2 14 7 271 272 +35 1 2 14 7 272 273 +36 1 2 14 7 273 274 +37 1 2 14 7 274 275 +38 1 2 14 7 275 276 +39 1 2 14 7 276 277 +40 1 2 14 7 277 278 +41 1 2 14 7 278 279 +42 1 2 14 7 279 280 +43 1 2 14 7 280 281 +44 1 2 14 7 281 282 +45 1 2 14 7 282 283 +46 1 2 14 7 283 284 +47 1 2 14 7 284 285 +48 1 2 14 7 285 286 +49 1 2 14 7 286 287 +50 1 2 14 7 287 288 +51 1 2 14 7 288 289 +52 1 2 14 7 289 290 +53 1 2 14 7 290 291 +54 1 2 14 7 291 292 +55 1 2 14 7 292 293 +56 1 2 14 7 293 294 +57 1 2 14 7 294 295 +58 1 2 14 7 295 296 +59 1 2 14 7 296 297 +60 1 2 14 7 297 298 +61 1 2 14 7 298 299 +62 1 2 14 7 299 300 +63 1 2 14 7 300 301 +64 1 2 14 7 301 302 +65 1 2 14 7 302 303 +66 1 2 14 7 303 304 +67 1 2 14 7 304 305 +68 1 2 14 7 305 306 +69 1 2 14 7 306 307 +70 1 2 14 7 307 308 +71 1 2 14 7 308 309 +72 1 2 14 7 309 310 +73 1 2 14 7 310 311 +74 1 2 14 7 311 312 +75 1 2 14 7 312 313 +76 1 2 14 7 313 314 +77 1 2 14 7 314 315 +78 1 2 14 7 315 316 +79 1 2 14 7 316 317 +80 1 2 14 7 317 318 +81 1 2 14 7 318 319 +82 1 2 14 7 319 320 +83 1 2 14 7 320 321 +84 1 2 14 7 321 322 +85 1 2 14 7 322 323 +86 1 2 14 7 323 324 +87 1 2 14 7 324 325 +88 1 2 14 7 325 326 +89 1 2 14 7 326 327 +90 1 2 14 7 327 328 +91 1 2 14 7 328 329 +92 1 2 14 7 329 330 +93 1 2 14 7 330 331 +94 1 2 14 7 331 332 +95 1 2 14 7 332 333 +96 1 2 14 7 333 334 +97 1 2 14 7 334 335 +98 1 2 14 7 335 336 +99 1 2 14 7 336 337 +100 1 2 14 7 337 3 +101 2 2 12 9 3448 589 1338 +102 2 2 12 9 3016 478 1519 +103 2 2 12 9 3017 1520 479 +104 2 2 12 9 1457 589 3448 +105 2 2 12 9 1427 3016 1519 +106 2 2 12 9 1428 1520 3017 +107 2 2 12 9 1161 1683 2226 +108 2 2 12 9 2226 1683 537 +109 2 2 12 9 2900 1547 1716 +110 2 2 12 9 2901 1717 1548 +111 2 2 12 9 1757 2521 463 +112 2 2 12 9 2707 1691 339 +113 2 2 12 9 1469 1792 3397 +114 2 2 12 9 689 1547 2900 +115 2 2 12 9 690 2901 1548 +116 2 2 12 9 1289 3195 1989 +117 2 2 12 9 1235 1691 2707 +118 2 2 12 9 2521 1564 463 +119 2 2 12 9 3384 833 1522 +120 2 2 12 9 815 1459 3596 +121 2 2 12 9 816 3597 1460 +122 2 2 12 9 1497 3384 1522 +123 2 2 12 9 3642 1449 390 +124 2 2 12 9 3072 388 2197 +125 2 2 12 9 2150 758 3553 +126 2 2 12 9 3596 1459 1560 +127 2 2 12 9 3597 1561 1460 +128 2 2 12 9 3500 1579 1378 +129 2 2 12 9 302 303 1963 +130 2 2 12 9 1537 3642 390 +131 2 2 12 9 1479 1544 3520 +132 2 2 12 9 1507 383 3600 +133 2 2 12 9 613 3500 1378 +134 2 2 12 9 1792 599 3397 +135 2 2 12 9 1806 3180 1327 +136 2 2 12 9 1238 2714 1612 +137 2 2 12 9 303 2976 1963 +138 2 2 12 9 2685 798 1114 +139 2 2 12 9 2714 358 1612 +140 2 2 12 9 3488 1789 1506 +141 2 2 12 9 1949 685 2543 +142 2 2 12 9 3643 1405 679 +143 2 2 12 9 1684 428 2926 +144 2 2 12 9 2838 1629 843 +145 2 2 12 9 1418 3643 679 +146 2 2 12 9 798 1950 1114 +147 2 2 12 9 2639 723 1560 +148 2 2 12 9 2640 1561 724 +149 2 2 12 9 3520 1544 699 +150 2 2 12 9 3600 383 1317 +151 2 2 12 9 1989 3195 627 +152 2 2 12 9 1220 1886 2922 +153 2 2 12 9 1327 3180 612 +154 2 2 12 9 2543 685 1631 +155 2 2 12 9 1851 2860 929 +156 2 2 12 9 1059 3488 1506 +157 2 2 12 9 1310 3130 1556 +158 2 2 12 9 3382 709 1162 +159 2 2 12 9 261 2731 1843 +160 2 2 12 9 315 1844 2732 +161 2 2 12 9 3163 454 1888 +162 2 2 12 9 3164 1889 455 +163 2 2 12 9 760 2195 1133 +164 2 2 12 9 761 1134 2196 +165 2 2 12 9 576 2045 1512 +166 2 2 12 9 1773 1944 2999 +167 2 2 12 9 1033 2720 1997 +168 2 2 12 9 1034 2000 2721 +169 2 2 12 9 672 1617 1202 +170 2 2 12 9 345 1444 2323 +171 2 2 12 9 3116 1585 614 +172 2 2 12 9 3117 615 1586 +173 2 2 12 9 529 1191 1778 +174 2 2 12 9 638 1353 1564 +175 2 2 12 9 450 1619 1222 +176 2 2 12 9 649 1996 1210 +177 2 2 12 9 1422 1589 3013 +178 2 2 12 9 1775 723 2639 +179 2 2 12 9 1776 2640 724 +180 2 2 12 9 3341 2508 1081 +181 2 2 12 9 3342 1082 2509 +182 2 2 12 9 638 1351 2306 +183 2 2 12 9 786 1964 2278 +184 2 2 12 9 785 1609 2277 +185 2 2 12 9 786 2278 1610 +186 2 2 12 9 712 2535 1236 +187 2 2 12 9 908 1758 2018 +188 2 2 12 9 785 2277 1988 +189 2 2 12 9 672 1202 1641 +190 2 2 12 9 653 1860 1664 +191 2 2 12 9 1343 1585 3116 +192 2 2 12 9 1344 3117 1586 +193 2 2 12 9 605 1276 2437 +194 2 2 12 9 445 3113 1199 +195 2 2 12 9 1115 1373 2964 +196 2 2 12 9 1821 2218 3590 +197 2 2 12 9 775 1135 2139 +198 2 2 12 9 2461 2963 659 +199 2 2 12 9 1403 1684 2926 +200 2 2 12 9 284 285 1484 +201 2 2 12 9 850 1657 1724 +202 2 2 12 9 1306 1629 2838 +203 2 2 12 9 760 1133 2991 +204 2 2 12 9 638 2306 1353 +205 2 2 12 9 761 2992 1134 +206 2 2 12 9 2963 1527 659 +207 2 2 12 9 3553 758 1231 +208 2 2 12 9 1295 2860 1851 +209 2 2 12 9 671 1265 1584 +210 2 2 12 9 725 1549 1291 +211 2 2 12 9 474 1731 1614 +212 2 2 12 9 681 2854 1221 +213 2 2 12 9 1106 1965 2715 +214 2 2 12 9 967 2768 1329 +215 2 2 12 9 431 1693 1187 +216 2 2 12 9 423 1289 1989 +217 2 2 12 9 662 1453 1330 +218 2 2 12 9 1349 3072 2197 +219 2 2 12 9 717 3230 1209 +220 2 2 12 9 226 1682 3276 +221 2 2 12 9 1624 2259 2647 +222 2 2 12 9 1329 2944 3269 +223 2 2 12 9 838 1581 1356 +224 2 2 12 9 3130 609 1556 +225 2 2 12 9 758 1951 1231 +226 2 2 12 9 694 1265 2983 +227 2 2 12 9 788 1155 3495 +228 2 2 12 9 1162 709 2060 +229 2 2 12 9 709 1422 3013 +230 2 2 12 9 704 1683 2488 +231 2 2 12 9 593 1357 1793 +232 2 2 12 9 594 1794 1358 +233 2 2 12 9 671 2457 1265 +234 2 2 12 9 3350 1648 1867 +235 2 2 12 9 656 2218 1821 +236 2 2 12 9 401 1231 1951 +237 2 2 12 9 570 1275 3428 +238 2 2 12 9 689 1846 1167 +239 2 2 12 9 690 1168 1847 +240 2 2 12 9 624 1415 1391 +241 2 2 12 9 625 1392 1416 +242 2 2 12 9 1174 2609 2421 +243 2 2 12 9 451 1547 1313 +244 2 2 12 9 452 1314 1548 +245 2 2 12 9 1665 2280 2815 +246 2 2 12 9 542 1374 1987 +247 2 2 12 9 257 258 1322 +248 2 2 12 9 318 319 1323 +249 2 2 12 9 849 2825 1286 +250 2 2 12 9 798 1714 1462 +251 2 2 12 9 628 1991 1315 +252 2 2 12 9 608 1291 3393 +253 2 2 12 9 566 2179 1176 +254 2 2 12 9 300 2381 1475 +255 2 2 12 9 493 1467 2341 +256 2 2 12 9 541 1804 1187 +257 2 2 12 9 616 1914 2811 +258 2 2 12 9 606 1572 1355 +259 2 2 12 9 775 2308 1135 +260 2 2 12 9 350 2163 1278 +261 2 2 12 9 470 1648 1221 +262 2 2 12 9 1763 3239 2537 +263 2 2 12 9 1291 1549 3393 +264 2 2 12 9 969 1654 2758 +265 2 2 12 9 970 2759 1655 +266 2 2 12 9 2944 430 3269 +267 2 2 12 9 300 301 2381 +268 2 2 12 9 2922 1886 600 +269 2 2 12 9 556 2201 1573 +270 2 2 12 9 888 1490 1492 +271 2 2 12 9 229 230 1311 +272 2 2 12 9 946 2084 1627 +273 2 2 12 9 1324 3163 1888 +274 2 2 12 9 1325 1889 3164 +275 2 2 12 9 931 1512 2045 +276 2 2 12 9 862 1290 1987 +277 2 2 12 9 733 1694 1890 +278 2 2 12 9 734 1891 1695 +279 2 2 12 9 1461 3504 2079 +280 2 2 12 9 637 1434 1568 +281 2 2 12 9 1205 3276 1682 +282 2 2 12 9 1941 3228 2525 +283 2 2 12 9 1942 2526 3229 +284 2 2 12 9 1066 1941 2525 +285 2 2 12 9 1067 2526 1942 +286 2 2 12 9 529 1985 1191 +287 2 2 12 9 563 1752 1150 +288 2 2 12 9 754 1781 2119 +289 2 2 12 9 782 1181 2259 +290 2 2 12 9 870 1923 1866 +291 2 2 12 9 930 1966 1335 +292 2 2 12 9 541 1187 1993 +293 2 2 12 9 1645 3533 2866 +294 2 2 12 9 466 1724 1657 +295 2 2 12 9 837 1944 1773 +296 2 2 12 9 674 1749 1243 +297 2 2 12 9 694 2983 1312 +298 2 2 12 9 718 1739 1171 +299 2 2 12 9 616 3304 1914 +300 2 2 12 9 340 1270 2593 +301 2 2 12 9 292 293 1506 +302 2 2 12 9 505 1244 1835 +303 2 2 12 9 284 1484 2932 +304 2 2 12 9 772 1557 1754 +305 2 2 12 9 663 1710 2266 +306 2 2 12 9 664 2267 1711 +307 2 2 12 9 538 1188 2207 +308 2 2 12 9 493 2341 2686 +309 2 2 12 9 969 2839 1654 +310 2 2 12 9 970 1655 2840 +311 2 2 12 9 1099 2944 1329 +312 2 2 12 9 478 1502 1519 +313 2 2 12 9 479 1520 1503 +314 2 2 12 9 1698 2410 3081 +315 2 2 12 9 1103 2205 2807 +316 2 2 12 9 2411 1699 3082 +317 2 2 12 9 1502 2404 3608 +318 2 2 12 9 1503 3609 2405 +319 2 2 12 9 630 2047 1662 +320 2 2 12 9 631 1663 2048 +321 2 2 12 9 681 1221 1648 +322 2 2 12 9 679 1237 3062 +323 2 2 12 9 704 2488 1681 +324 2 2 12 9 539 1156 2286 +325 2 2 12 9 1389 3580 2393 +326 2 2 12 9 501 1627 2084 +327 2 2 12 9 233 2615 1232 +328 2 2 12 9 825 3515 1434 +329 2 2 12 9 787 3573 1177 +330 2 2 12 9 597 2062 1492 +331 2 2 12 9 849 1215 2466 +332 2 2 12 9 422 1433 1462 +333 2 2 12 9 399 3203 1850 +334 2 2 12 9 1372 3453 1815 +335 2 2 12 9 712 1236 2523 +336 2 2 12 9 733 1890 1550 +337 2 2 12 9 734 1551 1891 +338 2 2 12 9 456 1250 3301 +339 2 2 12 9 606 1244 1572 +340 2 2 12 9 538 2964 1373 +341 2 2 12 9 1404 2585 2353 +342 2 2 12 9 557 1204 1822 +343 2 2 12 9 3453 444 1815 +344 2 2 12 9 562 1229 1658 +345 2 2 12 9 564 1659 1230 +346 2 2 12 9 3583 1394 2990 +347 2 2 12 9 354 1645 2866 +348 2 2 12 9 2952 845 1642 +349 2 2 12 9 722 2131 1618 +350 2 2 12 9 442 2280 1665 +351 2 2 12 9 3533 1204 2866 +352 2 2 12 9 837 1282 2113 +353 2 2 12 9 422 1489 1530 +354 2 2 12 9 679 1666 1237 +355 2 2 12 9 792 3316 1336 +356 2 2 12 9 397 1203 2081 +357 2 2 12 9 790 1286 2204 +358 2 2 12 9 1412 3080 1919 +359 2 2 12 9 1008 3590 2218 +360 2 2 12 9 862 1987 1374 +361 2 2 12 9 749 1216 1931 +362 2 2 12 9 856 2202 1296 +363 2 2 12 9 695 1594 1381 +364 2 2 12 9 857 1297 2203 +365 2 2 12 9 721 1530 1489 +366 2 2 12 9 1215 1336 3316 +367 2 2 12 9 1381 1594 3576 +368 2 2 12 9 605 2437 1386 +369 2 2 12 9 434 1200 3287 +370 2 2 12 9 435 3288 1201 +371 2 2 12 9 1077 2219 1897 +372 2 2 12 9 1078 1898 2220 +373 2 2 12 9 391 2346 1374 +374 2 2 12 9 696 1462 1433 +375 2 2 12 9 412 2856 2393 +376 2 2 12 9 539 3389 1156 +377 2 2 12 9 2033 2508 3341 +378 2 2 12 9 2034 3342 2509 +379 2 2 12 9 345 2323 2532 +380 2 2 12 9 1396 2466 2342 +381 2 2 12 9 675 1316 1756 +382 2 2 12 9 1434 3515 1568 +383 2 2 12 9 892 1564 1353 +384 2 2 12 9 849 1396 2825 +385 2 2 12 9 40 2169 2126 +386 2 2 12 9 181 2127 2170 +387 2 2 12 9 3251 2523 668 +388 2 2 12 9 570 3428 1515 +389 2 2 12 9 1962 1555 3206 +390 2 2 12 9 1075 2119 1781 +391 2 2 12 9 695 1258 3072 +392 2 2 12 9 3617 561 2583 +393 2 2 12 9 718 1171 2247 +394 2 2 12 9 666 2489 1364 +395 2 2 12 9 873 1748 1255 +396 2 2 12 9 3627 1837 598 +397 2 2 12 9 1205 3222 2291 +398 2 2 12 9 538 2032 1188 +399 2 2 12 9 782 1887 1181 +400 2 2 12 9 749 2954 1216 +401 2 2 12 9 529 3376 1252 +402 2 2 12 9 692 1724 2670 +403 2 2 12 9 546 2626 1157 +404 2 2 12 9 547 1158 2627 +405 2 2 12 9 634 1262 2695 +406 2 2 12 9 1033 1997 2979 +407 2 2 12 9 1034 2980 2000 +408 2 2 12 9 863 1614 1731 +409 2 2 12 9 743 1199 1685 +410 2 2 12 9 910 1257 2714 +411 2 2 12 9 739 1519 1502 +412 2 2 12 9 740 1503 1520 +413 2 2 12 9 779 2073 1688 +414 2 2 12 9 426 1459 2301 +415 2 2 12 9 427 2302 1460 +416 2 2 12 9 888 1492 2062 +417 2 2 12 9 677 3136 1307 +418 2 2 12 9 592 1449 2596 +419 2 2 12 9 397 2190 1203 +420 2 2 12 9 293 2959 1506 +421 2 2 12 9 562 1924 1229 +422 2 2 12 9 564 1230 1925 +423 2 2 12 9 438 1492 1490 +424 2 2 12 9 555 2421 2609 +425 2 2 12 9 447 1356 1581 +426 2 2 12 9 403 1287 2023 +427 2 2 12 9 404 2024 1288 +428 2 2 12 9 608 2917 1417 +429 2 2 12 9 541 2633 1804 +430 2 2 12 9 882 1349 2197 +431 2 2 12 9 1017 1573 2201 +432 2 2 12 9 642 2254 2684 +433 2 2 12 9 1664 1860 2891 +434 2 2 12 9 408 1897 2219 +435 2 2 12 9 409 2220 1898 +436 2 2 12 9 546 1157 2255 +437 2 2 12 9 547 2256 1158 +438 2 2 12 9 443 1986 2099 +439 2 2 12 9 702 1723 1691 +440 2 2 12 9 1296 2202 3087 +441 2 2 12 9 1297 3088 2203 +442 2 2 12 9 1279 2523 3251 +443 2 2 12 9 670 1577 1372 +444 2 2 12 9 1309 2952 1642 +445 2 2 12 9 357 1243 1749 +446 2 2 12 9 395 1745 1214 +447 2 2 12 9 722 2485 3021 +448 2 2 12 9 1220 2670 1724 +449 2 2 12 9 1132 3029 2168 +450 2 2 12 9 362 2259 2247 +451 2 2 12 9 542 1162 2060 +452 2 2 12 9 288 289 1360 +453 2 2 12 9 1700 432 3033 +454 2 2 12 9 3034 433 1701 +455 2 2 12 9 357 2913 1186 +456 2 2 12 9 377 2524 3057 +457 2 2 12 9 634 3475 1262 +458 2 2 12 9 723 2410 1698 +459 2 2 12 9 724 1699 2411 +460 2 2 12 9 922 1624 2647 +461 2 2 12 9 1095 2537 3239 +462 2 2 12 9 457 2466 1215 +463 2 2 12 9 1004 1662 2047 +464 2 2 12 9 1005 2048 1663 +465 2 2 12 9 1001 2208 2360 +466 2 2 12 9 870 1866 1371 +467 2 2 12 9 1106 2968 1965 +468 2 2 12 9 512 1269 1789 +469 2 2 12 9 398 1219 1751 +470 2 2 12 9 854 1278 2163 +471 2 2 12 9 790 1447 1881 +472 2 2 12 9 632 1728 1256 +473 2 2 12 9 681 1648 3350 +474 2 2 12 9 1555 999 3206 +475 2 2 12 9 922 1684 1403 +476 2 2 12 9 1373 2841 1702 +477 2 2 12 9 620 1206 1838 +478 2 2 12 9 760 1574 1625 +479 2 2 12 9 761 1626 1575 +480 2 2 12 9 406 2883 1342 +481 2 2 12 9 434 1625 1574 +482 2 2 12 9 1064 1417 3047 +483 2 2 12 9 435 1575 1626 +484 2 2 12 9 439 1653 1516 +485 2 2 12 9 428 1684 1577 +486 2 2 12 9 563 1150 2324 +487 2 2 12 9 693 1394 3583 +488 2 2 12 9 3438 656 2109 +489 2 2 12 9 3608 2404 650 +490 2 2 12 9 3609 651 2405 +491 2 2 12 9 763 1516 1653 +492 2 2 12 9 1329 2768 2931 +493 2 2 12 9 662 1294 2804 +494 2 2 12 9 3576 1594 645 +495 2 2 12 9 1318 2266 3324 +496 2 2 12 9 1319 3325 2267 +497 2 2 12 9 997 2266 1710 +498 2 2 12 9 998 1711 2267 +499 2 2 12 9 3475 2050 1262 +500 2 2 12 9 966 1326 2777 +501 2 2 12 9 470 1221 2505 +502 2 2 12 9 930 2367 1966 +503 2 2 12 9 1304 3102 2077 +504 2 2 12 9 273 2059 2903 +505 2 2 12 9 572 2654 1241 +506 2 2 12 9 573 1242 2655 +507 2 2 12 9 477 1754 1557 +508 2 2 12 9 505 2723 1244 +509 2 2 12 9 1144 1417 2917 +510 2 2 12 9 722 3021 1630 +511 2 2 12 9 230 2076 1311 +512 2 2 12 9 639 1727 2257 +513 2 2 12 9 717 1209 1757 +514 2 2 12 9 434 2712 1200 +515 2 2 12 9 435 1201 2713 +516 2 2 12 9 1304 2020 3047 +517 2 2 12 9 387 2018 1758 +518 2 2 12 9 576 1237 1666 +519 2 2 12 9 3129 1504 696 +520 2 2 12 9 834 1691 1723 +521 2 2 12 9 689 1167 2364 +522 2 2 12 9 690 2365 1168 +523 2 2 12 9 424 1620 3003 +524 2 2 12 9 608 3168 1291 +525 2 2 12 9 3047 2020 1064 +526 2 2 12 9 1459 2754 2301 +527 2 2 12 9 1460 2302 2755 +528 2 2 12 9 900 2292 1225 +529 2 2 12 9 1215 3372 1336 +530 2 2 12 9 1103 3249 2205 +531 2 2 12 9 511 1827 1291 +532 2 2 12 9 1130 2388 2001 +533 2 2 12 9 1131 2002 2389 +534 2 2 12 9 358 1256 2624 +535 2 2 12 9 684 1763 2537 +536 2 2 12 9 1975 371 2605 +537 2 2 12 9 233 1232 1972 +538 2 2 12 9 2607 372 1976 +539 2 2 12 9 1804 2633 3375 +540 2 2 12 9 587 1212 1761 +541 2 2 12 9 588 1762 1213 +542 2 2 12 9 267 1917 2391 +543 2 2 12 9 834 1669 2027 +544 2 2 12 9 662 1330 1814 +545 2 2 12 9 837 2997 1282 +546 2 2 12 9 364 1400 1907 +547 2 2 12 9 646 1398 2065 +548 2 2 12 9 893 1909 1704 +549 2 2 12 9 894 1705 1911 +550 2 2 12 9 813 1769 1848 +551 2 2 12 9 1001 1688 2073 +552 2 2 12 9 447 1995 1713 +553 2 2 12 9 595 2264 1399 +554 2 2 12 9 506 1318 3324 +555 2 2 12 9 507 3325 1319 +556 2 2 12 9 788 2136 1155 +557 2 2 12 9 940 1532 2967 +558 2 2 12 9 793 2177 1258 +559 2 2 12 9 1181 2247 2259 +560 2 2 12 9 1003 2941 1332 +561 2 2 12 9 735 1785 3508 +562 2 2 12 9 361 3141 2074 +563 2 2 12 9 432 1700 1271 +564 2 2 12 9 433 1272 1701 +565 2 2 12 9 424 3003 2513 +566 2 2 12 9 697 1250 2575 +567 2 2 12 9 475 1861 2981 +568 2 2 12 9 476 2982 1862 +569 2 2 12 9 849 2919 1215 +570 2 2 12 9 542 1987 1162 +571 2 2 12 9 717 1531 3230 +572 2 2 12 9 444 1402 1815 +573 2 2 12 9 736 3509 1788 +574 2 2 12 9 353 2132 1979 +575 2 2 12 9 691 1702 2841 +576 2 2 12 9 624 1667 2304 +577 2 2 12 9 625 2305 1668 +578 2 2 12 9 620 1850 1206 +579 2 2 12 9 3080 1010 1919 +580 2 2 12 9 680 1280 2178 +581 2 2 12 9 1449 3642 2596 +582 2 2 12 9 617 1401 3625 +583 2 2 12 9 512 2049 1269 +584 2 2 12 9 1260 1975 2605 +585 2 2 12 9 1261 2607 1976 +586 2 2 12 9 445 1199 1937 +587 2 2 12 9 675 1693 1316 +588 2 2 12 9 867 1396 2342 +589 2 2 12 9 778 2081 1203 +590 2 2 12 9 1074 1379 1879 +591 2 2 12 9 683 1736 3564 +592 2 2 12 9 1007 1327 2800 +593 2 2 12 9 1417 3210 3047 +594 2 2 12 9 556 1573 2293 +595 2 2 12 9 1357 1700 3033 +596 2 2 12 9 1358 3034 1701 +597 2 2 12 9 646 2065 2824 +598 2 2 12 9 633 2756 3418 +599 2 2 12 9 577 1676 2166 +600 2 2 12 9 1127 2751 1540 +601 2 2 12 9 553 1268 2580 +602 2 2 12 9 1228 2393 2856 +603 2 2 12 9 681 1451 2854 +604 2 2 12 9 1705 3094 2835 +605 2 2 12 9 1071 1463 2583 +606 2 2 12 9 722 1630 2131 +607 2 2 12 9 1206 1850 3203 +608 2 2 12 9 874 1285 2569 +609 2 2 12 9 1216 15 2283 +610 2 2 12 9 2099 1986 3029 +611 2 2 12 9 3580 412 2393 +612 2 2 12 9 695 3072 1349 +613 2 2 12 9 492 2182 1652 +614 2 2 12 9 773 1704 1909 +615 2 2 12 9 774 1911 1705 +616 2 2 12 9 425 2315 1350 +617 2 2 12 9 1413 3564 1736 +618 2 2 12 9 360 2108 2870 +619 2 2 12 9 725 1291 1827 +620 2 2 12 9 397 2081 1806 +621 2 2 12 9 398 2542 1431 +622 2 2 12 9 580 2363 1366 +623 2 2 12 9 668 1236 1703 +624 2 2 12 9 1098 2124 2008 +625 2 2 12 9 812 1994 1208 +626 2 2 12 9 647 1287 1725 +627 2 2 12 9 648 1726 1288 +628 2 2 12 9 538 1373 1702 +629 2 2 12 9 3504 698 2079 +630 2 2 12 9 737 1427 1519 +631 2 2 12 9 738 1520 1428 +632 2 2 12 9 367 1613 1956 +633 2 2 12 9 449 1193 3126 +634 2 2 12 9 829 1223 1900 +635 2 2 12 9 830 1901 1224 +636 2 2 12 9 754 2119 1222 +637 2 2 12 9 797 1592 1785 +638 2 2 12 9 551 2373 1857 +639 2 2 12 9 552 1858 2374 +640 2 2 12 9 223 224 1390 +641 2 2 12 9 464 1362 1819 +642 2 2 12 9 465 1820 1363 +643 2 2 12 9 1470 3438 2109 +644 2 2 12 9 742 1544 1479 +645 2 2 12 9 395 1214 2285 +646 2 2 12 9 686 1484 2989 +647 2 2 12 9 566 1176 2455 +648 2 2 12 9 438 2185 1305 +649 2 2 12 9 910 2416 1257 +650 2 2 12 9 1150 1979 2132 +651 2 2 12 9 741 2312 1190 +652 2 2 12 9 558 2777 1326 +653 2 2 12 9 898 2539 2348 +654 2 2 12 9 1092 2257 1727 +655 2 2 12 9 814 1342 1604 +656 2 2 12 9 523 2008 2124 +657 2 2 12 9 671 2751 2457 +658 2 2 12 9 1245 2849 2080 +659 2 2 12 9 308 1998 2357 +660 2 2 12 9 679 3062 1418 +661 2 2 12 9 1305 2185 2371 +662 2 2 12 9 966 2210 1326 +663 2 2 12 9 663 1435 1710 +664 2 2 12 9 664 1711 1436 +665 2 2 12 9 677 3581 3136 +666 2 2 12 9 199 2354 1783 +667 2 2 12 9 601 1494 2213 +668 2 2 12 9 602 2214 1495 +669 2 2 12 9 519 2001 2388 +670 2 2 12 9 520 2389 2002 +671 2 2 12 9 780 3009 1269 +672 2 2 12 9 715 1589 1422 +673 2 2 12 9 829 3462 1223 +674 2 2 12 9 830 1224 3463 +675 2 2 12 9 898 2348 1731 +676 2 2 12 9 799 1788 1595 +677 2 2 12 9 3102 1118 2077 +678 2 2 12 9 834 2027 2426 +679 2 2 12 9 557 1822 1251 +680 2 2 12 9 1523 1837 3627 +681 2 2 12 9 432 1271 2745 +682 2 2 12 9 433 2746 1272 +683 2 2 12 9 1205 2291 3276 +684 2 2 12 9 805 1311 2076 +685 2 2 12 9 730 1679 3154 +686 2 2 12 9 731 3155 1680 +687 2 2 12 9 38 39 1384 +688 2 2 12 9 182 183 1385 +689 2 2 12 9 1687 2527 2934 +690 2 2 12 9 770 1819 1217 +691 2 2 12 9 1818 3129 696 +692 2 2 12 9 473 1298 2570 +693 2 2 12 9 771 1218 1820 +694 2 2 12 9 456 3301 1544 +695 2 2 12 9 545 3333 1931 +696 2 2 12 9 359 2279 1448 +697 2 2 12 9 377 3057 1922 +698 2 2 12 9 633 3511 2756 +699 2 2 12 9 1074 3091 1379 +700 2 2 12 9 1518 2883 2912 +701 2 2 12 9 666 3461 2489 +702 2 2 12 9 662 2804 1453 +703 2 2 12 9 1045 2304 1667 +704 2 2 12 9 1046 1668 2305 +705 2 2 12 9 273 274 2059 +706 2 2 12 9 445 1486 3113 +707 2 2 12 9 1651 2998 2671 +708 2 2 12 9 357 2675 1243 +709 2 2 12 9 1463 3617 2583 +710 2 2 12 9 1179 2273 3081 +711 2 2 12 9 686 2989 1707 +712 2 2 12 9 1180 3082 2274 +713 2 2 12 9 832 1984 1321 +714 2 2 12 9 488 1310 2398 +715 2 2 12 9 1443 3508 1785 +716 2 2 12 9 447 1581 1995 +717 2 2 12 9 260 261 1843 +718 2 2 12 9 315 316 1844 +719 2 2 12 9 754 1222 2676 +720 2 2 12 9 513 2478 3079 +721 2 2 12 9 1009 1431 2542 +722 2 2 12 9 862 1374 2346 +723 2 2 12 9 1706 2726 2750 +724 2 2 12 9 1444 1788 3509 +725 2 2 12 9 529 1252 1985 +726 2 2 12 9 355 1892 1266 +727 2 2 12 9 783 2117 2011 +728 2 2 12 9 356 1267 1893 +729 2 2 12 9 784 2012 2118 +730 2 2 12 9 787 1177 2194 +731 2 2 12 9 617 3625 1471 +732 2 2 12 9 568 1238 2178 +733 2 2 12 9 1313 1547 3309 +734 2 2 12 9 1132 2168 3399 +735 2 2 12 9 1314 3310 1548 +736 2 2 12 9 878 2353 2585 +737 2 2 12 9 1262 2064 2695 +738 2 2 12 9 398 2534 1219 +739 2 2 12 9 741 1190 1938 +740 2 2 12 9 605 1386 1674 +741 2 2 12 9 1211 1931 3333 +742 2 2 12 9 449 1756 1316 +743 2 2 12 9 439 1211 3138 +744 2 2 12 9 756 3279 1197 +745 2 2 12 9 757 1198 3280 +746 2 2 12 9 387 1505 2018 +747 2 2 12 9 360 3538 2108 +748 2 2 12 9 759 1247 2067 +749 2 2 12 9 350 1278 3409 +750 2 2 12 9 933 2624 1256 +751 2 2 12 9 464 1819 1796 +752 2 2 12 9 465 1797 1820 +753 2 2 12 9 425 1350 1677 +754 2 2 12 9 423 1989 1590 +755 2 2 12 9 357 1186 2228 +756 2 2 12 9 530 1396 2232 +757 2 2 12 9 1532 1715 2967 +758 2 2 12 9 894 3094 1705 +759 2 2 12 9 1025 2166 1676 +760 2 2 12 9 446 1365 2087 +761 2 2 12 9 1324 1888 3327 +762 2 2 12 9 1325 3328 1889 +763 2 2 12 9 1627 2402 2957 +764 2 2 12 9 636 1552 1880 +765 2 2 12 9 650 2025 3608 +766 2 2 12 9 651 3609 2026 +767 2 2 12 9 637 1568 3353 +768 2 2 12 9 1200 1857 2373 +769 2 2 12 9 1201 2374 1858 +770 2 2 12 9 636 1347 1746 +771 2 2 12 9 817 1969 1644 +772 2 2 12 9 2544 730 3154 +773 2 2 12 9 2545 3155 731 +774 2 2 12 9 859 1399 2264 +775 2 2 12 9 587 2103 1212 +776 2 2 12 9 588 1213 2104 +777 2 2 12 9 1002 1652 2182 +778 2 2 12 9 434 1615 1565 +779 2 2 12 9 435 1566 1616 +780 2 2 12 9 799 1525 2467 +781 2 2 12 9 1157 1843 2731 +782 2 2 12 9 1158 2732 1844 +783 2 2 12 9 467 2303 1361 +784 2 2 12 9 618 2899 1307 +785 2 2 12 9 1029 1806 2081 +786 2 2 12 9 899 1957 1754 +787 2 2 12 9 1573 2643 2293 +788 2 2 12 9 1003 1332 3268 +789 2 2 12 9 1001 1380 2208 +790 2 2 12 9 628 2795 1991 +791 2 2 12 9 649 1210 2425 +792 2 2 12 9 3134 447 1713 +793 2 2 12 9 364 1303 3166 +794 2 2 12 9 400 2625 1863 +795 2 2 12 9 338 1410 3326 +796 2 2 12 9 781 1866 1923 +797 2 2 12 9 908 1298 1758 +798 2 2 12 9 671 1540 2751 +799 2 2 12 9 672 1571 1617 +800 2 2 12 9 1483 2369 2736 +801 2 2 12 9 506 3045 1318 +802 2 2 12 9 507 1319 3046 +803 2 2 12 9 1148 1432 3195 +804 2 2 12 9 449 3123 1193 +805 2 2 12 9 743 1937 1199 +806 2 2 12 9 1043 1941 2110 +807 2 2 12 9 361 2074 2967 +808 2 2 12 9 1044 2111 1942 +809 2 2 12 9 618 3456 1453 +810 2 2 12 9 867 2232 1396 +811 2 2 12 9 431 1187 2236 +812 2 2 12 9 904 2213 1494 +813 2 2 12 9 905 1495 2214 +814 2 2 12 9 379 1567 1535 +815 2 2 12 9 401 2312 1231 +816 2 2 12 9 780 1269 2049 +817 2 2 12 9 632 1256 2035 +818 2 2 12 9 536 1865 2802 +819 2 2 12 9 309 2392 1998 +820 2 2 12 9 1133 1472 2991 +821 2 2 12 9 391 1404 2353 +822 2 2 12 9 1134 2992 1473 +823 2 2 12 9 908 2570 1298 +824 2 2 12 9 1579 2562 3526 +825 2 2 12 9 513 3079 1513 +826 2 2 12 9 481 1802 1609 +827 2 2 12 9 482 1610 1803 +828 2 2 12 9 505 2562 1579 +829 2 2 12 9 340 2578 1270 +830 2 2 12 9 440 2113 1282 +831 2 2 12 9 355 1266 2245 +832 2 2 12 9 356 2246 1267 +833 2 2 12 9 825 1434 2154 +834 2 2 12 9 709 2715 1422 +835 2 2 12 9 1178 3208 1602 +836 2 2 12 9 23 24 1720 +837 2 2 12 9 1367 2330 3197 +838 2 2 12 9 3298 572 1241 +839 2 2 12 9 1368 3198 2331 +840 2 2 12 9 3300 1242 573 +841 2 2 12 9 756 1197 2245 +842 2 2 12 9 757 2246 1198 +843 2 2 12 9 729 1264 2175 +844 2 2 12 9 756 3327 1888 +845 2 2 12 9 757 1889 3328 +846 2 2 12 9 381 2569 1285 +847 2 2 12 9 453 1251 2628 +848 2 2 12 9 344 1785 1592 +849 2 2 12 9 657 2546 1795 +850 2 2 12 9 875 2398 1310 +851 2 2 12 9 772 1754 1957 +852 2 2 12 9 339 2882 3013 +853 2 2 12 9 1235 2757 1691 +854 2 2 12 9 226 227 1682 +855 2 2 12 9 1299 3036 1977 +856 2 2 12 9 1300 1978 3037 +857 2 2 12 9 450 1222 2119 +858 2 2 12 9 2954 15 1216 +859 2 2 12 9 553 2733 1268 +860 2 2 12 9 737 1519 1636 +861 2 2 12 9 738 1637 1520 +862 2 2 12 9 26 27 1423 +863 2 2 12 9 2125 2417 376 +864 2 2 12 9 426 1560 1459 +865 2 2 12 9 427 1460 1561 +866 2 2 12 9 1332 2941 3256 +867 2 2 12 9 754 1545 1781 +868 2 2 12 9 652 1497 1522 +869 2 2 12 9 900 1225 2837 +870 2 2 12 9 787 2030 3573 +871 2 2 12 9 456 2575 1250 +872 2 2 12 9 500 2715 1965 +873 2 2 12 9 382 2158 1630 +874 2 2 12 9 2951 1922 1695 +875 2 2 12 9 766 2080 2849 +876 2 2 12 9 1096 2802 1865 +877 2 2 12 9 367 1956 1605 +878 2 2 12 9 456 3383 2933 +879 2 2 12 9 423 1369 2576 +880 2 2 12 9 925 2486 1407 +881 2 2 12 9 926 1408 2487 +882 2 2 12 9 770 1217 2875 +883 2 2 12 9 771 2876 1218 +884 2 2 12 9 781 1923 1425 +885 2 2 12 9 705 2818 1884 +886 2 2 12 9 626 1371 2175 +887 2 2 12 9 706 1885 2819 +888 2 2 12 9 449 1316 1826 +889 2 2 12 9 529 1639 3376 +890 2 2 12 9 598 1379 3091 +891 2 2 12 9 1161 1930 2488 +892 2 2 12 9 400 1934 2625 +893 2 2 12 9 358 3470 1256 +894 2 2 12 9 345 1595 1788 +895 2 2 12 9 439 2061 1211 +896 2 2 12 9 440 1282 3255 +897 2 2 12 9 1286 2825 2204 +898 2 2 12 9 344 1443 1785 +899 2 2 12 9 770 1345 1796 +900 2 2 12 9 3159 417 2268 +901 2 2 12 9 771 1797 1346 +902 2 2 12 9 1290 2820 1987 +903 2 2 12 9 406 1342 2144 +904 2 2 12 9 875 1310 2470 +905 2 2 12 9 3016 1897 943 +906 2 2 12 9 3017 944 1898 +907 2 2 12 9 650 2404 2677 +908 2 2 12 9 651 2678 2405 +909 2 2 12 9 788 3495 2031 +910 2 2 12 9 446 2087 1418 +911 2 2 12 9 407 1999 3001 +912 2 2 12 9 533 1631 2705 +913 2 2 12 9 694 2829 1265 +914 2 2 12 9 345 1788 1444 +915 2 2 12 9 387 2603 1505 +916 2 2 12 9 2615 235 1852 +917 2 2 12 9 343 2006 1345 +918 2 2 12 9 342 1346 2007 +919 2 2 12 9 1313 3309 3508 +920 2 2 12 9 1314 3509 3310 +921 2 2 12 9 2402 599 2957 +922 2 2 12 9 405 3047 3210 +923 2 2 12 9 450 2327 1619 +924 2 2 12 9 793 1258 2168 +925 2 2 12 9 755 1985 1252 +926 2 2 12 9 1182 3441 1536 +927 2 2 12 9 1910 2851 2706 +928 2 2 12 9 1175 2684 2254 +929 2 2 12 9 618 1453 3615 +930 2 2 12 9 662 3539 1294 +931 2 2 12 9 470 1255 2683 +932 2 2 12 9 616 1425 1923 +933 2 2 12 9 354 2413 2412 +934 2 2 12 9 198 199 1783 +935 2 2 12 9 251 1854 2275 +936 2 2 12 9 325 2276 1855 +937 2 2 12 9 1190 1795 2546 +938 2 2 12 9 2292 3408 1225 +939 2 2 12 9 388 1195 2250 +940 2 2 12 9 705 1734 2818 +941 2 2 12 9 706 2819 1735 +942 2 2 12 9 438 1305 2193 +943 2 2 12 9 191 192 1432 +944 2 2 12 9 812 1208 2093 +945 2 2 12 9 2362 961 3111 +946 2 2 12 9 1399 3408 2292 +947 2 2 12 9 1024 2883 1518 +948 2 2 12 9 463 1517 2602 +949 2 2 12 9 748 1487 2236 +950 2 2 12 9 705 1824 1367 +951 2 2 12 9 706 1368 1825 +952 2 2 12 9 3099 1018 1815 +953 2 2 12 9 1171 2606 2975 +954 2 2 12 9 755 1341 1983 +955 2 2 12 9 557 2462 1204 +956 2 2 12 9 352 2991 1472 +957 2 2 12 9 351 1473 2992 +958 2 2 12 9 827 2182 1370 +959 2 2 12 9 627 3195 1432 +960 2 2 12 9 3036 710 1977 +961 2 2 12 9 3037 1978 711 +962 2 2 12 9 457 1215 3316 +963 2 2 12 9 224 2291 1390 +964 2 2 12 9 417 3159 1454 +965 2 2 12 9 365 1554 2659 +966 2 2 12 9 605 2941 1276 +967 2 2 12 9 982 2793 1553 +968 2 2 12 9 988 2126 2169 +969 2 2 12 9 989 2170 2127 +970 2 2 12 9 606 1882 1244 +971 2 2 12 9 1380 3134 1713 +972 2 2 12 9 916 2951 1695 +973 2 2 12 9 705 1367 1734 +974 2 2 12 9 706 1735 1368 +975 2 2 12 9 823 2122 1391 +976 2 2 12 9 824 1392 2123 +977 2 2 12 9 593 1793 2942 +978 2 2 12 9 568 2368 1238 +979 2 2 12 9 594 2943 1794 +980 2 2 12 9 584 1311 2263 +981 2 2 12 9 746 1259 2955 +982 2 2 12 9 976 1526 2188 +983 2 2 12 9 381 1285 2494 +984 2 2 12 9 483 2384 2915 +985 2 2 12 9 942 1630 2158 +986 2 2 12 9 647 2023 1287 +987 2 2 12 9 648 1288 2024 +988 2 2 12 9 446 2369 1483 +989 2 2 12 9 1330 1453 3456 +990 2 2 12 9 896 1845 1770 +991 2 2 12 9 1208 2063 2805 +992 2 2 12 9 1536 3441 2907 +993 2 2 12 9 729 2439 1264 +994 2 2 12 9 391 1374 2491 +995 2 2 12 9 274 275 2212 +996 2 2 12 9 666 1364 3242 +997 2 2 12 9 250 251 2275 +998 2 2 12 9 325 326 2276 +999 2 2 12 9 714 2726 1706 +1000 2 2 12 9 373 2110 1941 +1001 2 2 12 9 374 1942 2111 +1002 2 2 12 9 537 1683 1461 +1003 2 2 12 9 450 2531 1932 +1004 2 2 12 9 1553 2793 3071 +1005 2 2 12 9 741 1938 1352 +1006 2 2 12 9 800 2371 2185 +1007 2 2 12 9 670 1372 1815 +1008 2 2 12 9 1235 2973 2757 +1009 2 2 12 9 703 2953 1506 +1010 2 2 12 9 403 2557 1287 +1011 2 2 12 9 404 1288 2558 +1012 2 2 12 9 925 1407 2464 +1013 2 2 12 9 926 2465 1408 +1014 2 2 12 9 748 3068 1351 +1015 2 2 12 9 474 2029 1731 +1016 2 2 12 9 578 3087 2202 +1017 2 2 12 9 801 1305 1840 +1018 2 2 12 9 579 2203 3088 +1019 2 2 12 9 2841 1992 921 +1020 2 2 12 9 458 2364 1481 +1021 2 2 12 9 459 1482 2365 +1022 2 2 12 9 546 2255 1271 +1023 2 2 12 9 547 1272 2256 +1024 2 2 12 9 1427 1897 3016 +1025 2 2 12 9 413 3175 1375 +1026 2 2 12 9 1428 3017 1898 +1027 2 2 12 9 645 1990 1375 +1028 2 2 12 9 668 2523 1236 +1029 2 2 12 9 741 1231 2312 +1030 2 2 12 9 472 1347 2861 +1031 2 2 12 9 1179 3369 2273 +1032 2 2 12 9 1180 2274 3370 +1033 2 2 12 9 3253 1757 463 +1034 2 2 12 9 778 1203 2207 +1035 2 2 12 9 1270 3247 2593 +1036 2 2 12 9 836 2928 1480 +1037 2 2 12 9 765 1670 1352 +1038 2 2 12 9 640 1602 3208 +1039 2 2 12 9 1336 2417 2125 +1040 2 2 12 9 597 3289 1361 +1041 2 2 12 9 927 1716 1980 +1042 2 2 12 9 928 1981 1717 +1043 2 2 12 9 1099 1329 2931 +1044 2 2 12 9 456 1739 3383 +1045 2 2 12 9 441 2488 1930 +1046 2 2 12 9 395 1747 1745 +1047 2 2 12 9 388 2177 1195 +1048 2 2 12 9 419 1870 1359 +1049 2 2 12 9 403 2464 1407 +1050 2 2 12 9 404 1408 2465 +1051 2 2 12 9 472 2394 1347 +1052 2 2 12 9 511 1291 2090 +1053 2 2 12 9 624 1391 2122 +1054 2 2 12 9 695 2429 1258 +1055 2 2 12 9 625 2123 1392 +1056 2 2 12 9 580 1903 1339 +1057 2 2 12 9 677 1307 2899 +1058 2 2 12 9 605 3256 2941 +1059 2 2 12 9 268 2311 1917 +1060 2 2 12 9 1480 2928 1706 +1061 2 2 12 9 458 1508 2364 +1062 2 2 12 9 459 2365 1509 +1063 2 2 12 9 1111 2412 2413 +1064 2 2 12 9 525 2336 1793 +1065 2 2 12 9 526 1794 2337 +1066 2 2 12 9 1876 2722 2799 +1067 2 2 12 9 417 1454 3039 +1068 2 2 12 9 354 1814 1330 +1069 2 2 12 9 903 2071 1713 +1070 2 2 12 9 691 1692 1702 +1071 2 2 12 9 359 1784 2279 +1072 2 2 12 9 840 2101 1439 +1073 2 2 12 9 841 1440 2102 +1074 2 2 12 9 623 2888 1342 +1075 2 2 12 9 274 2212 2059 +1076 2 2 12 9 365 2298 1333 +1077 2 2 12 9 1327 3286 2800 +1078 2 2 12 9 805 2263 1311 +1079 2 2 12 9 829 1609 1802 +1080 2 2 12 9 830 1803 1610 +1081 2 2 12 9 977 2562 1835 +1082 2 2 12 9 408 1439 2101 +1083 2 2 12 9 409 2102 1440 +1084 2 2 12 9 1052 1712 2428 +1085 2 2 12 9 386 2154 1434 +1086 2 2 12 9 488 1918 1310 +1087 2 2 12 9 766 1933 2080 +1088 2 2 12 9 885 2387 1414 +1089 2 2 12 9 1958 3146 2879 +1090 2 2 12 9 432 2745 3118 +1091 2 2 12 9 433 3119 2746 +1092 2 2 12 9 399 1850 2456 +1093 2 2 12 9 747 1567 1772 +1094 2 2 12 9 1402 3099 1815 +1095 2 2 12 9 1102 2671 2998 +1096 2 2 12 9 234 235 2615 +1097 2 2 12 9 685 1410 1690 +1098 2 2 12 9 1437 3608 2025 +1099 2 2 12 9 801 2193 1305 +1100 2 2 12 9 1438 2026 3609 +1101 2 2 12 9 975 1765 2513 +1102 2 2 12 9 739 3608 1437 +1103 2 2 12 9 739 1636 1519 +1104 2 2 12 9 423 2014 1289 +1105 2 2 12 9 892 1353 2498 +1106 2 2 12 9 740 1438 3609 +1107 2 2 12 9 740 1520 1637 +1108 2 2 12 9 3384 1955 1782 +1109 2 2 12 9 764 1617 1571 +1110 2 2 12 9 747 1535 1567 +1111 2 2 12 9 874 2085 1285 +1112 2 2 12 9 1100 1793 2336 +1113 2 2 12 9 973 2011 2117 +1114 2 2 12 9 1101 2337 1794 +1115 2 2 12 9 974 2118 2012 +1116 2 2 12 9 832 1321 2390 +1117 2 2 12 9 874 2569 1347 +1118 2 2 12 9 819 3457 1259 +1119 2 2 12 9 3460 958 1285 +1120 2 2 12 9 398 1751 1760 +1121 2 2 12 9 536 2020 1304 +1122 2 2 12 9 915 1694 1921 +1123 2 2 12 9 593 1407 2486 +1124 2 2 12 9 594 2487 1408 +1125 2 2 12 9 759 2620 1247 +1126 2 2 12 9 1172 2949 1651 +1127 2 2 12 9 918 1945 1895 +1128 2 2 12 9 560 2563 1518 +1129 2 2 12 9 919 1896 1946 +1130 2 2 12 9 375 1781 1545 +1131 2 2 12 9 542 2027 1374 +1132 2 2 12 9 1169 2705 1631 +1133 2 2 12 9 732 3453 1372 +1134 2 2 12 9 364 3166 1400 +1135 2 2 12 9 685 1859 1631 +1136 2 2 12 9 873 1255 2505 +1137 2 2 12 9 726 1380 1713 +1138 2 2 12 9 8 9 1464 +1139 2 2 12 9 1183 2828 3055 +1140 2 2 12 9 791 2112 2807 +1141 2 2 12 9 470 2505 1255 +1142 2 2 12 9 592 3633 1449 +1143 2 2 12 9 844 1963 2621 +1144 2 2 12 9 1784 3405 2896 +1145 2 2 12 9 770 1884 1345 +1146 2 2 12 9 1165 3353 1568 +1147 2 2 12 9 722 1618 1653 +1148 2 2 12 9 771 1346 1885 +1149 2 2 12 9 799 2467 2038 +1150 2 2 12 9 957 1805 2053 +1151 2 2 12 9 430 1480 1706 +1152 2 2 12 9 527 2508 2033 +1153 2 2 12 9 528 2034 2509 +1154 2 2 12 9 814 1348 3040 +1155 2 2 12 9 454 1367 1824 +1156 2 2 12 9 455 1825 1368 +1157 2 2 12 9 449 1826 1371 +1158 2 2 12 9 576 2269 1237 +1159 2 2 12 9 483 2915 1909 +1160 2 2 12 9 980 2934 2527 +1161 2 2 12 9 231 232 1500 +1162 2 2 12 9 645 1375 1771 +1163 2 2 12 9 2330 727 3197 +1164 2 2 12 9 3198 728 2331 +1165 2 2 12 9 674 1243 3631 +1166 2 2 12 9 692 1611 2227 +1167 2 2 12 9 699 1784 2896 +1168 2 2 12 9 1276 1932 2531 +1169 2 2 12 9 703 1738 2953 +1170 2 2 12 9 847 1857 1565 +1171 2 2 12 9 848 1566 1858 +1172 2 2 12 9 1462 1714 2406 +1173 2 2 12 9 434 3287 1625 +1174 2 2 12 9 435 1626 3288 +1175 2 2 12 9 1435 3565 2600 +1176 2 2 12 9 1436 2601 3566 +1177 2 2 12 9 810 1390 2291 +1178 2 2 12 9 1570 3415 3333 +1179 2 2 12 9 834 1723 1669 +1180 2 2 12 9 739 1502 3608 +1181 2 2 12 9 740 3609 1503 +1182 2 2 12 9 813 1848 1614 +1183 2 2 12 9 3277 777 1954 +1184 2 2 12 9 696 1433 1712 +1185 2 2 12 9 475 3121 1861 +1186 2 2 12 9 476 1862 3122 +1187 2 2 12 9 700 2171 1590 +1188 2 2 12 9 3274 1952 776 +1189 2 2 12 9 842 1470 2109 +1190 2 2 12 9 692 2227 1678 +1191 2 2 12 9 1138 2087 3235 +1192 2 2 12 9 196 197 1580 +1193 2 2 12 9 958 2726 1285 +1194 2 2 12 9 258 1868 1322 +1195 2 2 12 9 318 1323 1869 +1196 2 2 12 9 1373 1992 2841 +1197 2 2 12 9 874 1347 2394 +1198 2 2 12 9 431 1487 3230 +1199 2 2 12 9 534 1452 1686 +1200 2 2 12 9 917 2769 1467 +1201 2 2 12 9 747 1848 1769 +1202 2 2 12 9 901 1873 1541 +1203 2 2 12 9 902 1542 1874 +1204 2 2 12 9 1051 1484 1791 +1205 2 2 12 9 794 2053 1805 +1206 2 2 12 9 744 1565 1615 +1207 2 2 12 9 745 1616 1566 +1208 2 2 12 9 746 1810 2602 +1209 2 2 12 9 741 2008 1231 +1210 2 2 12 9 1395 3289 3521 +1211 2 2 12 9 945 2681 1423 +1212 2 2 12 9 1116 2659 1554 +1213 2 2 12 9 819 1259 3648 +1214 2 2 12 9 729 1826 1316 +1215 2 2 12 9 622 1478 2370 +1216 2 2 12 9 748 1351 2846 +1217 2 2 12 9 755 1252 2343 +1218 2 2 12 9 1810 3253 463 +1219 2 2 12 9 773 1864 1496 +1220 2 2 12 9 350 2390 1321 +1221 2 2 12 9 481 2325 2629 +1222 2 2 12 9 482 2630 2326 +1223 2 2 12 9 549 3191 1524 +1224 2 2 12 9 694 1956 1764 +1225 2 2 12 9 45 46 1465 +1226 2 2 12 9 175 176 1466 +1227 2 2 12 9 557 1251 3030 +1228 2 2 12 9 792 2125 2735 +1229 2 2 12 9 645 3507 1990 +1230 2 2 12 9 473 2844 1298 +1231 2 2 12 9 797 2836 1524 +1232 2 2 12 9 536 1304 2077 +1233 2 2 12 9 1184 3001 1999 +1234 2 2 12 9 386 1644 1969 +1235 2 2 12 9 1041 2080 1933 +1236 2 2 12 9 923 2600 3565 +1237 2 2 12 9 924 3566 2601 +1238 2 2 12 9 485 1770 1845 +1239 2 2 12 9 1051 2932 1484 +1240 2 2 12 9 407 2646 1999 +1241 2 2 12 9 849 1286 2456 +1242 2 2 12 9 1342 2883 1604 +1243 2 2 12 9 1410 1949 3326 +1244 2 2 12 9 1070 3362 1355 +1245 2 2 12 9 967 1329 2307 +1246 2 2 12 9 379 1535 2438 +1247 2 2 12 9 377 1828 2524 +1248 2 2 12 9 800 2018 1505 +1249 2 2 12 9 450 1932 2327 +1250 2 2 12 9 236 1736 2827 +1251 2 2 12 9 698 1852 2396 +1252 2 2 12 9 3039 1918 991 +1253 2 2 12 9 768 2557 1407 +1254 2 2 12 9 769 1408 2558 +1255 2 2 12 9 597 3521 3289 +1256 2 2 12 9 26 1423 1834 +1257 2 2 12 9 1058 1448 2226 +1258 2 2 12 9 721 1489 3242 +1259 2 2 12 9 921 1764 1956 +1260 2 2 12 9 23 1720 2694 +1261 2 2 12 9 864 2423 1485 +1262 2 2 12 9 689 1508 3309 +1263 2 2 12 9 690 3310 1509 +1264 2 2 12 9 863 2072 1614 +1265 2 2 12 9 543 1708 2440 +1266 2 2 12 9 439 3248 2061 +1267 2 2 12 9 544 2441 1709 +1268 2 2 12 9 569 1840 1305 +1269 2 2 12 9 497 2443 1759 +1270 2 2 12 9 343 1895 1945 +1271 2 2 12 9 406 1562 2370 +1272 2 2 12 9 342 1946 1896 +1273 2 2 12 9 736 1788 1732 +1274 2 2 12 9 599 1792 2957 +1275 2 2 12 9 497 2604 2443 +1276 2 2 12 9 3111 961 1578 +1277 2 2 12 9 843 1745 1747 +1278 2 2 12 9 1450 3159 2268 +1279 2 2 12 9 863 2158 2072 +1280 2 2 12 9 1370 2182 3498 +1281 2 2 12 9 956 2512 1514 +1282 2 2 12 9 381 2494 1382 +1283 2 2 12 9 713 1646 2068 +1284 2 2 12 9 839 2422 2475 +1285 2 2 12 9 546 1271 2215 +1286 2 2 12 9 547 2216 1272 +1287 2 2 12 9 399 1496 1864 +1288 2 2 12 9 654 2057 1696 +1289 2 2 12 9 655 1697 2058 +1290 2 2 12 9 852 1419 2281 +1291 2 2 12 9 853 2282 1420 +1292 2 2 12 9 702 2996 1723 +1293 2 2 12 9 956 1514 2260 +1294 2 2 12 9 735 1718 1785 +1295 2 2 12 9 1069 1596 2616 +1296 2 2 12 9 1682 3628 3187 +1297 2 2 12 9 660 1651 2949 +1298 2 2 12 9 1696 2057 2792 +1299 2 2 12 9 592 1441 1908 +1300 2 2 12 9 1697 2794 2058 +1301 2 2 12 9 389 2616 1596 +1302 2 2 12 9 233 234 2615 +1303 2 2 12 9 1049 3343 1446 +1304 2 2 12 9 796 1702 1692 +1305 2 2 12 9 1284 3013 2882 +1306 2 2 12 9 580 2772 2865 +1307 2 2 12 9 266 267 2391 +1308 2 2 12 9 309 310 2392 +1309 2 2 12 9 1014 2757 2973 +1310 2 2 12 9 1366 2363 3586 +1311 2 2 12 9 733 1550 2172 +1312 2 2 12 9 48 49 1598 +1313 2 2 12 9 172 173 1599 +1314 2 2 12 9 734 2173 1551 +1315 2 2 12 9 449 1371 1866 +1316 2 2 12 9 842 2805 2063 +1317 2 2 12 9 689 3309 1547 +1318 2 2 12 9 500 1974 1422 +1319 2 2 12 9 690 1548 3310 +1320 2 2 12 9 833 3384 1782 +1321 2 2 12 9 1216 2790 1931 +1322 2 2 12 9 269 270 1521 +1323 2 2 12 9 43 1533 1800 +1324 2 2 12 9 178 1801 1534 +1325 2 2 12 9 806 1890 1622 +1326 2 2 12 9 807 1623 1891 +1327 2 2 12 9 735 1508 1718 +1328 2 2 12 9 1517 3275 2602 +1329 2 2 12 9 1174 2524 1828 +1330 2 2 12 9 1475 2218 3438 +1331 2 2 12 9 976 2188 2518 +1332 2 2 12 9 481 2629 1802 +1333 2 2 12 9 482 1803 2630 +1334 2 2 12 9 736 1732 1509 +1335 2 2 12 9 726 1713 2071 +1336 2 2 12 9 368 2430 1395 +1337 2 2 12 9 986 1766 2082 +1338 2 2 12 9 646 3486 1398 +1339 2 2 12 9 987 2083 1767 +1340 2 2 12 9 451 1313 2434 +1341 2 2 12 9 732 1372 3264 +1342 2 2 12 9 452 2435 1314 +1343 2 2 12 9 584 2848 1311 +1344 2 2 12 9 3438 2218 656 +1345 2 2 12 9 570 2209 1275 +1346 2 2 12 9 709 3382 2715 +1347 2 2 12 9 915 1921 2417 +1348 2 2 12 9 702 1691 2757 +1349 2 2 12 9 1222 1619 3347 +1350 2 2 12 9 1205 1682 3187 +1351 2 2 12 9 43 44 1533 +1352 2 2 12 9 177 178 1534 +1353 2 2 12 9 453 2205 1251 +1354 2 2 12 9 1171 1739 2606 +1355 2 2 12 9 447 2073 1356 +1356 2 2 12 9 600 1886 1442 +1357 2 2 12 9 3560 2225 1006 +1358 2 2 12 9 392 1829 1419 +1359 2 2 12 9 393 1420 1830 +1360 2 2 12 9 1011 1452 2908 +1361 2 2 12 9 698 1689 2079 +1362 2 2 12 9 1334 3136 3581 +1363 2 2 12 9 653 1514 2512 +1364 2 2 12 9 845 1760 1751 +1365 2 2 12 9 797 2504 2836 +1366 2 2 12 9 845 1842 1760 +1367 2 2 12 9 1007 2880 1327 +1368 2 2 12 9 1406 2061 3248 +1369 2 2 12 9 750 2221 1829 +1370 2 2 12 9 751 1830 2222 +1371 2 2 12 9 1246 2865 2772 +1372 2 2 12 9 1138 1454 3159 +1373 2 2 12 9 583 2233 1317 +1374 2 2 12 9 767 1811 1960 +1375 2 2 12 9 509 2428 1712 +1376 2 2 12 9 522 2536 2348 +1377 2 2 12 9 721 3242 3112 +1378 2 2 12 9 746 2602 2658 +1379 2 2 12 9 1010 1876 2799 +1380 2 2 12 9 895 1359 2460 +1381 2 2 12 9 768 1407 2375 +1382 2 2 12 9 769 2376 1408 +1383 2 2 12 9 1024 1518 2563 +1384 2 2 12 9 496 1532 2380 +1385 2 2 12 9 598 1837 1379 +1386 2 2 12 9 795 1374 2027 +1387 2 2 12 9 458 1718 1508 +1388 2 2 12 9 1240 2896 2258 +1389 2 2 12 9 1186 2913 1638 +1390 2 2 12 9 590 2931 2768 +1391 2 2 12 9 1059 1506 2959 +1392 2 2 12 9 622 2370 1562 +1393 2 2 12 9 448 1764 1992 +1394 2 2 12 9 565 3055 2828 +1395 2 2 12 9 716 1860 1456 +1396 2 2 12 9 402 2527 1687 +1397 2 2 12 9 746 2098 1259 +1398 2 2 12 9 541 1926 2633 +1399 2 2 12 9 921 1992 1764 +1400 2 2 12 9 859 1894 1328 +1401 2 2 12 9 1715 2962 2730 +1402 2 2 12 9 469 1669 1723 +1403 2 2 12 9 459 1509 1732 +1404 2 2 12 9 933 1256 2463 +1405 2 2 12 9 680 2178 1612 +1406 2 2 12 9 1765 3367 2513 +1407 2 2 12 9 686 2307 1569 +1408 2 2 12 9 782 2147 1887 +1409 2 2 12 9 779 1356 2073 +1410 2 2 12 9 1501 1990 3507 +1411 2 2 12 9 1577 1684 3264 +1412 2 2 12 9 697 2279 1250 +1413 2 2 12 9 1209 3230 1487 +1414 2 2 12 9 694 1312 3204 +1415 2 2 12 9 1294 3539 2339 +1416 2 2 12 9 612 1423 2681 +1417 2 2 12 9 425 3469 2747 +1418 2 2 12 9 349 2005 1378 +1419 2 2 12 9 971 1429 2787 +1420 2 2 12 9 1447 3053 1881 +1421 2 2 12 9 610 1481 3258 +1422 2 2 12 9 611 3259 1482 +1423 2 2 12 9 210 2065 1398 +1424 2 2 12 9 1056 1419 1829 +1425 2 2 12 9 1214 1524 3191 +1426 2 2 12 9 1057 1830 1420 +1427 2 2 12 9 642 3362 2254 +1428 2 2 12 9 1491 2225 3560 +1429 2 2 12 9 533 2360 2208 +1430 2 2 12 9 725 1760 1842 +1431 2 2 12 9 889 1430 2191 +1432 2 2 12 9 749 1910 2954 +1433 2 2 12 9 712 1755 2535 +1434 2 2 12 9 306 307 1703 +1435 2 2 12 9 413 1375 3027 +1436 2 2 12 9 301 302 2381 +1437 2 2 12 9 339 3013 1589 +1438 2 2 12 9 1112 2735 2125 +1439 2 2 12 9 860 2377 1415 +1440 2 2 12 9 861 1416 2378 +1441 2 2 12 9 580 1366 2772 +1442 2 2 12 9 732 1488 3453 +1443 2 2 12 9 763 1653 1618 +1444 2 2 12 9 1088 2440 1708 +1445 2 2 12 9 1174 2421 3272 +1446 2 2 12 9 1089 1709 2441 +1447 2 2 12 9 1010 2244 1919 +1448 2 2 12 9 904 1904 1888 +1449 2 2 12 9 905 1889 1905 +1450 2 2 12 9 1454 1918 3039 +1451 2 2 12 9 522 1833 2536 +1452 2 2 12 9 1278 2517 2091 +1453 2 2 12 9 768 1287 2557 +1454 2 2 12 9 769 2558 1288 +1455 2 2 12 9 1257 3470 2714 +1456 2 2 12 9 1365 3235 2087 +1457 2 2 12 9 770 1796 1819 +1458 2 2 12 9 1185 1689 2963 +1459 2 2 12 9 771 1820 1797 +1460 2 2 12 9 713 2068 2966 +1461 2 2 12 9 375 1545 1894 +1462 2 2 12 9 657 1467 1730 +1463 2 2 12 9 642 1293 2183 +1464 2 2 12 9 929 2801 1851 +1465 2 2 12 9 440 3255 1539 +1466 2 2 12 9 2115 777 3277 +1467 2 2 12 9 729 1316 2549 +1468 2 2 12 9 2114 3274 776 +1469 2 2 12 9 756 1888 1904 +1470 2 2 12 9 425 2773 2315 +1471 2 2 12 9 757 1905 1889 +1472 2 2 12 9 212 213 1643 +1473 2 2 12 9 3265 674 1995 +1474 2 2 12 9 1006 2187 2264 +1475 2 2 12 9 765 1352 3536 +1476 2 2 12 9 1113 2902 2970 +1477 2 2 12 9 749 2851 1910 +1478 2 2 12 9 196 1580 3299 +1479 2 2 12 9 669 1276 3434 +1480 2 2 12 9 869 1752 1912 +1481 2 2 12 9 1070 1355 3027 +1482 2 2 12 9 695 1381 2429 +1483 2 2 12 9 1088 2929 2094 +1484 2 2 12 9 1089 2095 2930 +1485 2 2 12 9 791 2807 1962 +1486 2 2 12 9 1042 1913 2863 +1487 2 2 12 9 1371 1826 2175 +1488 2 2 12 9 599 2402 1790 +1489 2 2 12 9 1943 3332 763 +1490 2 2 12 9 860 1415 2304 +1491 2 2 12 9 861 2305 1416 +1492 2 2 12 9 790 2822 1286 +1493 2 2 12 9 650 3319 2025 +1494 2 2 12 9 651 2026 3320 +1495 2 2 12 9 1166 2824 2065 +1496 2 2 12 9 545 1570 3333 +1497 2 2 12 9 1248 3118 2745 +1498 2 2 12 9 1249 2746 3119 +1499 2 2 12 9 257 1322 2242 +1500 2 2 12 9 319 2243 1323 +1501 2 2 12 9 425 1677 3469 +1502 2 2 12 9 760 2137 1574 +1503 2 2 12 9 761 1575 2138 +1504 2 2 12 9 1808 2422 3110 +1505 2 2 12 9 1113 2970 2141 +1506 2 2 12 9 3554 531 2463 +1507 2 2 12 9 451 1997 2720 +1508 2 2 12 9 452 2721 2000 +1509 2 2 12 9 852 2325 1343 +1510 2 2 12 9 853 1344 2326 +1511 2 2 12 9 609 1454 3235 +1512 2 2 12 9 1011 2135 1452 +1513 2 2 12 9 1007 1650 3540 +1514 2 2 12 9 1167 3258 1481 +1515 2 2 12 9 1168 1482 3259 +1516 2 2 12 9 437 2963 1689 +1517 2 2 12 9 343 1345 2818 +1518 2 2 12 9 342 2819 1346 +1519 2 2 12 9 601 1301 2146 +1520 2 2 12 9 602 2148 1302 +1521 2 2 12 9 484 2978 2386 +1522 2 2 12 9 642 2108 1293 +1523 2 2 12 9 344 2801 1443 +1524 2 2 12 9 188 189 1646 +1525 2 2 12 9 2682 2071 903 +1526 2 2 12 9 1088 2581 2929 +1527 2 2 12 9 1089 2930 2582 +1528 2 2 12 9 856 1296 2391 +1529 2 2 12 9 580 1339 2363 +1530 2 2 12 9 366 1927 1445 +1531 2 2 12 9 857 2392 1297 +1532 2 2 12 9 624 2304 1415 +1533 2 2 12 9 625 1416 2305 +1534 2 2 12 9 1194 2074 3141 +1535 2 2 12 9 930 1335 2532 +1536 2 2 12 9 940 2380 1532 +1537 2 2 12 9 636 1880 1347 +1538 2 2 12 9 381 1382 2340 +1539 2 2 12 9 1723 2996 2165 +1540 2 2 12 9 933 3347 1619 +1541 2 2 12 9 862 3503 1290 +1542 2 2 12 9 1332 2071 2682 +1543 2 2 12 9 1138 3235 1454 +1544 2 2 12 9 748 2236 1804 +1545 2 2 12 9 302 1963 2381 +1546 2 2 12 9 308 309 1998 +1547 2 2 12 9 590 2787 1429 +1548 2 2 12 9 907 1878 2430 +1549 2 2 12 9 451 1716 1547 +1550 2 2 12 9 900 1559 2292 +1551 2 2 12 9 1115 1992 1373 +1552 2 2 12 9 794 1733 2105 +1553 2 2 12 9 452 1548 1717 +1554 2 2 12 9 2896 3207 2258 +1555 2 2 12 9 649 2813 1996 +1556 2 2 12 9 511 2090 2749 +1557 2 2 12 9 1050 2396 1852 +1558 2 2 12 9 1055 1887 2147 +1559 2 2 12 9 464 2221 1362 +1560 2 2 12 9 440 2397 2113 +1561 2 2 12 9 1552 2507 1880 +1562 2 2 12 9 465 1363 2222 +1563 2 2 12 9 1095 1940 2390 +1564 2 2 12 9 2025 475 2981 +1565 2 2 12 9 2026 2982 476 +1566 2 2 12 9 827 1370 1982 +1567 2 2 12 9 858 1742 2100 +1568 2 2 12 9 1437 2025 2981 +1569 2 2 12 9 1438 2982 2026 +1570 2 2 12 9 883 2534 1431 +1571 2 2 12 9 350 1321 2163 +1572 2 2 12 9 635 1430 3105 +1573 2 2 12 9 669 2437 1276 +1574 2 2 12 9 423 2576 3381 +1575 2 2 12 9 2882 834 1284 +1576 2 2 12 9 808 2082 1766 +1577 2 2 12 9 809 1767 2083 +1578 2 2 12 9 494 1622 1890 +1579 2 2 12 9 495 1891 1623 +1580 2 2 12 9 1395 2430 3289 +1581 2 2 12 9 1159 2981 1861 +1582 2 2 12 9 1160 1862 2982 +1583 2 2 12 9 232 1972 1500 +1584 2 2 12 9 646 1517 3486 +1585 2 2 12 9 1156 1580 2286 +1586 2 2 12 9 1097 2021 1591 +1587 2 2 12 9 665 1715 1532 +1588 2 2 12 9 1028 1865 2401 +1589 2 2 12 9 695 1349 1916 +1590 2 2 12 9 206 1351 3068 +1591 2 2 12 9 467 1877 2303 +1592 2 2 12 9 1244 3124 1835 +1593 2 2 12 9 534 2908 1452 +1594 2 2 12 9 1029 2081 2037 +1595 2 2 12 9 1590 2171 3048 +1596 2 2 12 9 3563 443 2099 +1597 2 2 12 9 574 1775 2868 +1598 2 2 12 9 575 2869 1776 +1599 2 2 12 9 1079 1790 2402 +1600 2 2 12 9 350 3409 1685 +1601 2 2 12 9 762 1908 3575 +1602 2 2 12 9 1266 2103 3335 +1603 2 2 12 9 1267 3336 2104 +1604 2 2 12 9 1056 1829 2221 +1605 2 2 12 9 288 1360 2237 +1606 2 2 12 9 1057 2222 1830 +1607 2 2 12 9 1413 1736 3303 +1608 2 2 12 9 380 2229 1331 +1609 2 2 12 9 289 2248 1360 +1610 2 2 12 9 1581 3265 1995 +1611 2 2 12 9 563 1912 1752 +1612 2 2 12 9 543 1582 1708 +1613 2 2 12 9 544 1709 1583 +1614 2 2 12 9 352 2410 1498 +1615 2 2 12 9 351 1499 2411 +1616 2 2 12 9 1248 3317 1679 +1617 2 2 12 9 1249 1680 3318 +1618 2 2 12 9 1728 3554 2463 +1619 2 2 12 9 236 237 1736 +1620 2 2 12 9 554 2091 2517 +1621 2 2 12 9 799 1732 1788 +1622 2 2 12 9 464 2288 2221 +1623 2 2 12 9 465 2222 2289 +1624 2 2 12 9 1064 2020 2749 +1625 2 2 12 9 2003 3604 811 +1626 2 2 12 9 855 1450 2268 +1627 2 2 12 9 595 2292 1559 +1628 2 2 12 9 838 1356 2823 +1629 2 2 12 9 1429 1959 3263 +1630 2 2 12 9 868 3289 2430 +1631 2 2 12 9 2056 2935 3254 +1632 2 2 12 9 1097 2303 1877 +1633 2 2 12 9 797 1785 1718 +1634 2 2 12 9 741 1352 2623 +1635 2 2 12 9 715 1915 1589 +1636 2 2 12 9 267 268 1917 +1637 2 2 12 9 364 1907 2334 +1638 2 2 12 9 419 1359 2135 +1639 2 2 12 9 1217 2868 1775 +1640 2 2 12 9 1218 1776 2869 +1641 2 2 12 9 578 1679 3317 +1642 2 2 12 9 579 3318 1680 +1643 2 2 12 9 595 1399 2292 +1644 2 2 12 9 412 1476 1957 +1645 2 2 12 9 462 1526 1807 +1646 2 2 12 9 818 1591 2021 +1647 2 2 12 9 1441 3575 1908 +1648 2 2 12 9 660 2998 1651 +1649 2 2 12 9 253 254 1587 +1650 2 2 12 9 322 323 1588 +1651 2 2 12 9 747 1772 1848 +1652 2 2 12 9 1293 2108 3538 +1653 2 2 12 9 505 1579 2723 +1654 2 2 12 9 686 1791 1484 +1655 2 2 12 9 17 18 1651 +1656 2 2 12 9 1050 2827 1736 +1657 2 2 12 9 3287 687 2195 +1658 2 2 12 9 3288 2196 688 +1659 2 2 12 9 354 1330 2413 +1660 2 2 12 9 49 2763 1598 +1661 2 2 12 9 172 1599 2764 +1662 2 2 12 9 971 2904 1429 +1663 2 2 12 9 1007 3540 2880 +1664 2 2 12 9 768 2797 1287 +1665 2 2 12 9 769 1288 2798 +1666 2 2 12 9 967 2307 1707 +1667 2 2 12 9 803 2772 2403 +1668 2 2 12 9 618 1307 2662 +1669 2 2 12 9 1435 2600 3610 +1670 2 2 12 9 1436 3611 2601 +1671 2 2 12 9 229 1311 2019 +1672 2 2 12 9 212 1643 3314 +1673 2 2 12 9 844 2218 1475 +1674 2 2 12 9 746 1445 1810 +1675 2 2 12 9 467 1361 2561 +1676 2 2 12 9 1012 2621 1963 +1677 2 2 12 9 881 1686 2257 +1678 2 2 12 9 759 3032 3313 +1679 2 2 12 9 364 2133 1303 +1680 2 2 12 9 653 1456 1860 +1681 2 2 12 9 635 1298 2191 +1682 2 2 12 9 445 1937 2147 +1683 2 2 12 9 814 2493 1348 +1684 2 2 12 9 1375 3175 1771 +1685 2 2 12 9 1070 3027 1375 +1686 2 2 12 9 601 2547 1301 +1687 2 2 12 9 693 1870 1394 +1688 2 2 12 9 602 1302 2548 +1689 2 2 12 9 484 1911 2978 +1690 2 2 12 9 1017 2908 2235 +1691 2 2 12 9 505 1835 2562 +1692 2 2 12 9 750 1708 1582 +1693 2 2 12 9 751 1583 1709 +1694 2 2 12 9 349 1378 2812 +1695 2 2 12 9 398 1431 2534 +1696 2 2 12 9 680 3127 1280 +1697 2 2 12 9 2035 3411 2572 +1698 2 2 12 9 394 2687 1727 +1699 2 2 12 9 755 2343 1341 +1700 2 2 12 9 854 2517 1278 +1701 2 2 12 9 608 1417 3168 +1702 2 2 12 9 1571 3563 2099 +1703 2 2 12 9 703 1506 1789 +1704 2 2 12 9 1467 2769 1730 +1705 2 2 12 9 618 3615 2899 +1706 2 2 12 9 1537 2815 3642 +1707 2 2 12 9 975 2358 1765 +1708 2 2 12 9 780 2039 3009 +1709 2 2 12 9 906 1442 1886 +1710 2 2 12 9 1625 3287 2195 +1711 2 2 12 9 1626 2196 3288 +1712 2 2 12 9 635 2191 1430 +1713 2 2 12 9 858 2419 1393 +1714 2 2 12 9 733 2172 1798 +1715 2 2 12 9 734 1799 2173 +1716 2 2 12 9 1546 3332 1943 +1717 2 2 12 9 558 1326 2918 +1718 2 2 12 9 767 1777 1774 +1719 2 2 12 9 529 3004 1639 +1720 2 2 12 9 825 1409 1961 +1721 2 2 12 9 627 2529 1989 +1722 2 2 12 9 952 1505 2603 +1723 2 2 12 9 1245 2080 3183 +1724 2 2 12 9 778 2037 2081 +1725 2 2 12 9 750 2447 1362 +1726 2 2 12 9 751 1363 2448 +1727 2 2 12 9 720 3232 1779 +1728 2 2 12 9 414 2968 2407 +1729 2 2 12 9 457 2342 2466 +1730 2 2 12 9 471 1692 2484 +1731 2 2 12 9 471 2484 1664 +1732 2 2 12 9 379 1811 1567 +1733 2 2 12 9 789 1783 2009 +1734 2 2 12 9 1051 2105 1733 +1735 2 2 12 9 906 2636 1442 +1736 2 2 12 9 569 1505 2528 +1737 2 2 12 9 834 2426 1284 +1738 2 2 12 9 686 1707 2307 +1739 2 2 12 9 1023 2357 1998 +1740 2 2 12 9 869 1530 1752 +1741 2 2 12 9 676 1576 2415 +1742 2 2 12 9 717 1445 1927 +1743 2 2 12 9 1310 1556 2470 +1744 2 2 12 9 1277 2113 2397 +1745 2 2 12 9 510 2085 1608 +1746 2 2 12 9 508 1381 2349 +1747 2 2 12 9 589 2036 1338 +1748 2 2 12 9 810 2291 3222 +1749 2 2 12 9 406 2370 2912 +1750 2 2 12 9 306 1703 3512 +1751 2 2 12 9 1095 2390 3395 +1752 2 2 12 9 492 3498 2182 +1753 2 2 12 9 1426 2734 3396 +1754 2 2 12 9 489 2217 1899 +1755 2 2 12 9 886 2402 1627 +1756 2 2 12 9 191 1432 3075 +1757 2 2 12 9 1054 2723 1579 +1758 2 2 12 9 1414 2387 3624 +1759 2 2 12 9 1384 2618 2355 +1760 2 2 12 9 1385 2356 2619 +1761 2 2 12 9 922 1403 2724 +1762 2 2 12 9 1355 3362 2183 +1763 2 2 12 9 1340 2813 3547 +1764 2 2 12 9 767 1772 1567 +1765 2 2 12 9 715 1673 1915 +1766 2 2 12 9 1535 3194 2438 +1767 2 2 12 9 870 1371 2270 +1768 2 2 12 9 473 1471 2300 +1769 2 2 12 9 762 1765 2791 +1770 2 2 12 9 407 1919 2244 +1771 2 2 12 9 461 1393 2419 +1772 2 2 12 9 3263 1959 436 +1773 2 2 12 9 766 1965 2968 +1774 2 2 12 9 1009 1827 2372 +1775 2 2 12 9 776 3297 1303 +1776 2 2 12 9 792 1336 2125 +1777 2 2 12 9 1148 3075 1432 +1778 2 2 12 9 746 2955 1445 +1779 2 2 12 9 498 1966 2367 +1780 2 2 12 9 719 1835 3124 +1781 2 2 12 9 574 3548 1775 +1782 2 2 12 9 575 1776 3549 +1783 2 2 12 9 574 2832 3548 +1784 2 2 12 9 575 3549 2834 +1785 2 2 12 9 1268 3306 2580 +1786 2 2 12 9 383 2490 1317 +1787 2 2 12 9 635 2492 1298 +1788 2 2 12 9 776 1303 2133 +1789 2 2 12 9 1011 2290 2135 +1790 2 2 12 9 864 2251 2423 +1791 2 2 12 9 907 2430 2753 +1792 2 2 12 9 1167 1481 2364 +1793 2 2 12 9 1168 2365 1482 +1794 2 2 12 9 1059 1737 2174 +1795 2 2 12 9 1143 2010 2339 +1796 2 2 12 9 869 2495 1433 +1797 2 2 12 9 567 2339 2010 +1798 2 2 12 9 1165 1914 3304 +1799 2 2 12 9 889 1783 2354 +1800 2 2 12 9 1156 3299 1580 +1801 2 2 12 9 1641 3626 2042 +1802 2 2 12 9 638 2846 1351 +1803 2 2 12 9 804 1774 1777 +1804 2 2 12 9 529 2359 3004 +1805 2 2 12 9 632 2035 2572 +1806 2 2 12 9 715 1422 1974 +1807 2 2 12 9 1033 2336 1980 +1808 2 2 12 9 193 1831 2579 +1809 2 2 12 9 1034 1981 2337 +1810 2 2 12 9 188 1646 3069 +1811 2 2 12 9 872 2340 1382 +1812 2 2 12 9 508 2429 1381 +1813 2 2 12 9 1040 3057 2524 +1814 2 2 12 9 1366 2403 2772 +1815 2 2 12 9 1244 2723 1572 +1816 2 2 12 9 186 187 1632 +1817 2 2 12 9 406 2144 1562 +1818 2 2 12 9 1146 2835 3094 +1819 2 2 12 9 1064 2090 1417 +1820 2 2 12 9 811 3604 1813 +1821 2 2 12 9 796 1960 1811 +1822 2 2 12 9 744 1800 1533 +1823 2 2 12 9 745 1534 1801 +1824 2 2 12 9 2734 499 3396 +1825 2 2 12 9 380 1331 2427 +1826 2 2 12 9 583 1317 3321 +1827 2 2 12 9 812 2174 1737 +1828 2 2 12 9 511 2372 1827 +1829 2 2 12 9 206 2306 1351 +1830 2 2 12 9 875 2470 1507 +1831 2 2 12 9 355 1600 1892 +1832 2 2 12 9 356 1893 1601 +1833 2 2 12 9 775 2972 1410 +1834 2 2 12 9 1058 2226 2871 +1835 2 2 12 9 3626 565 2042 +1836 2 2 12 9 888 2597 1490 +1837 2 2 12 9 1014 1513 2184 +1838 2 2 12 9 1040 2524 1823 +1839 2 2 12 9 717 2439 1531 +1840 2 2 12 9 730 1975 2938 +1841 2 2 12 9 731 2939 1976 +1842 2 2 12 9 569 1305 2371 +1843 2 2 12 9 474 1614 1848 +1844 2 2 12 9 1055 2147 1937 +1845 2 2 12 9 1042 3145 1913 +1846 2 2 12 9 1779 3232 2225 +1847 2 2 12 9 395 3011 1747 +1848 2 2 12 9 34 35 1672 +1849 2 2 12 9 612 2681 1327 +1850 2 2 12 9 1337 2756 3511 +1851 2 2 12 9 3059 873 1341 +1852 2 2 12 9 671 2003 1540 +1853 2 2 12 9 1716 2720 1980 +1854 2 2 12 9 1717 1981 2721 +1855 2 2 12 9 849 2466 1396 +1856 2 2 12 9 278 279 1635 +1857 2 2 12 9 375 2496 1781 +1858 2 2 12 9 39 2126 1384 +1859 2 2 12 9 182 1385 2127 +1860 2 2 12 9 1355 1572 2571 +1861 2 2 12 9 519 3081 2273 +1862 2 2 12 9 520 2274 3082 +1863 2 2 12 9 394 2879 3146 +1864 2 2 12 9 359 1448 3024 +1865 2 2 12 9 767 1567 1811 +1866 2 2 12 9 795 2036 1404 +1867 2 2 12 9 1080 3436 1768 +1868 2 2 12 9 1173 2870 2108 +1869 2 2 12 9 1260 2938 1975 +1870 2 2 12 9 415 1337 2145 +1871 2 2 12 9 1261 1976 2939 +1872 2 2 12 9 576 3363 2045 +1873 2 2 12 9 1176 2179 3131 +1874 2 2 12 9 454 2330 1367 +1875 2 2 12 9 455 1368 2331 +1876 2 2 12 9 499 1765 2358 +1877 2 2 12 9 1387 3446 3149 +1878 2 2 12 9 1388 3150 3447 +1879 2 2 12 9 223 1390 3236 +1880 2 2 12 9 953 2129 1854 +1881 2 2 12 9 954 1855 2130 +1882 2 2 12 9 697 2575 3474 +1883 2 2 12 9 685 1949 1410 +1884 2 2 12 9 628 1315 2423 +1885 2 2 12 9 1009 2045 1431 +1886 2 2 12 9 1045 2101 2161 +1887 2 2 12 9 1046 2162 2102 +1888 2 2 12 9 1514 3070 2260 +1889 2 2 12 9 365 1333 2809 +1890 2 2 12 9 2340 2042 3425 +1891 2 2 12 9 859 1328 2444 +1892 2 2 12 9 1079 1535 2550 +1893 2 2 12 9 453 2807 2205 +1894 2 2 12 9 38 1384 2355 +1895 2 2 12 9 183 2356 1385 +1896 2 2 12 9 748 1853 3068 +1897 2 2 12 9 27 2599 1423 +1898 2 2 12 9 779 2106 1356 +1899 2 2 12 9 474 1774 2029 +1900 2 2 12 9 1686 3291 2257 +1901 2 2 12 9 1299 2096 3036 +1902 2 2 12 9 1300 3037 2097 +1903 2 2 12 9 692 2670 1611 +1904 2 2 12 9 823 1854 2129 +1905 2 2 12 9 824 2130 1855 +1906 2 2 12 9 369 2016 1528 +1907 2 2 12 9 370 1529 2017 +1908 2 2 12 9 1446 3343 1993 +1909 2 2 12 9 1020 3642 2815 +1910 2 2 12 9 643 1643 3125 +1911 2 2 12 9 1342 2888 2144 +1912 2 2 12 9 945 1423 2599 +1913 2 2 12 9 18 3354 1651 +1914 2 2 12 9 563 1836 1650 +1915 2 2 12 9 1196 3125 1643 +1916 2 2 12 9 811 1540 2003 +1917 2 2 12 9 778 3307 3593 +1918 2 2 12 9 509 2800 3286 +1919 2 2 12 9 952 2528 1505 +1920 2 2 12 9 494 2223 1622 +1921 2 2 12 9 349 1442 2636 +1922 2 2 12 9 1130 2001 2718 +1923 2 2 12 9 495 1623 2224 +1924 2 2 12 9 895 2716 1359 +1925 2 2 12 9 1431 2045 3363 +1926 2 2 12 9 1131 2719 2002 +1927 2 2 12 9 2042 1108 3425 +1928 2 2 12 9 215 2847 2956 +1929 2 2 12 9 878 1393 2309 +1930 2 2 12 9 619 2472 1421 +1931 2 2 12 9 1001 2360 1688 +1932 2 2 12 9 885 1421 1953 +1933 2 2 12 9 874 1608 2085 +1934 2 2 12 9 941 2593 3247 +1935 2 2 12 9 623 1342 2631 +1936 2 2 12 9 593 2486 1357 +1937 2 2 12 9 594 1358 2487 +1938 2 2 12 9 1084 3036 2096 +1939 2 2 12 9 1085 2097 3037 +1940 2 2 12 9 759 2067 3032 +1941 2 2 12 9 934 1403 2926 +1942 2 2 12 9 819 1557 1939 +1943 2 2 12 9 536 2401 1865 +1944 2 2 12 9 1144 3210 1417 +1945 2 2 12 9 548 1593 2709 +1946 2 2 12 9 367 3575 1441 +1947 2 2 12 9 1029 1902 3180 +1948 2 2 12 9 1328 2309 2444 +1949 2 2 12 9 448 1584 1764 +1950 2 2 12 9 772 1957 1476 +1951 2 2 12 9 742 1479 2506 +1952 2 2 12 9 869 1912 2495 +1953 2 2 12 9 606 1355 3523 +1954 2 2 12 9 570 1455 2209 +1955 2 2 12 9 658 2815 1537 +1956 2 2 12 9 468 2241 2514 +1957 2 2 12 9 389 2999 1944 +1958 2 2 12 9 589 1393 2585 +1959 2 2 12 9 461 2444 2309 +1960 2 2 12 9 767 1774 1772 +1961 2 2 12 9 468 2403 1366 +1962 2 2 12 9 1238 1612 2178 +1963 2 2 12 9 362 2647 2259 +1964 2 2 12 9 842 3412 1470 +1965 2 2 12 9 1361 2303 3184 +1966 2 2 12 9 747 2550 1535 +1967 2 2 12 9 1902 2458 3180 +1968 2 2 12 9 1340 2241 2813 +1969 2 2 12 9 1258 2177 3072 +1970 2 2 12 9 662 1814 2164 +1971 2 2 12 9 1318 3045 2040 +1972 2 2 12 9 1319 2041 3046 +1973 2 2 12 9 1022 2475 2422 +1974 2 2 12 9 893 1704 3616 +1975 2 2 12 9 493 1970 1628 +1976 2 2 12 9 881 2228 1686 +1977 2 2 12 9 804 2379 2253 +1978 2 2 12 9 1049 1446 3151 +1979 2 2 12 9 442 2471 1456 +1980 2 2 12 9 893 3616 3093 +1981 2 2 12 9 418 1379 2506 +1982 2 2 12 9 906 1886 2424 +1983 2 2 12 9 762 2791 1908 +1984 2 2 12 9 732 2617 2433 +1985 2 2 12 9 352 1472 3483 +1986 2 2 12 9 351 3484 1473 +1987 2 2 12 9 814 2631 1342 +1988 2 2 12 9 361 1715 2730 +1989 2 2 12 9 193 194 1831 +1990 2 2 12 9 947 2734 1426 +1991 2 2 12 9 889 2009 1783 +1992 2 2 12 9 934 2970 1403 +1993 2 2 12 9 810 2612 1390 +1994 2 2 12 9 232 233 1972 +1995 2 2 12 9 1142 1595 3144 +1996 2 2 12 9 864 1485 2116 +1997 2 2 12 9 494 1890 1694 +1998 2 2 12 9 495 1695 1891 +1999 2 2 12 9 851 1331 2635 +2000 2 2 12 9 1110 3146 1958 +2001 2 2 12 9 431 1531 2549 +2002 2 2 12 9 1353 3599 2498 +2003 2 2 12 9 1345 2006 3639 +2004 2 2 12 9 1346 3640 2007 +2005 2 2 12 9 852 1343 2318 +2006 2 2 12 9 853 2319 1344 +2007 2 2 12 9 1092 1727 2687 +2008 2 2 12 9 611 1482 3277 +2009 2 2 12 9 502 2839 1977 +2010 2 2 12 9 503 1978 2840 +2011 2 2 12 9 750 1362 2221 +2012 2 2 12 9 751 2222 1363 +2013 2 2 12 9 610 3274 1481 +2014 2 2 12 9 783 2006 1947 +2015 2 2 12 9 784 1948 2007 +2016 2 2 12 9 1002 2329 1652 +2017 2 2 12 9 1471 3625 2300 +2018 2 2 12 9 851 2427 1331 +2019 2 2 12 9 537 1461 2079 +2020 2 2 12 9 1001 3134 1380 +2021 2 2 12 9 402 3110 2422 +2022 2 2 12 9 1685 2537 3395 +2023 2 2 12 9 1559 3368 2699 +2024 2 2 12 9 423 3048 1369 +2025 2 2 12 9 222 1411 2230 +2026 2 2 12 9 1030 2633 1926 +2027 2 2 12 9 626 2270 1371 +2028 2 2 12 9 392 1419 2318 +2029 2 2 12 9 393 2319 1420 +2030 2 2 12 9 469 2679 2345 +2031 2 2 12 9 1742 2777 2100 +2032 2 2 12 9 1266 1892 2103 +2033 2 2 12 9 1267 2104 1893 +2034 2 2 12 9 1235 2206 2973 +2035 2 2 12 9 1166 3314 1643 +2036 2 2 12 9 617 1490 2597 +2037 2 2 12 9 1341 873 2445 +2038 2 2 12 9 882 2442 1349 +2039 2 2 12 9 877 2736 2369 +2040 2 2 12 9 525 1980 2336 +2041 2 2 12 9 526 2337 1981 +2042 2 2 12 9 1688 2360 3143 +2043 2 2 12 9 981 1899 2217 +2044 2 2 12 9 589 2436 1393 +2045 2 2 12 9 1419 3644 2281 +2046 2 2 12 9 726 2071 1674 +2047 2 2 12 9 1420 2282 3645 +2048 2 2 12 9 9 2387 1464 +2049 2 2 12 9 369 1528 2692 +2050 2 2 12 9 370 2693 1529 +2051 2 2 12 9 1117 2935 2056 +2052 2 2 12 9 530 2825 1396 +2053 2 2 12 9 439 1516 3248 +2054 2 2 12 9 1084 3149 3446 +2055 2 2 12 9 1085 3447 3150 +2056 2 2 12 9 986 1598 2763 +2057 2 2 12 9 987 2764 1599 +2058 2 2 12 9 831 1369 2171 +2059 2 2 12 9 1199 2537 1685 +2060 2 2 12 9 1123 1465 3018 +2061 2 2 12 9 1124 3019 1466 +2062 2 2 12 9 415 2481 1337 +2063 2 2 12 9 2743 614 1384 +2064 2 2 12 9 2744 1385 615 +2065 2 2 12 9 42 43 1800 +2066 2 2 12 9 178 179 1801 +2067 2 2 12 9 790 2204 1447 +2068 2 2 12 9 418 3278 1379 +2069 2 2 12 9 878 2585 1393 +2070 2 2 12 9 31 3076 1504 +2071 2 2 12 9 1090 2040 3045 +2072 2 2 12 9 1091 3046 2041 +2073 2 2 12 9 416 2136 1424 +2074 2 2 12 9 831 3010 1369 +2075 2 2 12 9 806 1550 1890 +2076 2 2 12 9 898 1731 2029 +2077 2 2 12 9 604 3183 2080 +2078 2 2 12 9 807 1891 1551 +2079 2 2 12 9 383 1507 2470 +2080 2 2 12 9 442 2778 2471 +2081 2 2 12 9 840 2161 2101 +2082 2 2 12 9 841 2102 2162 +2083 2 2 12 9 408 2219 1439 +2084 2 2 12 9 409 1440 2220 +2085 2 2 12 9 875 1507 2717 +2086 2 2 12 9 921 1956 1613 +2087 2 2 12 9 1074 1879 3283 +2088 2 2 12 9 545 1931 2790 +2089 2 2 12 9 338 2308 1410 +2090 2 2 12 9 531 2211 1458 +2091 2 2 12 9 1226 2933 3383 +2092 2 2 12 9 539 2112 3389 +2093 2 2 12 9 461 2309 1393 +2094 2 2 12 9 609 2608 1556 +2095 2 2 12 9 589 1404 2036 +2096 2 2 12 9 2699 3368 347 +2097 2 2 12 9 837 2408 1944 +2098 2 2 12 9 659 1527 3473 +2099 2 2 12 9 1058 3024 1448 +2100 2 2 12 9 1823 2524 3272 +2101 2 2 12 9 811 1813 1836 +2102 2 2 12 9 775 1410 2308 +2103 2 2 12 9 1337 3514 2756 +2104 2 2 12 9 1118 3103 2077 +2105 2 2 12 9 1768 3436 2668 +2106 2 2 12 9 957 2053 1849 +2107 2 2 12 9 1745 3432 3532 +2108 2 2 12 9 767 1960 1777 +2109 2 2 12 9 653 3537 1514 +2110 2 2 12 9 1347 2569 1746 +2111 2 2 12 9 403 2023 3212 +2112 2 2 12 9 404 3213 2024 +2113 2 2 12 9 1159 3524 2016 +2114 2 2 12 9 1160 2017 3525 +2115 2 2 12 9 833 2284 1522 +2116 2 2 12 9 710 3413 1598 +2117 2 2 12 9 711 1599 3414 +2118 2 2 12 9 663 3565 1435 +2119 2 2 12 9 664 1436 3566 +2120 2 2 12 9 439 3138 1653 +2121 2 2 12 9 663 2758 1654 +2122 2 2 12 9 664 1655 2759 +2123 2 2 12 9 796 1692 1960 +2124 2 2 12 9 859 2264 2187 +2125 2 2 12 9 936 2845 1397 +2126 2 2 12 9 765 3536 1652 +2127 2 2 12 9 785 1541 1873 +2128 2 2 12 9 786 1874 1542 +2129 2 2 12 9 823 1391 2275 +2130 2 2 12 9 824 2276 1392 +2131 2 2 12 9 1076 3069 1646 +2132 2 2 12 9 1053 1611 2670 +2133 2 2 12 9 481 1609 1873 +2134 2 2 12 9 482 1874 1610 +2135 2 2 12 9 754 1458 3387 +2136 2 2 12 9 567 3071 2793 +2137 2 2 12 9 1729 2881 2950 +2138 2 2 12 9 1343 2325 1585 +2139 2 2 12 9 1344 1586 2326 +2140 2 2 12 9 369 2718 1636 +2141 2 2 12 9 370 1637 2719 +2142 2 2 12 9 446 2923 1365 +2143 2 2 12 9 1241 1838 3298 +2144 2 2 12 9 1242 3300 1839 +2145 2 2 12 9 754 2676 1458 +2146 2 2 12 9 843 1747 1970 +2147 2 2 12 9 1340 2514 2241 +2148 2 2 12 9 46 3018 1465 +2149 2 2 12 9 175 1466 3019 +2150 2 2 12 9 938 1947 2006 +2151 2 2 12 9 795 1404 2491 +2152 2 2 12 9 939 2007 1948 +2153 2 2 12 9 788 1424 2136 +2154 2 2 12 9 1751 3543 3458 +2155 2 2 12 9 814 1411 2631 +2156 2 2 12 9 1338 2345 2679 +2157 2 2 12 9 343 1945 2006 +2158 2 2 12 9 342 2007 1946 +2159 2 2 12 9 1747 3011 2530 +2160 2 2 12 9 1378 1579 3526 +2161 2 2 12 9 831 2171 1645 +2162 2 2 12 9 828 1650 1836 +2163 2 2 12 9 424 2457 2409 +2164 2 2 12 9 773 1496 2299 +2165 2 2 12 9 1119 2903 2059 +2166 2 2 12 9 1781 2496 3073 +2167 2 2 12 9 981 1917 2311 +2168 2 2 12 9 1006 1753 2187 +2169 2 2 12 9 462 2188 1526 +2170 2 2 12 9 483 2316 3089 +2171 2 2 12 9 484 3090 2317 +2172 2 2 12 9 781 1425 2595 +2173 2 2 12 9 345 3144 1595 +2174 2 2 12 9 901 2355 2618 +2175 2 2 12 9 902 2619 2356 +2176 2 2 12 9 3592 365 1405 +2177 2 2 12 9 422 2898 1433 +2178 2 2 12 9 1172 1651 3354 +2179 2 2 12 9 656 1821 2109 +2180 2 2 12 9 918 3063 1945 +2181 2 2 12 9 919 1946 3064 +2182 2 2 12 9 1299 1977 2839 +2183 2 2 12 9 1300 2840 1978 +2184 2 2 12 9 1147 3248 1516 +2185 2 2 12 9 851 2300 3625 +2186 2 2 12 9 1631 1859 2725 +2187 2 2 12 9 964 1494 2146 +2188 2 2 12 9 793 2168 3029 +2189 2 2 12 9 965 2148 1495 +2190 2 2 12 9 1430 1973 3105 +2191 2 2 12 9 502 1977 2082 +2192 2 2 12 9 503 2083 1978 +2193 2 2 12 9 675 1446 3480 +2194 2 2 12 9 1886 3252 2424 +2195 2 2 12 9 814 2230 1411 +2196 2 2 12 9 477 1557 2107 +2197 2 2 12 9 1098 2008 2623 +2198 2 2 12 9 1182 1536 3583 +2199 2 2 12 9 220 1348 2665 +2200 2 2 12 9 471 1960 1692 +2201 2 2 12 9 990 1556 2608 +2202 2 2 12 9 1080 1768 2075 +2203 2 2 12 9 719 1970 1747 +2204 2 2 12 9 3040 1348 220 +2205 2 2 12 9 619 1421 2586 +2206 2 2 12 9 1083 2457 2751 +2207 2 2 12 9 388 2250 2197 +2208 2 2 12 9 474 1848 1772 +2209 2 2 12 9 210 1398 3546 +2210 2 2 12 9 480 1872 1741 +2211 2 2 12 9 986 2082 1977 +2212 2 2 12 9 987 1978 2083 +2213 2 2 12 9 1576 3147 2415 +2214 2 2 12 9 1041 1933 2395 +2215 2 2 12 9 1100 2942 1793 +2216 2 2 12 9 1101 1794 2943 +2217 2 2 12 9 445 1543 2167 +2218 2 2 12 9 746 2658 2098 +2219 2 2 12 9 1056 2221 2288 +2220 2 2 12 9 1057 2289 2222 +2221 2 2 12 9 1041 2395 2262 +2222 2 2 12 9 359 1546 1943 +2223 2 2 12 9 903 1713 1995 +2224 2 2 12 9 817 1741 1969 +2225 2 2 12 9 1090 2449 2040 +2226 2 2 12 9 1091 2041 2450 +2227 2 2 12 9 1123 3618 1465 +2228 2 2 12 9 1124 1466 3619 +2229 2 2 12 9 1099 2338 1576 +2230 2 2 12 9 825 2154 1409 +2231 2 2 12 9 883 1431 3363 +2232 2 2 12 9 964 2692 1528 +2233 2 2 12 9 965 1529 2693 +2234 2 2 12 9 1183 1597 2828 +2235 2 2 12 9 474 1772 1774 +2236 2 2 12 9 1384 614 2618 +2237 2 2 12 9 1385 2619 615 +2238 2 2 12 9 430 2944 1480 +2239 2 2 12 9 1220 1724 3252 +2240 2 2 12 9 603 1403 2970 +2241 2 2 12 9 496 3450 1532 +2242 2 2 12 9 340 1522 2284 +2243 2 2 12 9 502 1654 2839 +2244 2 2 12 9 503 2840 1655 +2245 2 2 12 9 368 1395 2877 +2246 2 2 12 9 1022 2422 1808 +2247 2 2 12 9 1025 2483 3146 +2248 2 2 12 9 521 1618 2131 +2249 2 2 12 9 818 2229 1591 +2250 2 2 12 9 1142 3407 1595 +2251 2 2 12 9 814 3040 2230 +2252 2 2 12 9 1189 1999 2646 +2253 2 2 12 9 1107 2015 2421 +2254 2 2 12 9 726 2748 1380 +2255 2 2 12 9 713 2966 2014 +2256 2 2 12 9 367 1605 3575 +2257 2 2 12 9 672 1778 3322 +2258 2 2 12 9 679 1405 3468 +2259 2 2 12 9 466 3252 1724 +2260 2 2 12 9 1443 2801 2322 +2261 2 2 12 9 391 2491 1404 +2262 2 2 12 9 1045 1667 2101 +2263 2 2 12 9 1046 2102 1668 +2264 2 2 12 9 570 2400 1455 +2265 2 2 12 9 763 1618 2180 +2266 2 2 12 9 858 1393 2436 +2267 2 2 12 9 775 1841 1872 +2268 2 2 12 9 835 3485 1409 +2269 2 2 12 9 1071 2747 1463 +2270 2 2 12 9 1204 3533 1822 +2271 2 2 12 9 1023 1998 2231 +2272 2 2 12 9 819 2107 1557 +2273 2 2 12 9 880 1834 3035 +2274 2 2 12 9 737 2718 2001 +2275 2 2 12 9 738 2002 2719 +2276 2 2 12 9 613 1378 3499 +2277 2 2 12 9 683 1953 1563 +2278 2 2 12 9 45 1465 2271 +2279 2 2 12 9 176 2272 1466 +2280 2 2 12 9 538 1702 2032 +2281 2 2 12 9 1432 2579 2857 +2282 2 2 12 9 204 205 1853 +2283 2 2 12 9 686 1569 3476 +2284 2 2 12 9 936 1397 2478 +2285 2 2 12 9 889 2354 1430 +2286 2 2 12 9 192 2579 1432 +2287 2 2 12 9 601 2146 1494 +2288 2 2 12 9 1306 2669 2697 +2289 2 2 12 9 602 1495 2148 +2290 2 2 12 9 597 1361 3184 +2291 2 2 12 9 367 1514 3440 +2292 2 2 12 9 852 2318 1419 +2293 2 2 12 9 853 1420 2319 +2294 2 2 12 9 246 2377 1660 +2295 2 2 12 9 330 1661 2378 +2296 2 2 12 9 462 2550 1769 +2297 2 2 12 9 1214 1745 3532 +2298 2 2 12 9 485 2139 1770 +2299 2 2 12 9 1415 2377 3176 +2300 2 2 12 9 1416 3177 2378 +2301 2 2 12 9 587 3335 2103 +2302 2 2 12 9 913 2028 1596 +2303 2 2 12 9 588 2104 3336 +2304 2 2 12 9 1528 2016 3524 +2305 2 2 12 9 1529 3525 2017 +2306 2 2 12 9 12 2706 2153 +2307 2 2 12 9 396 2632 1996 +2308 2 2 12 9 574 2868 2447 +2309 2 2 12 9 575 2448 2869 +2310 2 2 12 9 857 2231 1998 +2311 2 2 12 9 525 1793 3173 +2312 2 2 12 9 526 3174 1794 +2313 2 2 12 9 1793 3571 3173 +2314 2 2 12 9 798 1504 3076 +2315 2 2 12 9 1794 3174 3572 +2316 2 2 12 9 850 2425 1657 +2317 2 2 12 9 805 2076 1500 +2318 2 2 12 9 1912 2800 2495 +2319 2 2 12 9 1678 2227 3510 +2320 2 2 12 9 778 3593 2037 +2321 2 2 12 9 855 3092 1450 +2322 2 2 12 9 1219 3543 1751 +2323 2 2 12 9 490 1633 2157 +2324 2 2 12 9 25 26 1834 +2325 2 2 12 9 764 1571 2099 +2326 2 2 12 9 282 283 1733 +2327 2 2 12 9 785 1873 1609 +2328 2 2 12 9 786 1610 1874 +2329 2 2 12 9 1128 3375 2633 +2330 2 2 12 9 369 1636 2016 +2331 2 2 12 9 514 3196 1881 +2332 2 2 12 9 370 2017 1637 +2333 2 2 12 9 825 1961 1779 +2334 2 2 12 9 1087 2706 2851 +2335 2 2 12 9 948 1867 1648 +2336 2 2 12 9 1274 3439 1939 +2337 2 2 12 9 999 2579 1831 +2338 2 2 12 9 468 1366 3586 +2339 2 2 12 9 375 1894 2187 +2340 2 2 12 9 754 3387 1545 +2341 2 2 12 9 847 1533 2271 +2342 2 2 12 9 848 2272 1534 +2343 2 2 12 9 449 3126 1756 +2344 2 2 12 9 1056 3644 1419 +2345 2 2 12 9 1057 1420 3645 +2346 2 2 12 9 847 2271 1465 +2347 2 2 12 9 848 1466 2272 +2348 2 2 12 9 1433 2495 1712 +2349 2 2 12 9 820 1439 2219 +2350 2 2 12 9 888 1920 3371 +2351 2 2 12 9 821 2220 1440 +2352 2 2 12 9 918 2654 3063 +2353 2 2 12 9 3510 2227 1139 +2354 2 2 12 9 919 3064 2655 +2355 2 2 12 9 1347 1880 2861 +2356 2 2 12 9 453 1555 1962 +2357 2 2 12 9 827 2870 2293 +2358 2 2 12 9 294 295 1737 +2359 2 2 12 9 1062 1991 2795 +2360 2 2 12 9 1064 2749 2090 +2361 2 2 12 9 961 2733 1906 +2362 2 2 12 9 472 1849 2053 +2363 2 2 12 9 877 1512 2698 +2364 2 2 12 9 365 2659 1405 +2365 2 2 12 9 488 2200 1918 +2366 2 2 12 9 679 2151 1666 +2367 2 2 12 9 828 1836 1813 +2368 2 2 12 9 240 241 1743 +2369 2 2 12 9 335 336 1744 +2370 2 2 12 9 500 1422 2715 +2371 2 2 12 9 576 1512 2269 +2372 2 2 12 9 472 2053 3574 +2373 2 2 12 9 997 1660 2142 +2374 2 2 12 9 998 2143 1661 +2375 2 2 12 9 991 2109 1821 +2376 2 2 12 9 514 2299 3196 +2377 2 2 12 9 888 3371 2597 +2378 2 2 12 9 369 2985 2718 +2379 2 2 12 9 370 2719 2986 +2380 2 2 12 9 705 1884 1606 +2381 2 2 12 9 732 2433 1488 +2382 2 2 12 9 994 2730 2962 +2383 2 2 12 9 706 1607 1885 +2384 2 2 12 9 1031 2152 1864 +2385 2 2 12 9 704 3433 1972 +2386 2 2 12 9 416 1424 2821 +2387 2 2 12 9 388 3072 2177 +2388 2 2 12 9 794 3492 1733 +2389 2 2 12 9 938 2451 2384 +2390 2 2 12 9 1212 2103 2784 +2391 2 2 12 9 442 1456 3544 +2392 2 2 12 9 939 2386 2452 +2393 2 2 12 9 1213 2786 2104 +2394 2 2 12 9 1147 1516 3473 +2395 2 2 12 9 493 2850 1467 +2396 2 2 12 9 969 2040 2096 +2397 2 2 12 9 970 2097 2041 +2398 2 2 12 9 28 29 2140 +2399 2 2 12 9 299 1470 3412 +2400 2 2 12 9 419 2135 2290 +2401 2 2 12 9 880 3035 2458 +2402 2 2 12 9 630 2332 2047 +2403 2 2 12 9 631 2048 2333 +2404 2 2 12 9 583 2189 2479 +2405 2 2 12 9 694 1605 1956 +2406 2 2 12 9 991 1918 2200 +2407 2 2 12 9 717 3253 1445 +2408 2 2 12 9 32 33 1950 +2409 2 2 12 9 885 3334 2387 +2410 2 2 12 9 674 3265 1749 +2411 2 2 12 9 412 2567 1476 +2412 2 2 12 9 981 2217 1917 +2413 2 2 12 9 531 1458 2676 +2414 2 2 12 9 969 2096 2839 +2415 2 2 12 9 970 2840 2097 +2416 2 2 12 9 720 1779 1961 +2417 2 2 12 9 581 2525 3228 +2418 2 2 12 9 582 3229 2526 +2419 2 2 12 9 798 1462 2906 +2420 2 2 12 9 1391 1415 2775 +2421 2 2 12 9 1392 2776 1416 +2422 2 2 12 9 1236 3512 1703 +2423 2 2 12 9 752 2784 2103 +2424 2 2 12 9 753 2104 2786 +2425 2 2 12 9 938 2006 1945 +2426 2 2 12 9 939 1946 2007 +2427 2 2 12 9 822 2075 1768 +2428 2 2 12 9 1273 1828 3419 +2429 2 2 12 9 1362 2447 2868 +2430 2 2 12 9 1363 2869 2448 +2431 2 2 12 9 269 1521 2311 +2432 2 2 12 9 856 1917 2217 +2433 2 2 12 9 339 1589 1915 +2434 2 2 12 9 1331 3249 3014 +2435 2 2 12 9 1151 3333 3415 +2436 2 2 12 9 1070 1375 2656 +2437 2 2 12 9 459 1732 2038 +2438 2 2 12 9 44 2271 1533 +2439 2 2 12 9 177 1534 2272 +2440 2 2 12 9 48 1598 2051 +2441 2 2 12 9 173 2052 1599 +2442 2 2 12 9 1066 2316 2320 +2443 2 2 12 9 1067 2321 2317 +2444 2 2 12 9 990 1483 3100 +2445 2 2 12 9 700 1645 2171 +2446 2 2 12 9 795 2491 1374 +2447 2 2 12 9 2300 3427 473 +2448 2 2 12 9 681 3065 1451 +2449 2 2 12 9 1318 2040 2758 +2450 2 2 12 9 1319 2759 2041 +2451 2 2 12 9 719 1628 1970 +2452 2 2 12 9 299 2564 1470 +2453 2 2 12 9 1355 2571 3027 +2454 2 2 12 9 653 2512 1456 +2455 2 2 12 9 2858 3490 392 +2456 2 2 12 9 469 2165 1553 +2457 2 2 12 9 2859 393 3491 +2458 2 2 12 9 285 2989 1484 +2459 2 2 12 9 898 3041 2539 +2460 2 2 12 9 444 2510 1402 +2461 2 2 12 9 859 2444 1399 +2462 2 2 12 9 1316 1693 2549 +2463 2 2 12 9 1077 2001 2273 +2464 2 2 12 9 1078 2274 2002 +2465 2 2 12 9 222 3236 1411 +2466 2 2 12 9 872 1382 2359 +2467 2 2 12 9 775 2139 1841 +2468 2 2 12 9 1176 2329 2240 +2469 2 2 12 9 694 3204 1605 +2470 2 2 12 9 1464 2387 3334 +2471 2 2 12 9 770 1606 1884 +2472 2 2 12 9 771 1885 1607 +2473 2 2 12 9 626 1476 2270 +2474 2 2 12 9 403 1407 2557 +2475 2 2 12 9 404 2558 1408 +2476 2 2 12 9 698 2615 1852 +2477 2 2 12 9 354 2412 1645 +2478 2 2 12 9 390 1449 2252 +2479 2 2 12 9 597 1492 2210 +2480 2 2 12 9 411 2240 2329 +2481 2 2 12 9 300 1475 2564 +2482 2 2 12 9 1120 2896 3405 +2483 2 2 12 9 1647 3373 3418 +2484 2 2 12 9 772 1476 2704 +2485 2 2 12 9 1320 2098 2658 +2486 2 2 12 9 661 2756 3514 +2487 2 2 12 9 1523 2975 1837 +2488 2 2 12 9 671 1584 2003 +2489 2 2 12 9 786 1632 1964 +2490 2 2 12 9 1671 2821 2826 +2491 2 2 12 9 835 1409 3402 +2492 2 2 12 9 1410 2972 1690 +2493 2 2 12 9 562 2960 1924 +2494 2 2 12 9 564 1925 2961 +2495 2 2 12 9 1138 3267 2087 +2496 2 2 12 9 431 2236 1487 +2497 2 2 12 9 1906 2733 2916 +2498 2 2 12 9 1187 1693 3480 +2499 2 2 12 9 1100 1600 3214 +2500 2 2 12 9 1101 3215 1601 +2501 2 2 12 9 696 2906 1462 +2502 2 2 12 9 1451 3065 2250 +2503 2 2 12 9 917 1628 1882 +2504 2 2 12 9 1352 1938 3536 +2505 2 2 12 9 1133 2960 1472 +2506 2 2 12 9 1134 1473 2961 +2507 2 2 12 9 782 3636 1543 +2508 2 2 12 9 185 2399 1542 +2509 2 2 12 9 1095 3395 2537 +2510 2 2 12 9 886 2553 1383 +2511 2 2 12 9 1119 3373 1647 +2512 2 2 12 9 612 3035 1423 +2513 2 2 12 9 304 1755 2976 +2514 2 2 12 9 431 2549 1693 +2515 2 2 12 9 1598 3413 2051 +2516 2 2 12 9 1599 2052 3414 +2517 2 2 12 9 590 1429 2338 +2518 2 2 12 9 1299 2839 2096 +2519 2 2 12 9 1300 2097 2840 +2520 2 2 12 9 366 1445 2955 +2521 2 2 12 9 716 1456 2471 +2522 2 2 12 9 1309 2673 2663 +2523 2 2 12 9 1107 2421 3160 +2524 2 2 12 9 553 1638 2916 +2525 2 2 12 9 969 2758 2040 +2526 2 2 12 9 1406 2851 2061 +2527 2 2 12 9 970 2041 2759 +2528 2 2 12 9 1944 2408 3052 +2529 2 2 12 9 1162 1987 2820 +2530 2 2 12 9 885 2586 1421 +2531 2 2 12 9 1227 2433 2617 +2532 2 2 12 9 353 3292 1540 +2533 2 2 12 9 408 2101 1667 +2534 2 2 12 9 409 1668 2102 +2535 2 2 12 9 725 3391 1549 +2536 2 2 12 9 1127 1540 3292 +2537 2 2 12 9 422 1462 2406 +2538 2 2 12 9 262 263 1786 +2539 2 2 12 9 313 314 1787 +2540 2 2 12 9 50 51 1766 +2541 2 2 12 9 170 171 1767 +2542 2 2 12 9 1255 1748 2479 +2543 2 2 12 9 657 2341 1467 +2544 2 2 12 9 815 2547 1459 +2545 2 2 12 9 816 1460 2548 +2546 2 2 12 9 1037 2644 1773 +2547 2 2 12 9 472 3574 2394 +2548 2 2 12 9 270 2696 1521 +2549 2 2 12 9 1178 1602 3474 +2550 2 2 12 9 446 1418 3062 +2551 2 2 12 9 569 3156 1840 +2552 2 2 12 9 1210 1996 2632 +2553 2 2 12 9 255 2043 2739 +2554 2 2 12 9 321 2740 2044 +2555 2 2 12 9 601 1459 2547 +2556 2 2 12 9 602 2548 1460 +2557 2 2 12 9 415 1493 2194 +2558 2 2 12 9 733 1921 1694 +2559 2 2 12 9 886 1383 2438 +2560 2 2 12 9 734 1695 1922 +2561 2 2 12 9 616 2811 1425 +2562 2 2 12 9 446 1483 2923 +2563 2 2 12 9 895 1593 1958 +2564 2 2 12 9 787 2194 1493 +2565 2 2 12 9 506 2161 3045 +2566 2 2 12 9 1028 2197 2250 +2567 2 2 12 9 507 3046 2162 +2568 2 2 12 9 554 1773 2644 +2569 2 2 12 9 697 1448 2279 +2570 2 2 12 9 641 3532 3432 +2571 2 2 12 9 1809 2830 2996 +2572 2 2 12 9 1013 2253 2379 +2573 2 2 12 9 385 2040 2449 +2574 2 2 12 9 591 2697 2669 +2575 2 2 12 9 384 2450 2041 +2576 2 2 12 9 835 1872 1841 +2577 2 2 12 9 637 3179 1434 +2578 2 2 12 9 1170 3440 1514 +2579 2 2 12 9 622 3161 1478 +2580 2 2 12 9 592 2260 1441 +2581 2 2 12 9 847 1465 2591 +2582 2 2 12 9 848 2592 1466 +2583 2 2 12 9 785 1988 1672 +2584 2 2 12 9 1125 2047 2332 +2585 2 2 12 9 1076 1964 1632 +2586 2 2 12 9 1126 2333 2048 +2587 2 2 12 9 835 1741 1872 +2588 2 2 12 9 717 1927 2439 +2589 2 2 12 9 964 3050 1494 +2590 2 2 12 9 1322 2660 2242 +2591 2 2 12 9 742 2975 2606 +2592 2 2 12 9 1323 2243 2661 +2593 2 2 12 9 965 1495 3051 +2594 2 2 12 9 923 2559 1743 +2595 2 2 12 9 924 1744 2560 +2596 2 2 12 9 840 1439 2641 +2597 2 2 12 9 841 2642 1440 +2598 2 2 12 9 1263 2734 2252 +2599 2 2 12 9 380 1591 2229 +2600 2 2 12 9 899 3023 2856 +2601 2 2 12 9 947 2252 2734 +2602 2 2 12 9 1500 1972 3433 +2603 2 2 12 9 1289 2014 2966 +2604 2 2 12 9 871 1455 2400 +2605 2 2 12 9 763 3332 1516 +2606 2 2 12 9 34 1672 3042 +2607 2 2 12 9 826 2866 2462 +2608 2 2 12 9 617 2597 1401 +2609 2 2 12 9 1281 1840 3156 +2610 2 2 12 9 473 3427 2009 +2611 2 2 12 9 947 1426 2766 +2612 2 2 12 9 253 1587 2088 +2613 2 2 12 9 323 2089 1588 +2614 2 2 12 9 352 3483 2410 +2615 2 2 12 9 351 2411 3484 +2616 2 2 12 9 1152 1903 2865 +2617 2 2 12 9 353 1540 2132 +2618 2 2 12 9 743 2091 2927 +2619 2 2 12 9 3364 2948 636 +2620 2 2 12 9 871 2657 1455 +2621 2 2 12 9 659 3473 1516 +2622 2 2 12 9 486 1725 2797 +2623 2 2 12 9 487 2798 1726 +2624 2 2 12 9 1322 2780 2660 +2625 2 2 12 9 1323 2661 2781 +2626 2 2 12 9 460 2225 1491 +2627 2 2 12 9 800 1505 2371 +2628 2 2 12 9 856 2391 1917 +2629 2 2 12 9 855 2157 1633 +2630 2 2 12 9 1569 2307 3269 +2631 2 2 12 9 877 2269 1512 +2632 2 2 12 9 675 1756 2947 +2633 2 2 12 9 424 2409 1620 +2634 2 2 12 9 982 1553 2165 +2635 2 2 12 9 887 2806 1780 +2636 2 2 12 9 1468 2612 2397 +2637 2 2 12 9 908 2018 1875 +2638 2 2 12 9 1798 2649 3426 +2639 2 2 12 9 441 1930 1602 +2640 2 2 12 9 705 1606 3066 +2641 2 2 12 9 706 3067 1607 +2642 2 2 12 9 389 1596 2028 +2643 2 2 12 9 1209 1487 3481 +2644 2 2 12 9 914 1915 1673 +2645 2 2 12 9 366 1939 3439 +2646 2 2 12 9 1268 3374 2352 +2647 2 2 12 9 1593 3487 2709 +2648 2 2 12 9 838 2199 2418 +2649 2 2 12 9 201 3231 1973 +2650 2 2 12 9 913 1596 2672 +2651 2 2 12 9 365 2809 1554 +2652 2 2 12 9 958 2186 1569 +2653 2 2 12 9 794 2105 3574 +2654 2 2 12 9 812 1737 1994 +2655 2 2 12 9 1255 2479 2189 +2656 2 2 12 9 637 2393 2265 +2657 2 2 12 9 385 2096 2040 +2658 2 2 12 9 810 2397 2612 +2659 2 2 12 9 384 2041 2097 +2660 2 2 12 9 788 2577 1424 +2661 2 2 12 9 406 2912 2883 +2662 2 2 12 9 644 3458 3543 +2663 2 2 12 9 1049 3151 1758 +2664 2 2 12 9 386 1434 3594 +2665 2 2 12 9 365 3592 2298 +2666 2 2 12 9 279 1971 1635 +2667 2 2 12 9 783 1947 2117 +2668 2 2 12 9 3550 2174 812 +2669 2 2 12 9 784 2118 1948 +2670 2 2 12 9 219 2665 3032 +2671 2 2 12 9 885 1414 2586 +2672 2 2 12 9 1326 2210 3026 +2673 2 2 12 9 1094 1675 3381 +2674 2 2 12 9 189 2068 1646 +2675 2 2 12 9 785 2469 1541 +2676 2 2 12 9 458 1481 2114 +2677 2 2 12 9 459 2115 1482 +2678 2 2 12 9 570 1515 3099 +2679 2 2 12 9 1597 2948 3364 +2680 2 2 12 9 883 1666 2151 +2681 2 2 12 9 789 2286 1580 +2682 2 2 12 9 1251 3641 2628 +2683 2 2 12 9 760 2991 1816 +2684 2 2 12 9 805 1500 3433 +2685 2 2 12 9 761 1817 2992 +2686 2 2 12 9 340 1670 2578 +2687 2 2 12 9 367 3070 1514 +2688 2 2 12 9 713 2014 1675 +2689 2 2 12 9 445 2167 1486 +2690 2 2 12 9 194 2054 1831 +2691 2 2 12 9 790 1496 2822 +2692 2 2 12 9 601 2754 1459 +2693 2 2 12 9 40 41 2169 +2694 2 2 12 9 180 181 2170 +2695 2 2 12 9 602 1460 2755 +2696 2 2 12 9 990 2923 1483 +2697 2 2 12 9 918 1895 2223 +2698 2 2 12 9 919 2224 1896 +2699 2 2 12 9 920 1468 2774 +2700 2 2 12 9 772 3178 1557 +2701 2 2 12 9 1072 2916 1638 +2702 2 2 12 9 413 3027 2571 +2703 2 2 12 9 869 1433 2898 +2704 2 2 12 9 1023 2231 1812 +2705 2 2 12 9 866 3114 1469 +2706 2 2 12 9 593 2375 1407 +2707 2 2 12 9 594 1408 2376 +2708 2 2 12 9 366 3439 1927 +2709 2 2 12 9 1262 2539 3041 +2710 2 2 12 9 607 3100 1483 +2711 2 2 12 9 770 2875 1606 +2712 2 2 12 9 771 1607 2876 +2713 2 2 12 9 3490 1829 392 +2714 2 2 12 9 3491 393 1830 +2715 2 2 12 9 917 1467 2850 +2716 2 2 12 9 922 2617 1684 +2717 2 2 12 9 1042 2974 1671 +2718 2 2 12 9 355 3214 1600 +2719 2 2 12 9 292 1506 2953 +2720 2 2 12 9 356 1601 3215 +2721 2 2 12 9 420 2172 1550 +2722 2 2 12 9 2250 3065 1028 +2723 2 2 12 9 231 1500 2076 +2724 2 2 12 9 580 2865 1903 +2725 2 2 12 9 884 1590 1989 +2726 2 2 12 9 421 1551 2173 +2727 2 2 12 9 1600 2979 1892 +2728 2 2 12 9 1601 1893 2980 +2729 2 2 12 9 609 3130 1454 +2730 2 2 12 9 1116 1554 2420 +2731 2 2 12 9 672 3322 1571 +2732 2 2 12 9 1275 2471 2778 +2733 2 2 12 9 36 1541 2469 +2734 2 2 12 9 739 2016 1636 +2735 2 2 12 9 740 1637 2017 +2736 2 2 12 9 1585 2893 2618 +2737 2 2 12 9 1586 2619 2894 +2738 2 2 12 9 855 1633 2297 +2739 2 2 12 9 992 2792 2057 +2740 2 2 12 9 1018 3099 1515 +2741 2 2 12 9 993 2058 2794 +2742 2 2 12 9 920 2888 1468 +2743 2 2 12 9 774 1705 2055 +2744 2 2 12 9 1137 1881 3053 +2745 2 2 12 9 255 256 2043 +2746 2 2 12 9 320 321 2044 +2747 2 2 12 9 826 2462 1877 +2748 2 2 12 9 1049 1758 2492 +2749 2 2 12 9 783 3639 2006 +2750 2 2 12 9 784 2007 3640 +2751 2 2 12 9 3537 1170 1514 +2752 2 2 12 9 1565 1857 2712 +2753 2 2 12 9 1566 2713 1858 +2754 2 2 12 9 1190 2546 1938 +2755 2 2 12 9 519 2273 2001 +2756 2 2 12 9 457 3384 1497 +2757 2 2 12 9 520 2002 2274 +2758 2 2 12 9 972 3271 1518 +2759 2 2 12 9 794 1805 3492 +2760 2 2 12 9 522 2050 2500 +2761 2 2 12 9 689 2364 1508 +2762 2 2 12 9 1196 2956 2847 +2763 2 2 12 9 690 1509 2365 +2764 2 2 12 9 627 1432 2857 +2765 2 2 12 9 890 2242 2660 +2766 2 2 12 9 891 2661 2243 +2767 2 2 12 9 440 2774 1468 +2768 2 2 12 9 589 2585 1404 +2769 2 2 12 9 846 2802 2977 +2770 2 2 12 9 1283 2927 2091 +2771 2 2 12 9 541 3343 1926 +2772 2 2 12 9 1256 1728 2463 +2773 2 2 12 9 844 1475 2381 +2774 2 2 12 9 201 202 3231 +2775 2 2 12 9 458 2504 1718 +2776 2 2 12 9 735 3508 3309 +2777 2 2 12 9 736 3310 3509 +2778 2 2 12 9 1039 1759 1928 +2779 2 2 12 9 542 2060 2426 +2780 2 2 12 9 434 2987 1615 +2781 2 2 12 9 435 1616 2988 +2782 2 2 12 9 438 1490 2185 +2783 2 2 12 9 457 1497 2342 +2784 2 2 12 9 786 1542 2399 +2785 2 2 12 9 596 2538 1808 +2786 2 2 12 9 560 1518 2287 +2787 2 2 12 9 210 211 2065 +2788 2 2 12 9 596 2663 2673 +2789 2 2 12 9 1043 2110 1802 +2790 2 2 12 9 741 2623 2008 +2791 2 2 12 9 1044 1803 2111 +2792 2 2 12 9 577 2799 2722 +2793 2 2 12 9 652 2614 1497 +2794 2 2 12 9 2161 3171 3045 +2795 2 2 12 9 2162 3046 3172 +2796 2 2 12 9 798 2906 1504 +2797 2 2 12 9 1039 1798 3426 +2798 2 2 12 9 787 1510 2565 +2799 2 2 12 9 864 2046 2984 +2800 2 2 12 9 788 2566 1511 +2801 2 2 12 9 1563 2396 3167 +2802 2 2 12 9 1264 1927 3439 +2803 2 2 12 9 1223 3461 2554 +2804 2 2 12 9 663 1654 3565 +2805 2 2 12 9 664 3566 1655 +2806 2 2 12 9 658 2075 1665 +2807 2 2 12 9 492 3536 1938 +2808 2 2 12 9 752 2979 1997 +2809 2 2 12 9 753 2000 2980 +2810 2 2 12 9 1461 1683 3237 +2811 2 2 12 9 744 1615 2033 +2812 2 2 12 9 745 2034 1616 +2813 2 2 12 9 1686 2228 3629 +2814 2 2 12 9 710 3466 1977 +2815 2 2 12 9 711 1978 3467 +2816 2 2 12 9 760 1625 2195 +2817 2 2 12 9 761 2196 1626 +2818 2 2 12 9 750 1582 2447 +2819 2 2 12 9 751 2448 1583 +2820 2 2 12 9 352 1498 3060 +2821 2 2 12 9 351 3061 1499 +2822 2 2 12 9 982 2996 2830 +2823 2 2 12 9 460 1491 3647 +2824 2 2 12 9 600 2192 1929 +2825 2 2 12 9 1284 2426 2060 +2826 2 2 12 9 872 1641 2042 +2827 2 2 12 9 483 3089 2117 +2828 2 2 12 9 484 2118 3090 +2829 2 2 12 9 488 3550 2093 +2830 2 2 12 9 1234 2233 3085 +2831 2 2 12 9 1208 3223 2063 +2832 2 2 12 9 1099 1576 3308 +2833 2 2 12 9 440 1468 2397 +2834 2 2 12 9 670 3254 2935 +2835 2 2 12 9 842 2063 3412 +2836 2 2 12 9 698 3504 2615 +2837 2 2 12 9 215 216 2847 +2838 2 2 12 9 900 3368 1559 +2839 2 2 12 9 1072 2418 2199 +2840 2 2 12 9 1191 3322 1778 +2841 2 2 12 9 303 304 2976 +2842 2 2 12 9 456 1544 2606 +2843 2 2 12 9 416 1671 2974 +2844 2 2 12 9 727 2330 3311 +2845 2 2 12 9 728 3312 2331 +2846 2 2 12 9 835 1969 1741 +2847 2 2 12 9 673 2297 1633 +2848 2 2 12 9 367 1441 3070 +2849 2 2 12 9 901 1541 3357 +2850 2 2 12 9 902 3358 1542 +2851 2 2 12 9 699 3301 1784 +2852 2 2 12 9 782 1624 3636 +2853 2 2 12 9 569 2371 1505 +2854 2 2 12 9 603 2724 1403 +2855 2 2 12 9 972 1478 3464 +2856 2 2 12 9 431 3230 1531 +2857 2 2 12 9 992 1798 2172 +2858 2 2 12 9 993 2173 1799 +2859 2 2 12 9 936 3419 1828 +2860 2 2 12 9 1359 1870 2460 +2861 2 2 12 9 1033 1600 2336 +2862 2 2 12 9 1140 2500 2050 +2863 2 2 12 9 415 2950 1493 +2864 2 2 12 9 1034 2337 1601 +2865 2 2 12 9 1022 1808 2538 +2866 2 2 12 9 1608 3574 2105 +2867 2 2 12 9 1025 3146 2166 +2868 2 2 12 9 589 1457 2436 +2869 2 2 12 9 636 2948 1552 +2870 2 2 12 9 640 2672 1596 +2871 2 2 12 9 414 1933 2968 +2872 2 2 12 9 836 1480 3431 +2873 2 2 12 9 764 2005 1617 +2874 2 2 12 9 627 2857 1555 +2875 2 2 12 9 1148 2966 2068 +2876 2 2 12 9 787 2552 1510 +2877 2 2 12 9 31 32 3076 +2878 2 2 12 9 1214 3532 1524 +2879 2 2 12 9 880 1902 2084 +2880 2 2 12 9 748 2846 1487 +2881 2 2 12 9 1306 2697 1629 +2882 2 2 12 9 1165 1568 3459 +2883 2 2 12 9 788 1511 2577 +2884 2 2 12 9 478 2404 1502 +2885 2 2 12 9 479 1503 2405 +2886 2 2 12 9 510 1608 2105 +2887 2 2 12 9 1652 2329 3131 +2888 2 2 12 9 343 1734 1895 +2889 2 2 12 9 368 1457 2753 +2890 2 2 12 9 29 3015 2140 +2891 2 2 12 9 342 1896 1735 +2892 2 2 12 9 626 2704 1476 +2893 2 2 12 9 901 2893 1873 +2894 2 2 12 9 902 1874 2894 +2895 2 2 12 9 1656 2174 3550 +2896 2 2 12 9 813 1614 2072 +2897 2 2 12 9 792 1782 1955 +2898 2 2 12 9 254 2739 1587 +2899 2 2 12 9 322 1588 2740 +2900 2 2 12 9 730 1935 1679 +2901 2 2 12 9 731 1680 1936 +2902 2 2 12 9 471 1777 1960 +2903 2 2 12 9 445 2147 1543 +2904 2 2 12 9 1574 2137 2920 +2905 2 2 12 9 1575 2921 2138 +2906 2 2 12 9 496 2380 1842 +2907 2 2 12 9 1083 2409 2457 +2908 2 2 12 9 513 1513 2973 +2909 2 2 12 9 670 3401 1577 +2910 2 2 12 9 866 1469 3397 +2911 2 2 12 9 999 2857 2579 +2912 2 2 12 9 530 2204 2825 +2913 2 2 12 9 946 1720 2084 +2914 2 2 12 9 789 1634 2286 +2915 2 2 12 9 1327 2880 1806 +2916 2 2 12 9 972 2370 1478 +2917 2 2 12 9 1339 3517 2905 +2918 2 2 12 9 1472 2382 3369 +2919 2 2 12 9 1473 3370 2383 +2920 2 2 12 9 901 2618 2893 +2921 2 2 12 9 902 2894 2619 +2922 2 2 12 9 1106 2407 2968 +2923 2 2 12 9 187 3069 1632 +2924 2 2 12 9 1114 1672 1988 +2925 2 2 12 9 1077 1897 2710 +2926 2 2 12 9 1078 2711 1898 +2927 2 2 12 9 304 2535 1755 +2928 2 2 12 9 1223 2554 1900 +2929 2 2 12 9 1224 1901 2555 +2930 2 2 12 9 820 2382 1439 +2931 2 2 12 9 821 1440 2383 +2932 2 2 12 9 349 2812 1442 +2933 2 2 12 9 846 2749 2020 +2934 2 2 12 9 1228 2265 2393 +2935 2 2 12 9 515 1640 2181 +2936 2 2 12 9 1011 2201 2638 +2937 2 2 12 9 462 3281 2550 +2938 2 2 12 9 986 2763 1766 +2939 2 2 12 9 987 1767 2764 +2940 2 2 12 9 1282 2997 2517 +2941 2 2 12 9 806 2862 1550 +2942 2 2 12 9 807 1551 2864 +2943 2 2 12 9 782 1543 2147 +2944 2 2 12 9 911 1574 2920 +2945 2 2 12 9 912 2921 1575 +2946 2 2 12 9 368 2742 1457 +2947 2 2 12 9 632 2066 1728 +2948 2 2 12 9 659 1516 3332 +2949 2 2 12 9 1255 2189 2683 +2950 2 2 12 9 983 2950 2881 +2951 2 2 12 9 1162 2407 3382 +2952 2 2 12 9 430 2750 1569 +2953 2 2 12 9 920 1562 2144 +2954 2 2 12 9 958 1569 2750 +2955 2 2 12 9 773 2299 1704 +2956 2 2 12 9 802 2632 1552 +2957 2 2 12 9 786 2399 1632 +2958 2 2 12 9 623 2612 1468 +2959 2 2 12 9 742 2506 1837 +2960 2 2 12 9 630 2660 2780 +2961 2 2 12 9 631 2781 2661 +2962 2 2 12 9 946 2694 1720 +2963 2 2 12 9 463 2843 1517 +2964 2 2 12 9 712 2863 1913 +2965 2 2 12 9 721 2887 1530 +2966 2 2 12 9 1900 2554 3152 +2967 2 2 12 9 1901 3153 2555 +2968 2 2 12 9 675 2947 1446 +2969 2 2 12 9 1151 3021 2485 +2970 2 2 12 9 811 2132 1540 +2971 2 2 12 9 727 2223 1895 +2972 2 2 12 9 728 1896 2224 +2973 2 2 12 9 819 3648 2287 +2974 2 2 12 9 477 3464 1984 +2975 2 2 12 9 704 3237 1683 +2976 2 2 12 9 1340 3552 3390 +2977 2 2 12 9 472 2861 1849 +2978 2 2 12 9 697 3043 1448 +2979 2 2 12 9 622 1562 2584 +2980 2 2 12 9 1233 3032 2665 +2981 2 2 12 9 897 3586 2363 +2982 2 2 12 9 647 1861 2023 +2983 2 2 12 9 739 1437 3534 +2984 2 2 12 9 648 2024 1862 +2985 2 2 12 9 740 3535 1438 +2986 2 2 12 9 390 2362 1537 +2987 2 2 12 9 488 2398 3550 +2988 2 2 12 9 675 3480 1693 +2989 2 2 12 9 791 1831 2054 +2990 2 2 12 9 600 1442 3435 +2991 2 2 12 9 515 2835 1640 +2992 2 2 12 9 246 247 2377 +2993 2 2 12 9 329 330 2378 +2994 2 2 12 9 1118 2116 3379 +2995 2 2 12 9 798 2685 1714 +2996 2 2 12 9 376 2417 1921 +2997 2 2 12 9 513 2897 3419 +2998 2 2 12 9 444 1558 2510 +2999 2 2 12 9 491 1812 2231 +3000 2 2 12 9 659 3332 1546 +3001 2 2 12 9 938 2384 1947 +3002 2 2 12 9 939 1948 2386 +3003 2 2 12 9 879 1538 2683 +3004 2 2 12 9 893 2320 2316 +3005 2 2 12 9 894 2317 2321 +3006 2 2 12 9 382 2072 2158 +3007 2 2 12 9 649 1907 3547 +3008 2 2 12 9 1276 2941 1932 +3009 2 2 12 9 468 1474 2403 +3010 2 2 12 9 1087 2153 2706 +3011 2 2 12 9 448 1992 2511 +3012 2 2 12 9 789 1580 2454 +3013 2 2 12 9 8 1464 3101 +3014 2 2 12 9 360 1982 1730 +3015 2 2 12 9 494 2666 2223 +3016 2 2 12 9 1157 2626 1843 +3017 2 2 12 9 1158 1844 2627 +3018 2 2 12 9 495 2224 2667 +3019 2 2 12 9 549 1524 2836 +3020 2 2 12 9 1114 3042 1672 +3021 2 2 12 9 696 1504 2906 +3022 2 2 12 9 1309 1642 2673 +3023 2 2 12 9 194 195 2054 +3024 2 2 12 9 737 2710 1427 +3025 2 2 12 9 738 1428 2711 +3026 2 2 12 9 3567 3200 1015 +3027 2 2 12 9 3568 1016 3201 +3028 2 2 12 9 820 3369 2382 +3029 2 2 12 9 821 2383 3370 +3030 2 2 12 9 729 2549 1531 +3031 2 2 12 9 1662 3121 2702 +3032 2 2 12 9 1663 2703 3122 +3033 2 2 12 9 3167 2396 1050 +3034 2 2 12 9 828 3540 1650 +3035 2 2 12 9 649 3547 2813 +3036 2 2 12 9 1154 1919 3001 +3037 2 2 12 9 819 1939 3457 +3038 2 2 12 9 1446 1993 3480 +3039 2 2 12 9 737 1636 2718 +3040 2 2 12 9 738 2719 1637 +3041 2 2 12 9 829 1802 2110 +3042 2 2 12 9 830 2111 1803 +3043 2 2 12 9 1228 2856 3023 +3044 2 2 12 9 518 2278 1964 +3045 2 2 12 9 422 3634 1489 +3046 2 2 12 9 682 2881 1729 +3047 2 2 12 9 640 2149 1602 +3048 2 2 12 9 1414 2895 2586 +3049 2 2 12 9 808 1743 2559 +3050 2 2 12 9 809 2560 1744 +3051 2 2 12 9 972 1518 2912 +3052 2 2 12 9 635 1926 2492 +3053 2 2 12 9 396 2507 1552 +3054 2 2 12 9 623 1468 2888 +3055 2 2 12 9 1077 2273 2219 +3056 2 2 12 9 1078 2220 2274 +3057 2 2 12 9 521 2180 1618 +3058 2 2 12 9 785 1672 2469 +3059 2 2 12 9 501 2084 1902 +3060 2 2 12 9 399 2822 1496 +3061 2 2 12 9 1429 2904 1959 +3062 2 2 12 9 935 1863 2055 +3063 2 2 12 9 619 2586 2895 +3064 2 2 12 9 735 3309 1508 +3065 2 2 12 9 1657 2425 3445 +3066 2 2 12 9 1780 2806 2580 +3067 2 2 12 9 829 2110 3462 +3068 2 2 12 9 830 3463 2111 +3069 2 2 12 9 736 1509 3310 +3070 2 2 12 9 36 3357 1541 +3071 2 2 12 9 185 1542 3358 +3072 2 2 12 9 202 203 2294 +3073 2 2 12 9 758 3305 1759 +3074 2 2 12 9 1021 2799 2533 +3075 2 2 12 9 617 1471 2653 +3076 2 2 12 9 763 2180 1943 +3077 2 2 12 9 801 1840 2664 +3078 2 2 12 9 638 1564 2521 +3079 2 2 12 9 935 2497 2022 +3080 2 2 12 9 942 2131 1630 +3081 2 2 12 9 1387 2373 3446 +3082 2 2 12 9 1388 3447 2374 +3083 2 2 12 9 729 1531 2439 +3084 2 2 12 9 517 1988 2277 +3085 2 2 12 9 950 2213 2155 +3086 2 2 12 9 951 2156 2214 +3087 2 2 12 9 665 1532 2414 +3088 2 2 12 9 1211 2061 1931 +3089 2 2 12 9 723 3596 1560 +3090 2 2 12 9 724 1561 3597 +3091 2 2 12 9 627 1555 2529 +3092 2 2 12 9 864 2984 2480 +3093 2 2 12 9 676 3308 1576 +3094 2 2 12 9 1400 3547 1907 +3095 2 2 12 9 795 2027 1669 +3096 2 2 12 9 1020 2815 2280 +3097 2 2 12 9 955 3526 2562 +3098 2 2 12 9 1038 2479 1748 +3099 2 2 12 9 950 2155 1824 +3100 2 2 12 9 951 1825 2156 +3101 2 2 12 9 7 3101 3261 +3102 2 2 12 9 977 1929 2192 +3103 2 2 12 9 1040 3545 1799 +3104 2 2 12 9 441 2520 1681 +3105 2 2 12 9 1250 1784 3301 +3106 2 2 12 9 31 1504 3129 +3107 2 2 12 9 295 1994 1737 +3108 2 2 12 9 1161 3043 1930 +3109 2 2 12 9 3510 364 2334 +3110 2 2 12 9 806 2502 1761 +3111 2 2 12 9 807 1762 2503 +3112 2 2 12 9 534 2235 2908 +3113 2 2 12 9 1340 3390 2514 +3114 2 2 12 9 396 2905 3517 +3115 2 2 12 9 1501 2522 3441 +3116 2 2 12 9 1613 3505 2841 +3117 2 2 12 9 1799 3545 2650 +3118 2 2 12 9 3505 691 2841 +3119 2 2 12 9 691 2484 1692 +3120 2 2 12 9 462 1769 2188 +3121 2 2 12 9 787 1493 2552 +3122 2 2 12 9 1221 3429 2505 +3123 2 2 12 9 865 1920 2062 +3124 2 2 12 9 862 2346 2066 +3125 2 2 12 9 829 2277 1609 +3126 2 2 12 9 614 1585 2618 +3127 2 2 12 9 830 1610 2278 +3128 2 2 12 9 615 2619 1586 +3129 2 2 12 9 1029 2037 1902 +3130 2 2 12 9 822 1665 2075 +3131 2 2 12 9 774 2055 1863 +3132 2 2 12 9 1326 3026 2193 +3133 2 2 12 9 426 2301 1606 +3134 2 2 12 9 427 1607 2302 +3135 2 2 12 9 548 3585 1593 +3136 2 2 12 9 1076 1632 3069 +3137 2 2 12 9 1269 3632 1789 +3138 2 2 12 9 759 1677 2620 +3139 2 2 12 9 1170 3537 1664 +3140 2 2 12 9 983 1493 2950 +3141 2 2 12 9 411 2234 1780 +3142 2 2 12 9 777 2115 3266 +3143 2 2 12 9 700 1822 3533 +3144 2 2 12 9 776 2568 2114 +3145 2 2 12 9 258 259 1868 +3146 2 2 12 9 317 318 1869 +3147 2 2 12 9 566 2455 1621 +3148 2 2 12 9 473 2570 1471 +3149 2 2 12 9 999 1555 2857 +3150 2 2 12 9 585 3187 3628 +3151 2 2 12 9 278 1635 3044 +3152 2 2 12 9 780 2049 3600 +3153 2 2 12 9 469 1723 2165 +3154 2 2 12 9 961 3220 1578 +3155 2 2 12 9 420 1550 2862 +3156 2 2 12 9 1603 2872 2845 +3157 2 2 12 9 421 2864 1551 +3158 2 2 12 9 617 3005 1490 +3159 2 2 12 9 466 2473 2424 +3160 2 2 12 9 847 2994 1533 +3161 2 2 12 9 848 1534 2995 +3162 2 2 12 9 795 1669 2345 +3163 2 2 12 9 827 1982 2870 +3164 2 2 12 9 1008 2157 2268 +3165 2 2 12 9 454 1824 2155 +3166 2 2 12 9 455 2156 1825 +3167 2 2 12 9 879 2874 1538 +3168 2 2 12 9 1166 1643 3613 +3169 2 2 12 9 790 3196 1496 +3170 2 2 12 9 607 1483 2736 +3171 2 2 12 9 475 2702 3121 +3172 2 2 12 9 476 3122 2703 +3173 2 2 12 9 1185 2079 1689 +3174 2 2 12 9 660 2949 1526 +3175 2 2 12 9 1383 3593 3307 +3176 2 2 12 9 726 1674 2092 +3177 2 2 12 9 39 40 2126 +3178 2 2 12 9 1478 1984 3464 +3179 2 2 12 9 181 182 2127 +3180 2 2 12 9 727 1622 2223 +3181 2 2 12 9 900 1883 2013 +3182 2 2 12 9 728 2224 1623 +3183 2 2 12 9 923 1743 2600 +3184 2 2 12 9 924 2601 1744 +3185 2 2 12 9 663 2266 2758 +3186 2 2 12 9 664 2759 2267 +3187 2 2 12 9 1507 3600 2049 +3188 2 2 12 9 808 1721 3243 +3189 2 2 12 9 809 3244 1722 +3190 2 2 12 9 1770 2139 2911 +3191 2 2 12 9 506 2540 2161 +3192 2 2 12 9 507 2162 2541 +3193 2 2 12 9 820 2219 2273 +3194 2 2 12 9 821 2274 2220 +3195 2 2 12 9 1424 2577 3074 +3196 2 2 12 9 920 1539 2584 +3197 2 2 12 9 1090 3171 1658 +3198 2 2 12 9 1091 1659 3172 +3199 2 2 12 9 1014 2973 1513 +3200 2 2 12 9 1204 2462 2866 +3201 2 2 12 9 1116 2420 2701 +3202 2 2 12 9 880 2084 1720 +3203 2 2 12 9 205 206 3068 +3204 2 2 12 9 1485 3379 2116 +3205 2 2 12 9 720 1961 1845 +3206 2 2 12 9 732 3264 1684 +3207 2 2 12 9 486 2797 2120 +3208 2 2 12 9 487 2121 2798 +3209 2 2 12 9 422 1530 2898 +3210 2 2 12 9 1049 2492 1926 +3211 2 2 12 9 1759 3305 1928 +3212 2 2 12 9 709 3013 2060 +3213 2 2 12 9 1073 1728 2066 +3214 2 2 12 9 1079 3194 1535 +3215 2 2 12 9 13 14 1910 +3216 2 2 12 9 1295 2925 2767 +3217 2 2 12 9 846 2977 2086 +3218 2 2 12 9 804 2029 1774 +3219 2 2 12 9 831 2181 1640 +3220 2 2 12 9 606 2198 1882 +3221 2 2 12 9 864 2480 2251 +3222 2 2 12 9 444 3211 1558 +3223 2 2 12 9 937 2826 2821 +3224 2 2 12 9 2115 3489 3266 +3225 2 2 12 9 1424 3074 2821 +3226 2 2 12 9 871 2510 1558 +3227 2 2 12 9 886 2438 3194 +3228 2 2 12 9 423 1590 3048 +3229 2 2 12 9 468 3417 1474 +3230 2 2 12 9 864 2116 2046 +3231 2 2 12 9 628 1999 2795 +3232 2 2 12 9 832 1940 2296 +3233 2 2 12 9 755 1983 3054 +3234 2 2 12 9 438 2193 3026 +3235 2 2 12 9 797 1524 3189 +3236 2 2 12 9 16 2671 2283 +3237 2 2 12 9 611 3074 2577 +3238 2 2 12 9 840 1658 3171 +3239 2 2 12 9 841 3172 1659 +3240 2 2 12 9 1115 2511 1992 +3241 2 2 12 9 1017 2201 2908 +3242 2 2 12 9 1510 3443 3385 +3243 2 2 12 9 1511 3386 3444 +3244 2 2 12 9 799 3188 1525 +3245 2 2 12 9 428 1577 3449 +3246 2 2 12 9 1183 2424 2473 +3247 2 2 12 9 1313 3561 3132 +3248 2 2 12 9 567 2010 1878 +3249 2 2 12 9 1314 3133 3562 +3250 2 2 12 9 407 3001 1919 +3251 2 2 12 9 1379 1837 2506 +3252 2 2 12 9 396 1552 2632 +3253 2 2 12 9 808 3243 1743 +3254 2 2 12 9 809 1744 3244 +3255 2 2 12 9 613 2176 3356 +3256 2 2 12 9 1260 3173 2938 +3257 2 2 12 9 1261 2939 3174 +3258 2 2 12 9 470 2683 1538 +3259 2 2 12 9 948 2910 3531 +3260 2 2 12 9 1582 3200 3567 +3261 2 2 12 9 1583 3568 3201 +3262 2 2 12 9 697 1930 3043 +3263 2 2 12 9 669 2328 1770 +3264 2 2 12 9 1098 2623 1670 +3265 2 2 12 9 512 2174 1656 +3266 2 2 12 9 948 3531 1867 +3267 2 2 12 9 1477 3356 2176 +3268 2 2 12 9 867 1620 2409 +3269 2 2 12 9 1675 2014 3381 +3270 2 2 12 9 876 1621 2455 +3271 2 2 12 9 958 2750 2726 +3272 2 2 12 9 921 1613 2841 +3273 2 2 12 9 653 1664 3537 +3274 2 2 12 9 549 2227 1611 +3275 2 2 12 9 389 1944 2616 +3276 2 2 12 9 1103 3014 3249 +3277 2 2 12 9 1111 2022 2497 +3278 2 2 12 9 539 2286 1634 +3279 2 2 12 9 963 2602 3275 +3280 2 2 12 9 1009 3630 1827 +3281 2 2 12 9 857 1998 2392 +3282 2 2 12 9 1051 1791 3477 +3283 2 2 12 9 1129 1763 3437 +3284 2 2 12 9 826 2164 1814 +3285 2 2 12 9 1271 1700 2215 +3286 2 2 12 9 1272 2216 1701 +3287 2 2 12 9 545 3635 1570 +3288 2 2 12 9 792 2735 1782 +3289 2 2 12 9 804 1777 2379 +3290 2 2 12 9 699 1544 3301 +3291 2 2 12 9 860 2142 1660 +3292 2 2 12 9 861 1661 2143 +3293 2 2 12 9 649 2425 1907 +3294 2 2 12 9 1352 1670 2623 +3295 2 2 12 9 1678 3510 2334 +3296 2 2 12 9 1015 3200 1816 +3297 2 2 12 9 1016 1817 3201 +3298 2 2 12 9 920 2584 1562 +3299 2 2 12 9 621 2845 2872 +3300 2 2 12 9 742 2606 1544 +3301 2 2 12 9 765 3131 2179 +3302 2 2 12 9 642 2993 2108 +3303 2 2 12 9 892 3546 3486 +3304 2 2 12 9 1186 1638 3345 +3305 2 2 12 9 1152 3044 1635 +3306 2 2 12 9 460 3459 3515 +3307 2 2 12 9 838 3265 1581 +3308 2 2 12 9 438 3026 1492 +3309 2 2 12 9 813 2518 2188 +3310 2 2 12 9 660 3020 1570 +3311 2 2 12 9 931 2134 2086 +3312 2 2 12 9 1052 2428 2140 +3313 2 2 12 9 695 3352 1594 +3314 2 2 12 9 1207 3285 1839 +3315 2 2 12 9 1203 3077 2964 +3316 2 2 12 9 515 2055 1705 +3317 2 2 12 9 480 2972 1872 +3318 2 2 12 9 801 2664 2013 +3319 2 2 12 9 402 2015 2527 +3320 2 2 12 9 1018 1515 2940 +3321 2 2 12 9 914 2206 2707 +3322 2 2 12 9 1100 2336 1600 +3323 2 2 12 9 1101 1601 2337 +3324 2 2 12 9 464 1796 2011 +3325 2 2 12 9 465 2012 1797 +3326 2 2 12 9 555 2482 1673 +3327 2 2 12 9 1284 2060 3013 +3328 2 2 12 9 340 2593 1522 +3329 2 2 12 9 1246 2772 2212 +3330 2 2 12 9 854 2163 3388 +3331 2 2 12 9 701 1635 2855 +3332 2 2 12 9 1020 2596 3642 +3333 2 2 12 9 847 1565 2994 +3334 2 2 12 9 848 2995 1566 +3335 2 2 12 9 478 2573 2129 +3336 2 2 12 9 479 2130 2574 +3337 2 2 12 9 1074 1558 3211 +3338 2 2 12 9 869 2898 1530 +3339 2 2 12 9 1268 2352 3306 +3340 2 2 12 9 815 1698 2388 +3341 2 2 12 9 673 2826 2298 +3342 2 2 12 9 816 2389 1699 +3343 2 2 12 9 341 3441 2522 +3344 2 2 12 9 887 1780 2234 +3345 2 2 12 9 909 1559 2699 +3346 2 2 12 9 621 1839 3285 +3347 2 2 12 9 776 2133 2568 +3348 2 2 12 9 796 2032 1702 +3349 2 2 12 9 904 1494 3454 +3350 2 2 12 9 876 2580 3306 +3351 2 2 12 9 905 3455 1495 +3352 2 2 12 9 1139 2568 2133 +3353 2 2 12 9 799 2038 1732 +3354 2 2 12 9 1318 2758 2266 +3355 2 2 12 9 1319 2267 2759 +3356 2 2 12 9 1196 1643 3104 +3357 2 2 12 9 896 1770 2328 +3358 2 2 12 9 565 2828 2042 +3359 2 2 12 9 488 2805 2200 +3360 2 2 12 9 1054 1572 2723 +3361 2 2 12 9 641 1629 3404 +3362 2 2 12 9 52 1721 3218 +3363 2 2 12 9 169 3219 1722 +3364 2 2 12 9 458 3348 2504 +3365 2 2 12 9 764 3499 2005 +3366 2 2 12 9 673 1671 2826 +3367 2 2 12 9 47 48 2051 +3368 2 2 12 9 173 174 2052 +3369 2 2 12 9 456 2606 1739 +3370 2 2 12 9 797 3189 1592 +3371 2 2 12 9 1073 2066 2346 +3372 2 2 12 9 684 3113 3185 +3373 2 2 12 9 1004 2023 1861 +3374 2 2 12 9 1005 1862 2024 +3375 2 2 12 9 1849 2861 3595 +3376 2 2 12 9 430 1569 3269 +3377 2 2 12 9 434 1565 2712 +3378 2 2 12 9 435 2713 1566 +3379 2 2 12 9 680 1619 2327 +3380 2 2 12 9 672 3238 1778 +3381 2 2 12 9 983 3028 1493 +3382 2 2 12 9 643 3613 1643 +3383 2 2 12 9 543 3200 1582 +3384 2 2 12 9 544 1583 3201 +3385 2 2 12 9 756 1904 3279 +3386 2 2 12 9 358 2714 3470 +3387 2 2 12 9 757 3280 1905 +3388 2 2 12 9 871 1558 2695 +3389 2 2 12 9 454 2155 1888 +3390 2 2 12 9 1060 1729 2145 +3391 2 2 12 9 455 1889 2156 +3392 2 2 12 9 855 2268 2157 +3393 2 2 12 9 488 2093 2805 +3394 2 2 12 9 1069 3522 1596 +3395 2 2 12 9 1357 2486 1700 +3396 2 2 12 9 1358 1701 2487 +3397 2 2 12 9 535 3429 2854 +3398 2 2 12 9 660 1526 3020 +3399 2 2 12 9 415 2145 1729 +3400 2 2 12 9 803 2212 2772 +3401 2 2 12 9 799 1595 3188 +3402 2 2 12 9 1054 2571 1572 +3403 2 2 12 9 917 1882 2198 +3404 2 2 12 9 1097 1591 3250 +3405 2 2 12 9 1207 3038 1934 +3406 2 2 12 9 911 2440 2094 +3407 2 2 12 9 912 2095 2441 +3408 2 2 12 9 641 1592 3189 +3409 2 2 12 9 1076 1646 2446 +3410 2 2 12 9 272 2903 1647 +3411 2 2 12 9 1013 2891 1860 +3412 2 2 12 9 976 3020 1526 +3413 2 2 12 9 729 2175 1826 +3414 2 2 12 9 1674 2071 3256 +3415 2 2 12 9 383 2470 1556 +3416 2 2 12 9 1108 2042 2828 +3417 2 2 12 9 937 2821 3074 +3418 2 2 12 9 1002 2643 1573 +3419 2 2 12 9 937 3008 2826 +3420 2 2 12 9 808 3218 1721 +3421 2 2 12 9 809 1722 3219 +3422 2 2 12 9 535 2445 3429 +3423 2 2 12 9 1014 1809 2757 +3424 2 2 12 9 1602 1930 3474 +3425 2 2 12 9 1012 1963 2976 +3426 2 2 12 9 347 2595 2699 +3427 2 2 12 9 817 2589 1741 +3428 2 2 12 9 1486 3185 3113 +3429 2 2 12 9 940 1549 2380 +3430 2 2 12 9 501 1902 2037 +3431 2 2 12 9 888 2062 1920 +3432 2 2 12 9 814 1604 2493 +3433 2 2 12 9 964 1528 2936 +3434 2 2 12 9 965 2937 1529 +3435 2 2 12 9 554 2517 2997 +3436 2 2 12 9 558 2837 2100 +3437 2 2 12 9 375 2187 1753 +3438 2 2 12 9 492 1652 3536 +3439 2 2 12 9 1052 3193 1712 +3440 2 2 12 9 644 3407 1642 +3441 2 2 12 9 833 1782 2124 +3442 2 2 12 9 1604 2883 1024 +3443 2 2 12 9 931 3302 1512 +3444 2 2 12 9 453 2628 1555 +3445 2 2 12 9 1014 2184 3442 +3446 2 2 12 9 644 3188 1595 +3447 2 2 12 9 1938 2546 3498 +3448 2 2 12 9 480 1690 2972 +3449 2 2 12 9 304 305 2535 +3450 2 2 12 9 1477 3202 3399 +3451 2 2 12 9 890 1662 2702 +3452 2 2 12 9 891 2703 1663 +3453 2 2 12 9 1184 2251 2480 +3454 2 2 12 9 646 2824 2315 +3455 2 2 12 9 1379 3278 1879 +3456 2 2 12 9 752 1892 2979 +3457 2 2 12 9 846 2086 2134 +3458 2 2 12 9 753 2980 1893 +3459 2 2 12 9 714 2928 1639 +3460 2 2 12 9 1225 2100 2837 +3461 2 2 12 9 276 277 2238 +3462 2 2 12 9 411 1780 2240 +3463 2 2 12 9 956 2596 2280 +3464 2 2 12 9 537 2871 2226 +3465 2 2 12 9 189 190 2068 +3466 2 2 12 9 2082 2559 3558 +3467 2 2 12 9 2083 3559 2560 +3468 2 2 12 9 1189 2795 1999 +3469 2 2 12 9 1121 2739 2043 +3470 2 2 12 9 1122 2044 2740 +3471 2 2 12 9 975 2513 3003 +3472 2 2 12 9 933 1619 2842 +3473 2 2 12 9 272 1647 3148 +3474 2 2 12 9 641 3432 1629 +3475 2 2 12 9 346 1856 2657 +3476 2 2 12 9 498 2475 1966 +3477 2 2 12 9 744 1533 2994 +3478 2 2 12 9 745 2995 1534 +3479 2 2 12 9 925 2215 1700 +3480 2 2 12 9 926 1701 2216 +3481 2 2 12 9 916 2872 1603 +3482 2 2 12 9 1507 2049 2717 +3483 2 2 12 9 1247 3465 2067 +3484 2 2 12 9 660 1570 2998 +3485 2 2 12 9 710 1598 3466 +3486 2 2 12 9 711 3467 1599 +3487 2 2 12 9 1053 2285 1611 +3488 2 2 12 9 895 2460 1593 +3489 2 2 12 9 186 1632 2399 +3490 2 2 12 9 595 1559 2634 +3491 2 2 12 9 851 1634 2300 +3492 2 2 12 9 1121 2025 3319 +3493 2 2 12 9 1122 3320 2026 +3494 2 2 12 9 469 1553 2679 +3495 2 2 12 9 346 2253 1856 +3496 2 2 12 9 197 2454 1580 +3497 2 2 12 9 703 1789 3632 +3498 2 2 12 9 523 2124 1782 +3499 2 2 12 9 820 2273 3369 +3500 2 2 12 9 821 3370 2274 +3501 2 2 12 9 457 3316 1955 +3502 2 2 12 9 749 2061 2851 +3503 2 2 12 9 1161 2488 1683 +3504 2 2 12 9 986 3466 1598 +3505 2 2 12 9 987 1599 3467 +3506 2 2 12 9 727 3311 1622 +3507 2 2 12 9 728 1623 3312 +3508 2 2 12 9 1172 3354 2159 +3509 2 2 12 9 680 2842 1619 +3510 2 2 12 9 800 1875 2018 +3511 2 2 12 9 1364 3112 3242 +3512 2 2 12 9 1378 3526 2812 +3513 2 2 12 9 801 2013 1883 +3514 2 2 12 9 241 2600 1743 +3515 2 2 12 9 335 1744 2601 +3516 2 2 12 9 642 2684 2993 +3517 2 2 12 9 583 3085 2233 +3518 2 2 12 9 1141 3404 1629 +3519 2 2 12 9 883 3363 1666 +3520 2 2 12 9 279 280 1971 +3521 2 2 12 9 359 3024 1546 +3522 2 2 12 9 1234 2039 2233 +3523 2 2 12 9 707 2745 2255 +3524 2 2 12 9 708 2256 2746 +3525 2 2 12 9 868 1878 2010 +3526 2 2 12 9 419 3165 1870 +3527 2 2 12 9 1282 2517 3255 +3528 2 2 12 9 808 1766 3218 +3529 2 2 12 9 809 3219 1767 +3530 2 2 12 9 844 2160 2218 +3531 2 2 12 9 904 2155 2213 +3532 2 2 12 9 905 2214 2156 +3533 2 2 12 9 984 2686 2341 +3534 2 2 12 9 518 1675 3153 +3535 2 2 12 9 719 3124 1628 +3536 2 2 12 9 1321 1984 3161 +3537 2 2 12 9 1235 2707 2206 +3538 2 2 12 9 1606 2301 3066 +3539 2 2 12 9 1607 3067 2302 +3540 2 2 12 9 673 1633 2889 +3541 2 2 12 9 1273 2609 1828 +3542 2 2 12 9 1065 3349 2249 +3543 2 2 12 9 638 3481 2846 +3544 2 2 12 9 683 1563 3167 +3545 2 2 12 9 920 2774 1539 +3546 2 2 12 9 1107 2527 2015 +3547 2 2 12 9 1557 3178 1939 +3548 2 2 12 9 1090 1658 2449 +3549 2 2 12 9 652 1522 3157 +3550 2 2 12 9 1091 2450 1659 +3551 2 2 12 9 831 1645 2412 +3552 2 2 12 9 636 1746 3364 +3553 2 2 12 9 854 3388 2474 +3554 2 2 12 9 1074 3283 1558 +3555 2 2 12 9 789 2454 1783 +3556 2 2 12 9 1333 2298 2826 +3557 2 2 12 9 481 1585 2325 +3558 2 2 12 9 482 2326 1586 +3559 2 2 12 9 859 2187 1894 +3560 2 2 12 9 804 2004 2029 +3561 2 2 12 9 221 222 2230 +3562 2 2 12 9 449 1866 3123 +3563 2 2 12 9 1545 3387 3400 +3564 2 2 12 9 1086 2616 1944 +3565 2 2 12 9 644 1642 3458 +3566 2 2 12 9 1317 2233 3600 +3567 2 2 12 9 764 2176 3499 +3568 2 2 12 9 909 2811 1914 +3569 2 2 12 9 434 1574 2987 +3570 2 2 12 9 435 2988 1575 +3571 2 2 12 9 772 2704 3178 +3572 2 2 12 9 1313 3132 2434 +3573 2 2 12 9 533 2543 1631 +3574 2 2 12 9 1314 2435 3133 +3575 2 2 12 9 1062 2709 2907 +3576 2 2 12 9 1133 1924 2960 +3577 2 2 12 9 1134 2961 1925 +3578 2 2 12 9 916 1603 2951 +3579 2 2 12 9 945 2140 2428 +3580 2 2 12 9 1207 3300 3038 +3581 2 2 12 9 932 2239 1833 +3582 2 2 12 9 1009 2542 3630 +3583 2 2 12 9 693 3487 2460 +3584 2 2 12 9 426 1606 2875 +3585 2 2 12 9 427 2876 1607 +3586 2 2 12 9 522 2348 2539 +3587 2 2 12 9 378 2668 1688 +3588 2 2 12 9 440 1539 2774 +3589 2 2 12 9 563 1650 3421 +3590 2 2 12 9 867 2614 1620 +3591 2 2 12 9 645 1594 3507 +3592 2 2 12 9 718 2247 3577 +3593 2 2 12 9 700 1590 2499 +3594 2 2 12 9 464 2011 2288 +3595 2 2 12 9 465 2289 2012 +3596 2 2 12 9 307 2357 1703 +3597 2 2 12 9 502 2082 3558 +3598 2 2 12 9 503 3559 2083 +3599 2 2 12 9 1022 1966 2475 +3600 2 2 12 9 3344 1604 1024 +3601 2 2 12 9 1038 1748 3120 +3602 2 2 12 9 657 1795 2341 +3603 2 2 12 9 239 3243 1721 +3604 2 2 12 9 337 1722 3244 +3605 2 2 12 9 42 1800 3083 +3606 2 2 12 9 179 3084 1801 +3607 2 2 12 9 371 3385 3443 +3608 2 2 12 9 744 2994 1565 +3609 2 2 12 9 372 3444 3386 +3610 2 2 12 9 745 1566 2995 +3611 2 2 12 9 760 1816 2137 +3612 2 2 12 9 761 2138 1817 +3613 2 2 12 9 283 2932 1733 +3614 2 2 12 9 843 1629 3432 +3615 2 2 12 9 997 3637 1660 +3616 2 2 12 9 998 1661 3638 +3617 2 2 12 9 1331 2229 3249 +3618 2 2 12 9 842 2109 2200 +3619 2 2 12 9 1142 1642 3407 +3620 2 2 12 9 1594 3352 2522 +3621 2 2 12 9 698 2396 1689 +3622 2 2 12 9 782 2259 1624 +3623 2 2 12 9 1864 2152 3203 +3624 2 2 12 9 1816 3200 2137 +3625 2 2 12 9 839 2475 1823 +3626 2 2 12 9 1817 2138 3201 +3627 2 2 12 9 518 3246 1675 +3628 2 2 12 9 831 1640 3010 +3629 2 2 12 9 640 1596 3522 +3630 2 2 12 9 914 1673 2482 +3631 2 2 12 9 1536 2907 2709 +3632 2 2 12 9 516 1887 3107 +3633 2 2 12 9 367 3440 1613 +3634 2 2 12 9 263 2515 1786 +3635 2 2 12 9 313 1787 2516 +3636 2 2 12 9 716 3403 1860 +3637 2 2 12 9 294 1737 2959 +3638 2 2 12 9 1361 3289 2561 +3639 2 2 12 9 851 2635 1634 +3640 2 2 12 9 295 296 1994 +3641 2 2 12 9 489 1899 3573 +3642 2 2 12 9 490 3145 1633 +3643 2 2 12 9 805 3433 1681 +3644 2 2 12 9 973 2288 2011 +3645 2 2 12 9 952 2947 1756 +3646 2 2 12 9 1002 1573 2752 +3647 2 2 12 9 974 2012 2289 +3648 2 2 12 9 796 1811 2459 +3649 2 2 12 9 286 3192 1707 +3650 2 2 12 9 907 1553 3071 +3651 2 2 12 9 21 3551 3114 +3652 2 2 12 9 1088 2094 2440 +3653 2 2 12 9 1089 2441 2095 +3654 2 2 12 9 702 2757 1809 +3655 2 2 12 9 1273 3419 2897 +3656 2 2 12 9 24 2385 1720 +3657 2 2 12 9 501 2553 1627 +3658 2 2 12 9 1425 2699 2595 +3659 2 2 12 9 1298 2492 1758 +3660 2 2 12 9 1117 3143 2360 +3661 2 2 12 9 845 3458 1642 +3662 2 2 12 9 719 1747 2530 +3663 2 2 12 9 1150 2887 1979 +3664 2 2 12 9 1593 2460 3487 +3665 2 2 12 9 1360 2248 2787 +3666 2 2 12 9 721 1979 2887 +3667 2 2 12 9 566 1621 2766 +3668 2 2 12 9 658 1537 3111 +3669 2 2 12 9 500 3205 1974 +3670 2 2 12 9 652 1620 2614 +3671 2 2 12 9 2522 3352 1109 +3672 2 2 12 9 244 2651 1710 +3673 2 2 12 9 332 1711 2652 +3674 2 2 12 9 922 2724 1624 +3675 2 2 12 9 947 1621 2352 +3676 2 2 12 9 732 1684 2617 +3677 2 2 12 9 1587 3319 2677 +3678 2 2 12 9 1588 2678 3320 +3679 2 2 12 9 646 3275 1517 +3680 2 2 12 9 1281 2595 2664 +3681 2 2 12 9 723 1698 3596 +3682 2 2 12 9 724 3597 1699 +3683 2 2 12 9 806 1622 2852 +3684 2 2 12 9 394 1727 2879 +3685 2 2 12 9 807 2853 1623 +3686 2 2 12 9 1412 2914 2831 +3687 2 2 12 9 1350 2315 2824 +3688 2 2 12 9 50 1766 2763 +3689 2 2 12 9 171 2764 1767 +3690 2 2 12 9 485 1841 2139 +3691 2 2 12 9 346 2064 3041 +3692 2 2 12 9 666 2554 3461 +3693 2 2 12 9 689 2900 1846 +3694 2 2 12 9 690 1847 2901 +3695 2 2 12 9 1060 2145 3022 +3696 2 2 12 9 802 1552 2948 +3697 2 2 12 9 213 3104 1643 +3698 2 2 12 9 665 2414 1687 +3699 2 2 12 9 1031 1864 2915 +3700 2 2 12 9 539 1634 2635 +3701 2 2 12 9 185 186 2399 +3702 2 2 12 9 713 2446 1646 +3703 2 2 12 9 1360 2768 2237 +3704 2 2 12 9 470 1538 2892 +3705 2 2 12 9 874 2394 1608 +3706 2 2 12 9 755 2078 1985 +3707 2 2 12 9 1877 2462 2909 +3708 2 2 12 9 1073 3115 2211 +3709 2 2 12 9 22 2694 1792 +3710 2 2 12 9 531 2676 3347 +3711 2 2 12 9 519 2388 1698 +3712 2 2 12 9 262 1786 2731 +3713 2 2 12 9 314 2732 1787 +3714 2 2 12 9 520 1699 2389 +3715 2 2 12 9 30 1818 3015 +3716 2 2 12 9 2265 3023 3584 +3717 2 2 12 9 558 2918 1883 +3718 2 2 12 9 1185 2871 2079 +3719 2 2 12 9 390 2352 3374 +3720 2 2 12 9 892 2843 1564 +3721 2 2 12 9 1094 3153 1675 +3722 2 2 12 9 822 2778 1665 +3723 2 2 12 9 907 2679 1553 +3724 2 2 12 9 687 1924 2195 +3725 2 2 12 9 441 1681 2488 +3726 2 2 12 9 688 2196 1925 +3727 2 2 12 9 652 3003 1620 +3728 2 2 12 9 1202 1617 3284 +3729 2 2 12 9 1336 3372 2762 +3730 2 2 12 9 373 3093 2690 +3731 2 2 12 9 892 2498 3546 +3732 2 2 12 9 374 2691 3094 +3733 2 2 12 9 1191 1985 2078 +3734 2 2 12 9 1065 3175 3349 +3735 2 2 12 9 876 2240 1780 +3736 2 2 12 9 508 3399 2168 +3737 2 2 12 9 798 3076 1950 +3738 2 2 12 9 383 1649 2490 +3739 2 2 12 9 1271 2255 2745 +3740 2 2 12 9 1272 2746 2256 +3741 2 2 12 9 836 3431 1719 +3742 2 2 12 9 827 2293 2643 +3743 2 2 12 9 1277 3187 2408 +3744 2 2 12 9 463 1564 2843 +3745 2 2 12 9 466 1657 2473 +3746 2 2 12 9 802 2473 3445 +3747 2 2 12 9 358 2624 1612 +3748 2 2 12 9 603 2970 2902 +3749 2 2 12 9 281 1805 2674 +3750 2 2 12 9 884 2499 1590 +3751 2 2 12 9 380 3380 1591 +3752 2 2 12 9 1256 3470 2035 +3753 2 2 12 9 1170 1664 2484 +3754 2 2 12 9 581 2281 3644 +3755 2 2 12 9 582 3645 2282 +3756 2 2 12 9 256 257 2242 +3757 2 2 12 9 319 320 2243 +3758 2 2 12 9 990 3002 1556 +3759 2 2 12 9 469 2345 1669 +3760 2 2 12 9 1164 2467 2420 +3761 2 2 12 9 722 1653 3138 +3762 2 2 12 9 659 1546 3296 +3763 2 2 12 9 940 3393 1549 +3764 2 2 12 9 244 1710 3602 +3765 2 2 12 9 332 3603 1711 +3766 2 2 12 9 826 1877 2453 +3767 2 2 12 9 1372 1577 3264 +3768 2 2 12 9 291 1738 3270 +3769 2 2 12 9 1027 2708 2019 +3770 2 2 12 9 839 2015 2422 +3771 2 2 12 9 1054 1579 3500 +3772 2 2 12 9 340 3528 1670 +3773 2 2 12 9 493 2838 1970 +3774 2 2 12 9 1265 2829 1584 +3775 2 2 12 9 1263 2252 3633 +3776 2 2 12 9 382 2518 2072 +3777 2 2 12 9 1017 3578 1573 +3778 2 2 12 9 705 3066 1824 +3779 2 2 12 9 706 1825 3067 +3780 2 2 12 9 382 1630 3021 +3781 2 2 12 9 616 2295 3304 +3782 2 2 12 9 2114 2568 3348 +3783 2 2 12 9 363 3120 1748 +3784 2 2 12 9 515 2181 2497 +3785 2 2 12 9 537 2079 2871 +3786 2 2 12 9 2145 3511 3022 +3787 2 2 12 9 813 2188 1769 +3788 2 2 12 9 930 2532 2323 +3789 2 2 12 9 460 3515 1779 +3790 2 2 12 9 865 3184 2303 +3791 2 2 12 9 346 2004 2253 +3792 2 2 12 9 281 3492 1805 +3793 2 2 12 9 517 2685 1988 +3794 2 2 12 9 1413 3261 3101 +3795 2 2 12 9 228 229 2019 +3796 2 2 12 9 1102 2283 2671 +3797 2 2 12 9 1207 1934 3323 +3798 2 2 12 9 985 1687 2414 +3799 2 2 12 9 673 2889 1671 +3800 2 2 12 9 909 2634 1559 +3801 2 2 12 9 641 3404 1592 +3802 2 2 12 9 426 2639 1560 +3803 2 2 12 9 344 1592 3406 +3804 2 2 12 9 427 1561 2640 +3805 2 2 12 9 1008 2218 2160 +3806 2 2 12 9 383 1556 3002 +3807 2 2 12 9 890 2660 1662 +3808 2 2 12 9 891 1663 2661 +3809 2 2 12 9 297 298 2063 +3810 2 2 12 9 516 2361 1871 +3811 2 2 12 9 837 1773 2997 +3812 2 2 12 9 555 2609 2482 +3813 2 2 12 9 378 1768 2668 +3814 2 2 12 9 604 2831 2914 +3815 2 2 12 9 672 1641 3238 +3816 2 2 12 9 35 2469 1672 +3817 2 2 12 9 1494 3050 3454 +3818 2 2 12 9 1495 3455 3051 +3819 2 2 12 9 510 1791 2186 +3820 2 2 12 9 883 2151 2701 +3821 2 2 12 9 1202 3626 1641 +3822 2 2 12 9 347 2664 2595 +3823 2 2 12 9 1842 2380 3391 +3824 2 2 12 9 532 1916 2442 +3825 2 2 12 9 1129 3437 2785 +3826 2 2 12 9 1145 2489 3461 +3827 2 2 12 9 911 3006 1615 +3828 2 2 12 9 912 1616 3007 +3829 2 2 12 9 774 1863 2625 +3830 2 2 12 9 834 2882 1691 +3831 2 2 12 9 872 3238 1641 +3832 2 2 12 9 911 2987 1574 +3833 2 2 12 9 912 1575 2988 +3834 2 2 12 9 7 8 3101 +3835 2 2 12 9 1152 1635 3587 +3836 2 2 12 9 286 1707 2989 +3837 2 2 12 9 860 1660 2377 +3838 2 2 12 9 861 2378 1661 +3839 2 2 12 9 1394 1870 3165 +3840 2 2 12 9 460 1779 2225 +3841 2 2 12 9 818 2205 3249 +3842 2 2 12 9 644 1595 3407 +3843 2 2 12 9 749 1931 2061 +3844 2 2 12 9 228 2019 2708 +3845 2 2 12 9 1103 2807 2112 +3846 2 2 12 9 591 2767 2925 +3847 2 2 12 9 838 2418 1749 +3848 2 2 12 9 1229 2449 1658 +3849 2 2 12 9 1230 1659 2450 +3850 2 2 12 9 1308 3224 2263 +3851 2 2 12 9 1037 2028 2361 +3852 2 2 12 9 493 2686 2838 +3853 2 2 12 9 968 1880 2507 +3854 2 2 12 9 517 3152 1714 +3855 2 2 12 9 932 2258 2239 +3856 2 2 12 9 441 3273 2520 +3857 2 2 12 9 946 2957 1792 +3858 2 2 12 9 752 2103 1892 +3859 2 2 12 9 753 1893 2104 +3860 2 2 12 9 1301 2985 2692 +3861 2 2 12 9 1302 2693 2986 +3862 2 2 12 9 1114 1988 2685 +3863 2 2 12 9 1065 2349 1771 +3864 2 2 12 9 629 3400 3387 +3865 2 2 12 9 512 1656 2717 +3866 2 2 12 9 1051 1733 2932 +3867 2 2 12 9 478 3016 2573 +3868 2 2 12 9 479 2574 3017 +3869 2 2 12 9 1568 3515 3459 +3870 2 2 12 9 904 1888 2155 +3871 2 2 12 9 905 2156 1889 +3872 2 2 12 9 1066 2320 1941 +3873 2 2 12 9 1067 1942 2321 +3874 2 2 12 9 1341 2445 1983 +3875 2 2 12 9 3319 650 2677 +3876 2 2 12 9 584 2263 3224 +3877 2 2 12 9 3320 2678 651 +3878 2 2 12 9 828 2190 3540 +3879 2 2 12 9 1657 3445 2473 +3880 2 2 12 9 880 1720 2385 +3881 2 2 12 9 386 2785 1644 +3882 2 2 12 9 1179 3081 2410 +3883 2 2 12 9 1180 2411 3082 +3884 2 2 12 9 496 2952 2727 +3885 2 2 12 9 553 2806 1638 +3886 2 2 12 9 991 2200 2109 +3887 2 2 12 9 1059 2959 1737 +3888 2 2 12 9 504 1906 2199 +3889 2 2 12 9 460 3647 1914 +3890 2 2 12 9 256 2242 2043 +3891 2 2 12 9 320 2044 2243 +3892 2 2 12 9 1273 2482 2609 +3893 2 2 12 9 198 1783 2454 +3894 2 2 12 9 898 2029 2004 +3895 2 2 12 9 847 2591 1857 +3896 2 2 12 9 848 1858 2592 +3897 2 2 12 9 942 2239 2131 +3898 2 2 12 9 714 1639 3004 +3899 2 2 12 9 768 2375 3293 +3900 2 2 12 9 769 3294 2376 +3901 2 2 12 9 684 3185 1644 +3902 2 2 12 9 570 3099 2400 +3903 2 2 12 9 935 2055 2497 +3904 2 2 12 9 658 1665 2815 +3905 2 2 12 9 1025 1676 2368 +3906 2 2 12 9 828 1813 2511 +3907 2 2 12 9 844 2621 2160 +3908 2 2 12 9 832 2296 2556 +3909 2 2 12 9 556 2638 2201 +3910 2 2 12 9 1120 1943 2180 +3911 2 2 12 9 420 2610 1696 +3912 2 2 12 9 421 1697 2611 +3913 2 2 12 9 451 2434 1997 +3914 2 2 12 9 452 2000 2435 +3915 2 2 12 9 1263 3633 1908 +3916 2 2 12 9 1354 2211 3115 +3917 2 2 12 9 1276 2531 3434 +3918 2 2 12 9 773 2915 1864 +3919 2 2 12 9 1031 2384 2451 +3920 2 2 12 9 1032 2452 2386 +3921 2 2 12 9 596 1808 2663 +3922 2 2 12 9 608 2074 2917 +3923 2 2 12 9 875 1656 2398 +3924 2 2 12 9 1349 2442 1916 +3925 2 2 12 9 514 1704 2299 +3926 2 2 12 9 511 2749 2134 +3927 2 2 12 9 1405 2659 3468 +3928 2 2 12 9 550 2420 2467 +3929 2 2 12 9 1021 2244 2799 +3930 2 2 12 9 692 1678 2924 +3931 2 2 12 9 984 2341 1795 +3932 2 2 12 9 252 253 2088 +3933 2 2 12 9 323 324 2089 +3934 2 2 12 9 620 1838 2762 +3935 2 2 12 9 630 1662 2660 +3936 2 2 12 9 668 1812 3251 +3937 2 2 12 9 631 2661 1663 +3938 2 2 12 9 1183 3260 1597 +3939 2 2 12 9 886 1627 2553 +3940 2 2 12 9 291 2953 1738 +3941 2 2 12 9 872 2359 1778 +3942 2 2 12 9 11 12 2153 +3943 2 2 12 9 1132 3399 3202 +3944 2 2 12 9 1187 1804 2236 +3945 2 2 12 9 1530 2887 1752 +3946 2 2 12 9 51 52 3218 +3947 2 2 12 9 169 170 3219 +3948 2 2 12 9 568 2178 3049 +3949 2 2 12 9 217 218 2067 +3950 2 2 12 9 674 2128 1995 +3951 2 2 12 9 246 1660 3637 +3952 2 2 12 9 330 3638 1661 +3953 2 2 12 9 829 1900 2277 +3954 2 2 12 9 830 2278 1901 +3955 2 2 12 9 947 2766 1621 +3956 2 2 12 9 605 1674 3256 +3957 2 2 12 9 931 2045 2372 +3958 2 2 12 9 32 1950 3076 +3959 2 2 12 9 260 1843 2688 +3960 2 2 12 9 316 2689 1844 +3961 2 2 12 9 450 2119 2531 +3962 2 2 12 9 200 3497 2354 +3963 2 2 12 9 882 2077 3103 +3964 2 2 12 9 911 1615 2987 +3965 2 2 12 9 912 2988 1616 +3966 2 2 12 9 529 1778 2359 +3967 2 2 12 9 448 3604 1584 +3968 2 2 12 9 563 2324 1836 +3969 2 2 12 9 680 1612 2842 +3970 2 2 12 9 383 3002 1649 +3971 2 2 12 9 555 1673 3160 +3972 2 2 12 9 806 1761 2862 +3973 2 2 12 9 1262 3041 2064 +3974 2 2 12 9 807 2864 1762 +3975 2 2 12 9 719 2530 1835 +3976 2 2 12 9 826 1814 2866 +3977 2 2 12 9 562 1658 2641 +3978 2 2 12 9 564 2642 1659 +3979 2 2 12 9 1333 2826 3008 +3980 2 2 12 9 714 1706 2928 +3981 2 2 12 9 823 2275 1854 +3982 2 2 12 9 824 1855 2276 +3983 2 2 12 9 6 2956 214 +3984 2 2 12 9 206 207 2306 +3985 2 2 12 9 382 2680 2518 +3986 2 2 12 9 835 1841 3485 +3987 2 2 12 9 35 36 2469 +3988 2 2 12 9 368 1742 2742 +3989 2 2 12 9 1172 2159 3598 +3990 2 2 12 9 1081 3083 1800 +3991 2 2 12 9 1082 1801 3084 +3992 2 2 12 9 806 2852 2502 +3993 2 2 12 9 807 2503 2853 +3994 2 2 12 9 678 2087 3267 +3995 2 2 12 9 1635 1971 2855 +3996 2 2 12 9 429 2830 1809 +3997 2 2 12 9 471 2379 1777 +3998 2 2 12 9 876 3306 1621 +3999 2 2 12 9 879 2490 1649 +4000 2 2 12 9 1098 2284 2124 +4001 2 2 12 9 1308 2149 3224 +4002 2 2 12 9 400 3323 1934 +4003 2 2 12 9 1250 2279 1784 +4004 2 2 12 9 14 15 2954 +4005 2 2 12 9 1306 2838 2686 +4006 2 2 12 9 375 1753 2496 +4007 2 2 12 9 502 3558 1654 +4008 2 2 12 9 503 1655 3559 +4009 2 2 12 9 1264 2439 1927 +4010 2 2 12 9 942 1833 2239 +4011 2 2 12 9 953 2677 2404 +4012 2 2 12 9 954 2405 2678 +4013 2 2 12 9 1111 2497 2181 +4014 2 2 12 9 1292 2899 3615 +4015 2 2 12 9 387 1758 3151 +4016 2 2 12 9 1093 1714 3152 +4017 2 2 12 9 1337 2481 3514 +4018 2 2 12 9 1203 2190 3077 +4019 2 2 12 9 549 1611 3191 +4020 2 2 12 9 870 2567 2295 +4021 2 2 12 9 490 1913 3145 +4022 2 2 12 9 995 3132 1696 +4023 2 2 12 9 996 1697 3133 +4024 2 2 12 9 202 2294 3231 +4025 2 2 12 9 1003 2327 1932 +4026 2 2 12 9 737 2001 2710 +4027 2 2 12 9 738 2711 2002 +4028 2 2 12 9 624 3493 1667 +4029 2 2 12 9 625 1668 3494 +4030 2 2 12 9 839 3272 2421 +4031 2 2 12 9 470 2892 1648 +4032 2 2 12 9 913 1871 2361 +4033 2 2 12 9 879 1649 2874 +4034 2 2 12 9 836 1719 2431 +4035 2 2 12 9 715 1974 2803 +4036 2 2 12 9 1263 2791 2734 +4037 2 2 12 9 950 2301 2754 +4038 2 2 12 9 951 2755 2302 +4039 2 2 12 9 1465 3618 2591 +4040 2 2 12 9 1466 2592 3619 +4041 2 2 12 9 822 1768 2779 +4042 2 2 12 9 843 3432 1745 +4043 2 2 12 9 1093 2406 1714 +4044 2 2 12 9 493 1628 2850 +4045 2 2 12 9 1350 3496 1677 +4046 2 2 12 9 494 1694 2587 +4047 2 2 12 9 616 1923 2295 +4048 2 2 12 9 495 2588 1695 +4049 2 2 12 9 925 1700 2486 +4050 2 2 12 9 742 1837 2975 +4051 2 2 12 9 926 2487 1701 +4052 2 2 12 9 881 2310 3097 +4053 2 2 12 9 22 23 2694 +4054 2 2 12 9 817 1644 3185 +4055 2 2 12 9 795 2345 2036 +4056 2 2 12 9 205 3068 1853 +4057 2 2 12 9 973 2525 2816 +4058 2 2 12 9 974 2817 2526 +4059 2 2 12 9 713 1675 2446 +4060 2 2 12 9 936 3506 1603 +4061 2 2 12 9 1013 1856 2253 +4062 2 2 12 9 1098 1670 3528 +4063 2 2 12 9 845 1751 3458 +4064 2 2 12 9 230 231 2076 +4065 2 2 12 9 1009 2372 2045 +4066 2 2 12 9 395 2285 3290 +4067 2 2 12 9 1027 3628 1682 +4068 2 2 12 9 357 1749 2418 +4069 2 2 12 9 1209 2521 1757 +4070 2 2 12 9 850 1724 2924 +4071 2 2 12 9 883 2701 2347 +4072 2 2 12 9 854 2474 3255 +4073 2 2 12 9 985 3110 1687 +4074 2 2 12 9 1141 1629 2697 +4075 2 2 12 9 1155 3251 1812 +4076 2 2 12 9 1077 2710 2001 +4077 2 2 12 9 1078 2002 2711 +4078 2 2 12 9 765 2578 1670 +4079 2 2 12 9 863 1731 2348 +4080 2 2 12 9 929 2366 2057 +4081 2 2 12 9 805 1681 2520 +4082 2 2 12 9 930 2058 2367 +4083 2 2 12 9 779 1688 2668 +4084 2 2 12 9 1055 3107 1887 +4085 2 2 12 9 1072 2199 1906 +4086 2 2 12 9 1285 2085 3460 +4087 2 2 12 9 868 2561 3289 +4088 2 2 12 9 971 1738 2904 +4089 2 2 12 9 678 3643 2087 +4090 2 2 12 9 591 2669 1832 +4091 2 2 12 9 700 2499 1822 +4092 2 2 12 9 550 2701 2420 +4093 2 2 12 9 811 1836 2324 +4094 2 2 12 9 1228 3023 2265 +4095 2 2 12 9 19 20 2159 +4096 2 2 12 9 704 1972 3237 +4097 2 2 12 9 1402 2400 3099 +4098 2 2 12 9 1069 3224 2149 +4099 2 2 12 9 522 2500 1833 +4100 2 2 12 9 562 2641 2382 +4101 2 2 12 9 564 2383 2642 +4102 2 2 12 9 1217 1775 2639 +4103 2 2 12 9 1218 2640 1776 +4104 2 2 12 9 349 3284 2005 +4105 2 2 12 9 483 2117 1947 +4106 2 2 12 9 484 1948 2118 +4107 2 2 12 9 363 2431 1719 +4108 2 2 12 9 995 1696 2610 +4109 2 2 12 9 1389 3304 2295 +4110 2 2 12 9 840 2641 1658 +4111 2 2 12 9 996 2611 1697 +4112 2 2 12 9 841 1659 2642 +4113 2 2 12 9 1020 2280 2596 +4114 2 2 12 9 917 2850 1628 +4115 2 2 12 9 532 3095 1916 +4116 2 2 12 9 1142 2673 1642 +4117 2 2 12 9 1512 3302 2698 +4118 2 2 12 9 1169 1631 2725 +4119 2 2 12 9 29 30 3015 +4120 2 2 12 9 1740 3478 2962 +4121 2 2 12 9 1137 3053 1979 +4122 2 2 12 9 481 2893 1585 +4123 2 2 12 9 482 1586 2894 +4124 2 2 12 9 20 21 3114 +4125 2 2 12 9 1007 3421 1650 +4126 2 2 12 9 535 1983 2445 +4127 2 2 12 9 633 3418 3373 +4128 2 2 12 9 665 1740 2962 +4129 2 2 12 9 577 2722 1676 +4130 2 2 12 9 1027 1682 2708 +4131 2 2 12 9 480 2589 2141 +4132 2 2 12 9 1033 2979 1600 +4133 2 2 12 9 1034 1601 2980 +4134 2 2 12 9 992 2057 2366 +4135 2 2 12 9 993 2367 2058 +4136 2 2 12 9 1028 3065 1865 +4137 2 2 12 9 592 1908 3633 +4138 2 2 12 9 990 1649 3002 +4139 2 2 12 9 525 2313 1980 +4140 2 2 12 9 526 1981 2314 +4141 2 2 12 9 927 2900 1716 +4142 2 2 12 9 928 1717 2901 +4143 2 2 12 9 1280 3049 2178 +4144 2 2 12 9 6 215 2956 +4145 2 2 12 9 514 3616 1704 +4146 2 2 12 9 1309 2727 2952 +4147 2 2 12 9 52 3588 1721 +4148 2 2 12 9 169 1722 3589 +4149 2 2 12 9 199 200 2354 +4150 2 2 12 9 1587 2739 3319 +4151 2 2 12 9 1588 3320 2740 +4152 2 2 12 9 1452 3291 1686 +4153 2 2 12 9 1449 3633 2252 +4154 2 2 12 9 995 1997 2434 +4155 2 2 12 9 700 3533 1645 +4156 2 2 12 9 850 2334 1907 +4157 2 2 12 9 996 2435 2000 +4158 2 2 12 9 398 1760 2542 +4159 2 2 12 9 967 1707 3192 +4160 2 2 12 9 572 2152 2451 +4161 2 2 12 9 607 2736 1750 +4162 2 2 12 9 822 2779 3428 +4163 2 2 12 9 985 2663 1808 +4164 2 2 12 9 391 2353 3115 +4165 2 2 12 9 239 1721 3588 +4166 2 2 12 9 337 3589 1722 +4167 2 2 12 9 1194 2917 2074 +4168 2 2 12 9 703 2904 1738 +4169 2 2 12 9 849 1850 2919 +4170 2 2 12 9 789 3427 1634 +4171 2 2 12 9 1068 2543 2208 +4172 2 2 12 9 12 13 2706 +4173 2 2 12 9 459 2038 3489 +4174 2 2 12 9 1119 1647 2903 +4175 2 2 12 9 222 223 3236 +4176 2 2 12 9 903 1995 2128 +4177 2 2 12 9 1593 3585 1958 +4178 2 2 12 9 1081 2508 2169 +4179 2 2 12 9 1082 2170 2509 +4180 2 2 12 9 654 1696 3132 +4181 2 2 12 9 655 3133 1697 +4182 2 2 12 9 521 2131 2239 +4183 2 2 12 9 251 3226 1854 +4184 2 2 12 9 325 1855 3227 +4185 2 2 12 9 610 2552 3028 +4186 2 2 12 9 339 1691 2882 +4187 2 2 12 9 1521 2890 2311 +4188 2 2 12 9 1068 1949 2543 +4189 2 2 12 9 519 1698 3081 +4190 2 2 12 9 520 3082 1699 +4191 2 2 12 9 701 3587 1635 +4192 2 2 12 9 506 2142 2540 +4193 2 2 12 9 507 2541 2143 +4194 2 2 12 9 948 1648 2892 +4195 2 2 12 9 1188 3307 2207 +4196 2 2 12 9 1225 2419 2100 +4197 2 2 12 9 430 1706 2750 +4198 2 2 12 9 946 1627 2957 +4199 2 2 12 9 873 3059 1748 +4200 2 2 12 9 1075 2531 2119 +4201 2 2 12 9 1430 2354 3497 +4202 2 2 12 9 895 1727 2716 +4203 2 2 12 9 1042 1671 2889 +4204 2 2 12 9 747 1769 2550 +4205 2 2 12 9 405 2046 2116 +4206 2 2 12 9 994 2962 3478 +4207 2 2 12 9 936 1603 2845 +4208 2 2 12 9 899 1754 2556 +4209 2 2 12 9 927 1980 2313 +4210 2 2 12 9 558 2100 2777 +4211 2 2 12 9 928 2314 1981 +4212 2 2 12 9 978 1975 2544 +4213 2 2 12 9 979 2545 1976 +4214 2 2 12 9 1543 2902 2167 +4215 2 2 12 9 1072 1638 2913 +4216 2 2 12 9 1360 2787 2768 +4217 2 2 12 9 486 3454 3050 +4218 2 2 12 9 437 1689 3482 +4219 2 2 12 9 487 3051 3455 +4220 2 2 12 9 683 3167 1736 +4221 2 2 12 9 1315 2965 3095 +4222 2 2 12 9 1435 3602 1710 +4223 2 2 12 9 1436 1711 3603 +4224 2 2 12 9 1047 2938 3173 +4225 2 2 12 9 1048 3174 2939 +4226 2 2 12 9 578 3154 1679 +4227 2 2 12 9 579 1680 3155 +4228 2 2 12 9 1427 2710 1897 +4229 2 2 12 9 1428 1898 2711 +4230 2 2 12 9 730 2544 1975 +4231 2 2 12 9 731 1976 2545 +4232 2 2 12 9 857 2203 2810 +4233 2 2 12 9 517 1714 2685 +4234 2 2 12 9 917 2198 2769 +4235 2 2 12 9 1232 3237 1972 +4236 2 2 12 9 1133 2195 1924 +4237 2 2 12 9 1134 1925 2196 +4238 2 2 12 9 1301 2547 2782 +4239 2 2 12 9 1302 2783 2548 +4240 2 2 12 9 402 1687 3110 +4241 2 2 12 9 556 2293 3225 +4242 2 2 12 9 483 1909 2316 +4243 2 2 12 9 484 2317 1911 +4244 2 2 12 9 276 2238 3420 +4245 2 2 12 9 15 16 2283 +4246 2 2 12 9 1640 2835 3366 +4247 2 2 12 9 963 2315 2773 +4248 2 2 12 9 587 1761 2502 +4249 2 2 12 9 1439 2382 2641 +4250 2 2 12 9 1440 2642 2383 +4251 2 2 12 9 588 2503 1762 +4252 2 2 12 9 17 1651 2671 +4253 2 2 12 9 281 282 3492 +4254 2 2 12 9 1012 1913 2621 +4255 2 2 12 9 1493 3028 2552 +4256 2 2 12 9 1112 2150 2735 +4257 2 2 12 9 1295 1851 2925 +4258 2 2 12 9 239 240 3243 +4259 2 2 12 9 336 337 3244 +4260 2 2 12 9 665 2934 1740 +4261 2 2 12 9 533 2208 2543 +4262 2 2 12 9 723 1775 3548 +4263 2 2 12 9 1445 3253 1810 +4264 2 2 12 9 724 3549 1776 +4265 2 2 12 9 1260 2605 2313 +4266 2 2 12 9 1261 2314 2607 +4267 2 2 12 9 441 1602 3273 +4268 2 2 12 9 857 2810 2231 +4269 2 2 12 9 685 1690 2700 +4270 2 2 12 9 550 2467 3529 +4271 2 2 12 9 1383 3307 3582 +4272 2 2 12 9 781 2595 3337 +4273 2 2 12 9 1031 2451 2152 +4274 2 2 12 9 925 2464 2737 +4275 2 2 12 9 1513 3079 3315 +4276 2 2 12 9 926 2738 2465 +4277 2 2 12 9 418 3423 3612 +4278 2 2 12 9 971 3270 1738 +4279 2 2 12 9 1539 3255 2474 +4280 2 2 12 9 1277 2408 2113 +4281 2 2 12 9 1525 3529 2467 +4282 2 2 12 9 480 1741 2589 +4283 2 2 12 9 471 1664 2891 +4284 2 2 12 9 1418 2087 3643 +4285 2 2 12 9 832 3430 1984 +4286 2 2 12 9 750 3490 1708 +4287 2 2 12 9 751 1709 3491 +4288 2 2 12 9 804 2253 2004 +4289 2 2 12 9 381 1746 2569 +4290 2 2 12 9 418 3612 2594 +4291 2 2 12 9 197 198 2454 +4292 2 2 12 9 856 2808 2202 +4293 2 2 12 9 442 1665 2778 +4294 2 2 12 9 720 3142 1753 +4295 2 2 12 9 758 1759 2443 +4296 2 2 12 9 1376 3293 2375 +4297 2 2 12 9 1377 2376 3294 +4298 2 2 12 9 756 2245 3327 +4299 2 2 12 9 895 2879 1727 +4300 2 2 12 9 757 3328 2246 +4301 2 2 12 9 838 1749 3265 +4302 2 2 12 9 984 1795 3098 +4303 2 2 12 9 2106 3436 3162 +4304 2 2 12 9 881 3097 2675 +4305 2 2 12 9 1856 3601 2657 +4306 2 2 12 9 1274 1939 3178 +4307 2 2 12 9 363 3059 2343 +4308 2 2 12 9 815 2782 2547 +4309 2 2 12 9 816 2548 2783 +4310 2 2 12 9 1060 3390 1729 +4311 2 2 12 9 1104 2350 3087 +4312 2 2 12 9 803 2059 2212 +4313 2 2 12 9 1105 3088 2351 +4314 2 2 12 9 218 219 3032 +4315 2 2 12 9 363 2343 2431 +4316 2 2 12 9 856 2217 2808 +4317 2 2 12 9 1129 3584 1763 +4318 2 2 12 9 952 1756 3126 +4319 2 2 12 9 715 3410 1673 +4320 2 2 12 9 984 1832 2669 +4321 2 2 12 9 557 3030 2021 +4322 2 2 12 9 1023 1812 3109 +4323 2 2 12 9 280 281 2674 +4324 2 2 12 9 1173 2293 2870 +4325 2 2 12 9 1576 2338 3263 +4326 2 2 12 9 408 1667 3377 +4327 2 2 12 9 409 3378 1668 +4328 2 2 12 9 1545 3400 1894 +4329 2 2 12 9 875 2717 1656 +4330 2 2 12 9 915 2587 1694 +4331 2 2 12 9 24 25 2385 +4332 2 2 12 9 916 1695 2588 +4333 2 2 12 9 259 260 2688 +4334 2 2 12 9 316 317 2689 +4335 2 2 12 9 796 2459 2032 +4336 2 2 12 9 862 2066 3503 +4337 2 2 12 9 1176 2240 2455 +4338 2 2 12 9 1248 1679 3118 +4339 2 2 12 9 1249 3119 1680 +4340 2 2 12 9 353 1979 3053 +4341 2 2 12 9 887 2235 3216 +4342 2 2 12 9 1045 2161 2540 +4343 2 2 12 9 1046 2541 2162 +4344 2 2 12 9 1233 3313 3032 +4345 2 2 12 9 882 2197 2401 +4346 2 2 12 9 815 3596 1698 +4347 2 2 12 9 990 3100 1649 +4348 2 2 12 9 816 1699 3597 +4349 2 2 12 9 536 2802 2020 +4350 2 2 12 9 826 2453 2164 +4351 2 2 12 9 1128 1853 3375 +4352 2 2 12 9 509 1712 2495 +4353 2 2 12 9 1447 3471 3292 +4354 2 2 12 9 1354 3115 2353 +4355 2 2 12 9 350 1685 3395 +4356 2 2 12 9 911 2920 2440 +4357 2 2 12 9 912 2441 2921 +4358 2 2 12 9 797 1718 2504 +4359 2 2 12 9 714 3004 2494 +4360 2 2 12 9 542 2426 2027 +4361 2 2 12 9 287 288 2237 +4362 2 2 12 9 416 2821 1671 +4363 2 2 12 9 977 2192 2562 +4364 2 2 12 9 1084 2096 3149 +4365 2 2 12 9 1085 3150 2097 +4366 2 2 12 9 1210 3445 2425 +4367 2 2 12 9 866 3397 1790 +4368 2 2 12 9 639 2716 1727 +4369 2 2 12 9 1472 2960 2382 +4370 2 2 12 9 1473 2383 2961 +4371 2 2 12 9 733 1798 3056 +4372 2 2 12 9 734 3057 1799 +4373 2 2 12 9 1538 3031 2892 +4374 2 2 12 9 499 2734 2791 +4375 2 2 12 9 585 2408 3187 +4376 2 2 12 9 1050 1736 3167 +4377 2 2 12 9 1132 2099 3029 +4378 2 2 12 9 628 2251 1999 +4379 2 2 12 9 854 3255 2517 +4380 2 2 12 9 942 2536 1833 +4381 2 2 12 9 379 2459 1811 +4382 2 2 12 9 369 2692 2985 +4383 2 2 12 9 370 2986 2693 +4384 2 2 12 9 436 2039 3147 +4385 2 2 12 9 992 2649 1798 +4386 2 2 12 9 993 1799 2650 +4387 2 2 12 9 36 37 3357 +4388 2 2 12 9 184 185 3358 +4389 2 2 12 9 534 1686 3629 +4390 2 2 12 9 44 45 2271 +4391 2 2 12 9 176 177 2272 +4392 2 2 12 9 289 290 2248 +4393 2 2 12 9 1102 2790 2283 +4394 2 2 12 9 810 3222 2397 +4395 2 2 12 9 498 1823 2475 +4396 2 2 12 9 997 1710 2651 +4397 2 2 12 9 998 2652 1711 +4398 2 2 12 9 540 2296 1940 +4399 2 2 12 9 1526 2949 1807 +4400 2 2 12 9 1113 2141 2589 +4401 2 2 12 9 368 2877 1742 +4402 2 2 12 9 980 1740 2934 +4403 2 2 12 9 882 2401 2077 +4404 2 2 12 9 1296 3087 2350 +4405 2 2 12 9 1297 2351 3088 +4406 2 2 12 9 227 2708 1682 +4407 2 2 12 9 1253 2770 2544 +4408 2 2 12 9 932 1833 2500 +4409 2 2 12 9 1254 2545 2771 +4410 2 2 12 9 1108 3364 1746 +4411 2 2 12 9 1558 3283 2695 +4412 2 2 12 9 1174 1828 2609 +4413 2 2 12 9 1295 2767 2604 +4414 2 2 12 9 701 1849 3595 +4415 2 2 12 9 209 210 3546 +4416 2 2 12 9 1128 3128 1853 +4417 2 2 12 9 684 1644 3437 +4418 2 2 12 9 590 2768 2787 +4419 2 2 12 9 16 17 2671 +4420 2 2 12 9 668 3109 1812 +4421 2 2 12 9 486 3279 1904 +4422 2 2 12 9 487 1905 3280 +4423 2 2 12 9 988 2169 2508 +4424 2 2 12 9 989 2509 2170 +4425 2 2 12 9 576 1666 3363 +4426 2 2 12 9 1357 3571 1793 +4427 2 2 12 9 1358 1794 3572 +4428 2 2 12 9 871 2064 2657 +4429 2 2 12 9 1229 1924 3620 +4430 2 2 12 9 1230 3621 1925 +4431 2 2 12 9 1287 2797 1725 +4432 2 2 12 9 1288 1726 2798 +4433 2 2 12 9 973 2816 2288 +4434 2 2 12 9 974 2289 2817 +4435 2 2 12 9 647 1725 2936 +4436 2 2 12 9 648 2937 1726 +4437 2 2 12 9 780 3600 2233 +4438 2 2 12 9 1184 1999 2251 +4439 2 2 12 9 971 2787 2248 +4440 2 2 12 9 1497 2614 2342 +4441 2 2 12 9 626 2175 3135 +4442 2 2 12 9 517 2277 1900 +4443 2 2 12 9 518 1901 2278 +4444 2 2 12 9 677 3315 3079 +4445 2 2 12 9 523 2735 2150 +4446 2 2 12 9 1182 3583 2990 +4447 2 2 12 9 25 1834 2385 +4448 2 2 12 9 607 3031 2874 +4449 2 2 12 9 946 1792 2694 +4450 2 2 12 9 451 2720 1716 +4451 2 2 12 9 765 1652 3131 +4452 2 2 12 9 452 1717 2721 +4453 2 2 12 9 399 2456 2822 +4454 2 2 12 9 817 3025 2589 +4455 2 2 12 9 1011 2638 2290 +4456 2 2 12 9 696 1712 3193 +4457 2 2 12 9 967 2237 2768 +4458 2 2 12 9 961 3374 2733 +4459 2 2 12 9 583 3321 2189 +4460 2 2 12 9 1498 2832 3060 +4461 2 2 12 9 1499 3061 2834 +4462 2 2 12 9 893 2316 1909 +4463 2 2 12 9 894 1911 2317 +4464 2 2 12 9 1487 2846 3481 +4465 2 2 12 9 704 1681 3433 +4466 2 2 12 9 1521 2696 3340 +4467 2 2 12 9 11 2153 3624 +4468 2 2 12 9 977 1835 2530 +4469 2 2 12 9 948 2892 3031 +4470 2 2 12 9 1053 2922 1929 +4471 2 2 12 9 1382 2494 3004 +4472 2 2 12 9 997 2142 3324 +4473 2 2 12 9 998 3325 2143 +4474 2 2 12 9 962 2443 2604 +4475 2 2 12 9 1528 3524 2936 +4476 2 2 12 9 1529 2937 3525 +4477 2 2 12 9 743 1685 3409 +4478 2 2 12 9 490 2157 2160 +4479 2 2 12 9 1252 2431 2343 +4480 2 2 12 9 1362 2868 1819 +4481 2 2 12 9 1486 3025 3185 +4482 2 2 12 9 1363 1820 2869 +4483 2 2 12 9 1538 2874 3031 +4484 2 2 12 9 780 2233 2039 +4485 2 2 12 9 1469 3114 3551 +4486 2 2 12 9 341 2907 3441 +4487 2 2 12 9 955 2812 3526 +4488 2 2 12 9 516 3086 1887 +4489 2 2 12 9 927 2313 2605 +4490 2 2 12 9 928 2607 2314 +4491 2 2 12 9 634 3283 1879 +4492 2 2 12 9 1159 1861 3524 +4493 2 2 12 9 1160 3525 1862 +4494 2 2 12 9 1137 1979 3112 +4495 2 2 12 9 1123 3413 1967 +4496 2 2 12 9 600 1929 2922 +4497 2 2 12 9 1124 1968 3414 +4498 2 2 12 9 833 2124 2284 +4499 2 2 12 9 880 2385 1834 +4500 2 2 12 9 966 2877 3521 +4501 2 2 12 9 1039 3056 1798 +4502 2 2 12 9 992 2172 2792 +4503 2 2 12 9 993 2794 2173 +4504 2 2 12 9 1040 1799 3057 +4505 2 2 12 9 1477 2176 3202 +4506 2 2 12 9 272 273 2903 +4507 2 2 12 9 1008 2160 2157 +4508 2 2 12 9 490 2621 1913 +4509 2 2 12 9 204 1853 3128 +4510 2 2 12 9 244 245 2651 +4511 2 2 12 9 331 332 2652 +4512 2 2 12 9 1336 2762 2417 +4513 2 2 12 9 532 2442 3103 +4514 2 2 12 9 1004 1861 3121 +4515 2 2 12 9 1005 3122 1862 +4516 2 2 12 9 634 2695 3283 +4517 2 2 12 9 800 3005 1875 +4518 2 2 12 9 870 2295 1923 +4519 2 2 12 9 887 3216 3345 +4520 2 2 12 9 504 2106 3162 +4521 2 2 12 9 1341 2343 3059 +4522 2 2 12 9 521 2239 2258 +4523 2 2 12 9 716 2209 3601 +4524 2 2 12 9 866 3217 1807 +4525 2 2 12 9 1109 1916 3095 +4526 2 2 12 9 243 244 3602 +4527 2 2 12 9 332 333 3603 +4528 2 2 12 9 1043 1802 2629 +4529 2 2 12 9 1044 2630 1803 +4530 2 2 12 9 1065 1771 3175 +4531 2 2 12 9 467 2453 1877 +4532 2 2 12 9 1173 3225 2293 +4533 2 2 12 9 1617 2005 3284 +4534 2 2 12 9 1038 2415 3085 +4535 2 2 12 9 448 2511 1813 +4536 2 2 12 9 1130 2718 2985 +4537 2 2 12 9 1131 2986 2719 +4538 2 2 12 9 251 252 3226 +4539 2 2 12 9 324 325 3227 +4540 2 2 12 9 1274 3178 2704 +4541 2 2 12 9 282 1733 3492 +4542 2 2 12 9 858 2742 1742 +4543 2 2 12 9 298 299 3412 +4544 2 2 12 9 1355 2183 3523 +4545 2 2 12 9 978 2030 2565 +4546 2 2 12 9 979 2566 2031 +4547 2 2 12 9 400 1863 2551 +4548 2 2 12 9 978 2544 2770 +4549 2 2 12 9 979 2771 2545 +4550 2 2 12 9 1386 3392 1674 +4551 2 2 12 9 497 1759 3426 +4552 2 2 12 9 682 1729 3390 +4553 2 2 12 9 1234 3085 2415 +4554 2 2 12 9 457 1955 3384 +4555 2 2 12 9 641 3189 3532 +4556 2 2 12 9 748 3375 1853 +4557 2 2 12 9 523 1782 2735 +4558 2 2 12 9 37 38 2355 +4559 2 2 12 9 183 184 2356 +4560 2 2 12 9 540 1763 3584 +4561 2 2 12 9 224 225 2291 +4562 2 2 12 9 764 2099 3202 +4563 2 2 12 9 1308 2520 3273 +4564 2 2 12 9 617 1875 3005 +4565 2 2 12 9 1092 2310 2257 +4566 2 2 12 9 268 269 2311 +4567 2 2 12 9 494 2587 2666 +4568 2 2 12 9 1075 1781 3073 +4569 2 2 12 9 495 2667 2588 +4570 2 2 12 9 1066 3089 2316 +4571 2 2 12 9 1067 2317 3090 +4572 2 2 12 9 286 287 3192 +4573 2 2 12 9 360 1730 2769 +4574 2 2 12 9 876 1780 2580 +4575 2 2 12 9 271 272 3148 +4576 2 2 12 9 1570 3020 3415 +4577 2 2 12 9 1015 3060 2832 +4578 2 2 12 9 1016 2834 3061 +4579 2 2 12 9 628 2423 2251 +4580 2 2 12 9 910 3579 2722 +4581 2 2 12 9 1033 1980 2720 +4582 2 2 12 9 1034 2721 1981 +4583 2 2 12 9 922 2647 2617 +4584 2 2 12 9 357 2228 2675 +4585 2 2 12 9 1676 2722 3579 +4586 2 2 12 9 1523 3361 2975 +4587 2 2 12 9 877 1750 2736 +4588 2 2 12 9 371 3443 1846 +4589 2 2 12 9 1264 3135 2175 +4590 2 2 12 9 372 1847 3444 +4591 2 2 12 9 387 3151 2603 +4592 2 2 12 9 1409 2154 3402 +4593 2 2 12 9 787 2565 2030 +4594 2 2 12 9 788 2031 2566 +4595 2 2 12 9 607 1750 3031 +4596 2 2 12 9 1263 1908 2791 +4597 2 2 12 9 1039 3426 1759 +4598 2 2 12 9 290 291 3270 +4599 2 2 12 9 716 2471 2209 +4600 2 2 12 9 1004 3121 1662 +4601 2 2 12 9 1005 1663 3122 +4602 2 2 12 9 373 1941 2320 +4603 2 2 12 9 374 2321 1942 +4604 2 2 12 9 420 1696 2792 +4605 2 2 12 9 1203 2964 2207 +4606 2 2 12 9 421 2794 1697 +4607 2 2 12 9 793 2476 2177 +4608 2 2 12 9 693 2460 1870 +4609 2 2 12 9 463 2602 1810 +4610 2 2 12 9 776 1952 3297 +4611 2 2 12 9 2295 2567 3580 +4612 2 2 12 9 524 2416 1876 +4613 2 2 12 9 508 2168 2429 +4614 2 2 12 9 30 3129 1818 +4615 2 2 12 9 644 3543 3188 +4616 2 2 12 9 1234 3147 2039 +4617 2 2 12 9 296 3223 1994 +4618 2 2 12 9 884 1989 2529 +4619 2 2 12 9 721 3112 1979 +4620 2 2 12 9 514 1881 3182 +4621 2 2 12 9 1367 3197 1734 +4622 2 2 12 9 669 1770 2911 +4623 2 2 12 9 1368 1735 3198 +4624 2 2 12 9 1147 3473 2472 +4625 2 2 12 9 1260 2313 3173 +4626 2 2 12 9 1261 3174 2314 +4627 2 2 12 9 415 1729 2950 +4628 2 2 12 9 945 3286 2681 +4629 2 2 12 9 373 2320 3093 +4630 2 2 12 9 743 3409 2091 +4631 2 2 12 9 374 3094 2321 +4632 2 2 12 9 394 3146 2483 +4633 2 2 12 9 877 2698 1750 +4634 2 2 12 9 687 3620 1924 +4635 2 2 12 9 688 1925 3621 +4636 2 2 12 9 962 2604 2767 +4637 2 2 12 9 1370 3365 1982 +4638 2 2 12 9 22 1792 3551 +4639 2 2 12 9 1216 2283 2790 +4640 2 2 12 9 1286 2822 2456 +4641 2 2 12 9 1277 2397 3222 +4642 2 2 12 9 1227 2617 2647 +4643 2 2 12 9 1061 3518 2069 +4644 2 2 12 9 1063 2070 3519 +4645 2 2 12 9 1149 3418 2756 +4646 2 2 12 9 361 2967 1715 +4647 2 2 12 9 1238 2368 3579 +4648 2 2 12 9 1510 3385 2565 +4649 2 2 12 9 1511 2566 3386 +4650 2 2 12 9 866 2159 3114 +4651 2 2 12 9 1339 1903 2468 +4652 2 2 12 9 1322 1868 2780 +4653 2 2 12 9 966 1742 2877 +4654 2 2 12 9 1323 2781 1869 +4655 2 2 12 9 991 1821 3039 +4656 2 2 12 9 817 3185 3025 +4657 2 2 12 9 535 2814 1983 +4658 2 2 12 9 1241 2666 2587 +4659 2 2 12 9 1242 2588 2667 +4660 2 2 12 9 238 3261 3303 +4661 2 2 12 9 1123 1967 3618 +4662 2 2 12 9 1124 3619 1968 +4663 2 2 12 9 1414 3624 2153 +4664 2 2 12 9 1188 2032 2459 +4665 2 2 12 9 937 1954 3008 +4666 2 2 12 9 665 1687 2934 +4667 2 2 12 9 9 10 2387 +4668 2 2 12 9 1301 2692 2146 +4669 2 2 12 9 1302 2148 2693 +4670 2 2 12 9 1217 2639 2875 +4671 2 2 12 9 1218 2876 2640 +4672 2 2 12 9 647 3524 1861 +4673 2 2 12 9 648 1862 3525 +4674 2 2 12 9 718 1871 2501 +4675 2 2 12 9 591 1832 2767 +4676 2 2 12 9 1584 2829 1764 +4677 2 2 12 9 1315 1991 2965 +4678 2 2 12 9 240 1743 3243 +4679 2 2 12 9 336 3244 1744 +4680 2 2 12 9 881 2257 2310 +4681 2 2 12 9 1155 1812 3495 +4682 2 2 12 9 1443 2322 3561 +4683 2 2 12 9 1444 3562 2323 +4684 2 2 12 9 1281 2664 1840 +4685 2 2 12 9 499 2791 1765 +4686 2 2 12 9 515 2497 2055 +4687 2 2 12 9 890 2043 2242 +4688 2 2 12 9 891 2243 2044 +4689 2 2 12 9 759 3469 1677 +4690 2 2 12 9 371 1846 2605 +4691 2 2 12 9 372 2607 1847 +4692 2 2 12 9 307 308 2357 +4693 2 2 12 9 1179 2410 3483 +4694 2 2 12 9 1180 3484 2411 +4695 2 2 12 9 866 1790 3217 +4696 2 2 12 9 264 265 2350 +4697 2 2 12 9 311 312 2351 +4698 2 2 12 9 1047 1935 2938 +4699 2 2 12 9 1048 2939 1936 +4700 2 2 12 9 515 1705 2835 +4701 2 2 12 9 645 1771 3576 +4702 2 2 12 9 665 2962 1715 +4703 2 2 12 9 692 2924 1724 +4704 2 2 12 9 1150 1752 2887 +4705 2 2 12 9 344 3406 1851 +4706 2 2 12 9 701 2468 1903 +4707 2 2 12 9 880 2458 1902 +4708 2 2 12 9 654 2322 2057 +4709 2 2 12 9 655 2058 2323 +4710 2 2 12 9 1019 1983 2814 +4711 2 2 12 9 868 2430 1878 +4712 2 2 12 9 903 2128 2682 +4713 2 2 12 9 654 3561 2322 +4714 2 2 12 9 1234 2415 3147 +4715 2 2 12 9 655 2323 3562 +4716 2 2 12 9 963 2658 2602 +4717 2 2 12 9 957 1849 2855 +4718 2 2 12 9 1262 2050 2539 +4719 2 2 12 9 1178 3474 2575 +4720 2 2 12 9 976 3415 3020 +4721 2 2 12 9 1093 3152 2554 +4722 2 2 12 9 1094 2555 3153 +4723 2 2 12 9 668 1703 3109 +4724 2 2 12 9 491 3495 1812 +4725 2 2 12 9 1455 3601 2209 +4726 2 2 12 9 1278 2091 3409 +4727 2 2 12 9 959 2885 2332 +4728 2 2 12 9 960 2333 2886 +4729 2 2 12 9 962 1951 2443 +4730 2 2 12 9 378 1688 3143 +4731 2 2 12 9 950 1824 3066 +4732 2 2 12 9 951 3067 1825 +4733 2 2 12 9 551 1857 2591 +4734 2 2 12 9 552 2592 1858 +4735 2 2 12 9 972 2912 2370 +4736 2 2 12 9 957 2674 1805 +4737 2 2 12 9 791 2054 3389 +4738 2 2 12 9 297 2063 3223 +4739 2 2 12 9 1676 3579 2368 +4740 2 2 12 9 1088 1708 2858 +4741 2 2 12 9 1089 2859 1709 +4742 2 2 12 9 966 2777 1742 +4743 2 2 12 9 1280 3127 2335 +4744 2 2 12 9 1049 1926 3343 +4745 2 2 12 9 620 2762 3372 +4746 2 2 12 9 723 3548 2410 +4747 2 2 12 9 724 2411 3549 +4748 2 2 12 9 948 3031 1750 +4749 2 2 12 9 1030 2294 2633 +4750 2 2 12 9 496 1842 2952 +4751 2 2 12 9 538 2207 2964 +4752 2 2 12 9 1037 1773 2999 +4753 2 2 12 9 1167 1846 3443 +4754 2 2 12 9 1168 3444 1847 +4755 2 2 12 9 980 3205 1740 +4756 2 2 12 9 51 3218 1766 +4757 2 2 12 9 170 1767 3219 +4758 2 2 12 9 832 2556 3430 +4759 2 2 12 9 1515 3428 2779 +4760 2 2 12 9 935 2551 1863 +4761 2 2 12 9 900 2837 1883 +4762 2 2 12 9 1052 2140 3015 +4763 2 2 12 9 1253 2544 3154 +4764 2 2 12 9 1254 3155 2545 +4765 2 2 12 9 1096 2977 2802 +4766 2 2 12 9 844 2381 1963 +4767 2 2 12 9 414 2395 1933 +4768 2 2 12 9 1096 1867 3531 +4769 2 2 12 9 981 2890 1899 +4770 2 2 12 9 1412 3158 3080 +4771 2 2 12 9 381 3425 1746 +4772 2 2 12 9 849 2456 1850 +4773 2 2 12 9 363 1748 3059 +4774 2 2 12 9 483 1947 2384 +4775 2 2 12 9 578 2202 3154 +4776 2 2 12 9 579 3155 2203 +4777 2 2 12 9 484 2386 1948 +4778 2 2 12 9 1177 3573 1899 +4779 2 2 12 9 1395 3521 2877 +4780 2 2 12 9 554 2997 1773 +4781 2 2 12 9 1037 2361 2884 +4782 2 2 12 9 532 3103 3379 +4783 2 2 12 9 694 1764 2829 +4784 2 2 12 9 557 2021 2909 +4785 2 2 12 9 1755 3472 2976 +4786 2 2 12 9 949 2262 2395 +4787 2 2 12 9 647 2936 3524 +4788 2 2 12 9 648 3525 2937 +4789 2 2 12 9 701 2855 1849 +4790 2 2 12 9 1174 3272 2524 +4791 2 2 12 9 1498 2410 3548 +4792 2 2 12 9 1499 3549 2411 +4793 2 2 12 9 667 2576 3010 +4794 2 2 12 9 343 2818 1734 +4795 2 2 12 9 342 1735 2819 +4796 2 2 12 9 380 1920 3380 +4797 2 2 12 9 657 1730 3365 +4798 2 2 12 9 27 28 2599 +4799 2 2 12 9 1446 2603 3151 +4800 2 2 12 9 344 1851 2801 +4801 2 2 12 9 1298 2844 2191 +4802 2 2 12 9 910 1876 2416 +4803 2 2 12 9 925 2737 2215 +4804 2 2 12 9 1017 2235 2234 +4805 2 2 12 9 926 2216 2738 +4806 2 2 12 9 363 1719 3120 +4807 2 2 12 9 417 3039 1821 +4808 2 2 12 9 1521 3340 2890 +4809 2 2 12 9 597 3184 2062 +4810 2 2 12 9 1212 3338 1761 +4811 2 2 12 9 685 2700 1859 +4812 2 2 12 9 1213 1762 3339 +4813 2 2 12 9 730 2938 1935 +4814 2 2 12 9 731 1936 2939 +4815 2 2 12 9 1251 1822 3641 +4816 2 2 12 9 832 2390 1940 +4817 2 2 12 9 718 3383 1739 +4818 2 2 12 9 717 1757 3253 +4819 2 2 12 9 1115 2964 3077 +4820 2 2 12 9 1239 2504 3348 +4821 2 2 12 9 684 3437 1763 +4822 2 2 12 9 962 2767 1832 +4823 2 2 12 9 1241 3501 1838 +4824 2 2 12 9 802 3445 2632 +4825 2 2 12 9 913 2361 2028 +4826 2 2 12 9 1242 1839 3502 +4827 2 2 12 9 428 2725 1859 +4828 2 2 12 9 397 1806 2880 +4829 2 2 12 9 19 2159 3354 +4830 2 2 12 9 1225 3408 2419 +4831 2 2 12 9 577 2533 2799 +4832 2 2 12 9 1527 2472 3473 +4833 2 2 12 9 1061 2929 2581 +4834 2 2 12 9 1063 2582 2930 +4835 2 2 12 9 940 2967 2074 +4836 2 2 12 9 743 2927 1937 +4837 2 2 12 9 1208 1994 3223 +4838 2 2 12 9 1838 3501 2762 +4839 2 2 12 9 850 1907 2425 +4840 2 2 12 9 599 1790 3397 +4841 2 2 12 9 47 2051 3018 +4842 2 2 12 9 174 3019 2052 +4843 2 2 12 9 378 2779 1768 +4844 2 2 12 9 623 3530 2612 +4845 2 2 12 9 872 1778 3238 +4846 2 2 12 9 1239 2836 2504 +4847 2 2 12 9 1141 1851 3406 +4848 2 2 12 9 480 3106 1690 +4849 2 2 12 9 758 2443 1951 +4850 2 2 12 9 1073 3554 1728 +4851 2 2 12 9 839 2421 2015 +4852 2 2 12 9 1266 3327 2245 +4853 2 2 12 9 1267 2246 3328 +4854 2 2 12 9 190 3075 2068 +4855 2 2 12 9 1159 2016 3534 +4856 2 2 12 9 1160 3535 2017 +4857 2 2 12 9 948 1750 2910 +4858 2 2 12 9 712 2523 2863 +4859 2 2 12 9 1012 2976 3472 +4860 2 2 12 9 947 2352 2252 +4861 2 2 12 9 1137 3182 1881 +4862 2 2 12 9 793 1986 2476 +4863 2 2 12 9 1311 2848 2019 +4864 2 2 12 9 1338 2036 2345 +4865 2 2 12 9 208 209 2498 +4866 2 2 12 9 352 1816 2991 +4867 2 2 12 9 351 2992 1817 +4868 2 2 12 9 1195 2177 2476 +4869 2 2 12 9 219 220 2665 +4870 2 2 12 9 872 2042 2340 +4871 2 2 12 9 1501 3441 3257 +4872 2 2 12 9 1217 1819 2868 +4873 2 2 12 9 1218 2869 1820 +4874 2 2 12 9 1109 3095 2965 +4875 2 2 12 9 661 1899 2890 +4876 2 2 12 9 291 292 2953 +4877 2 2 12 9 1171 2975 3361 +4878 2 2 12 9 1389 3353 3304 +4879 2 2 12 9 867 2409 2232 +4880 2 2 12 9 896 3142 1845 +4881 2 2 12 9 386 1969 3402 +4882 2 2 12 9 514 3182 2489 +4883 2 2 12 9 285 286 2989 +4884 2 2 12 9 927 2605 1846 +4885 2 2 12 9 1279 2590 2974 +4886 2 2 12 9 928 1847 2607 +4887 2 2 12 9 1006 3232 1753 +4888 2 2 12 9 959 2780 1868 +4889 2 2 12 9 960 1869 2781 +4890 2 2 12 9 1103 2112 3014 +4891 2 2 12 9 908 1875 2653 +4892 2 2 12 9 682 3390 3552 +4893 2 2 12 9 953 1854 3226 +4894 2 2 12 9 954 3227 1855 +4895 2 2 12 9 617 2653 1875 +4896 2 2 12 9 901 3357 2355 +4897 2 2 12 9 902 2356 3358 +4898 2 2 12 9 486 2120 3279 +4899 2 2 12 9 487 3280 2121 +4900 2 2 12 9 1028 2401 2197 +4901 2 2 12 9 354 2866 1814 +4902 2 2 12 9 988 2069 3518 +4903 2 2 12 9 989 3519 2070 +4904 2 2 12 9 1202 3284 2636 +4905 2 2 12 9 1628 3124 1882 +4906 2 2 12 9 959 1843 2626 +4907 2 2 12 9 960 2627 1844 +4908 2 2 12 9 1253 3154 2202 +4909 2 2 12 9 1254 2203 3155 +4910 2 2 12 9 725 3630 1760 +4911 2 2 12 9 811 2324 2132 +4912 2 2 12 9 1423 3035 1834 +4913 2 2 12 9 352 3060 1816 +4914 2 2 12 9 351 1817 3061 +4915 2 2 12 9 681 1865 3065 +4916 2 2 12 9 1150 2132 2324 +4917 2 2 12 9 1108 1746 3425 +4918 2 2 12 9 1018 3254 1815 +4919 2 2 12 9 1123 3018 2051 +4920 2 2 12 9 1124 2052 3019 +4921 2 2 12 9 945 2428 3286 +4922 2 2 12 9 1114 1950 3042 +4923 2 2 12 9 1148 2068 3075 +4924 2 2 12 9 913 2501 1871 +4925 2 2 12 9 436 1959 3009 +4926 2 2 12 9 1270 2179 3398 +4927 2 2 12 9 750 1829 3490 +4928 2 2 12 9 751 3491 1830 +4929 2 2 12 9 486 3050 1725 +4930 2 2 12 9 487 1726 3051 +4931 2 2 12 9 953 2404 2129 +4932 2 2 12 9 954 2130 2405 +4933 2 2 12 9 929 2057 2322 +4934 2 2 12 9 930 2323 2058 +4935 2 2 12 9 1222 3347 2676 +4936 2 2 12 9 1185 2963 2461 +4937 2 2 12 9 866 1807 3598 +4938 2 2 12 9 402 2422 2015 +4939 2 2 12 9 504 2199 2823 +4940 2 2 12 9 1070 2656 2254 +4941 2 2 12 9 1350 3613 3496 +4942 2 2 12 9 959 2626 2885 +4943 2 2 12 9 960 2886 2627 +4944 2 2 12 9 981 2311 2890 +4945 2 2 12 9 956 2260 2596 +4946 2 2 12 9 710 3036 1967 +4947 2 2 12 9 711 1968 3037 +4948 2 2 12 9 661 2890 3340 +4949 2 2 12 9 1014 3442 1809 +4950 2 2 12 9 1413 3303 3261 +4951 2 2 12 9 1335 1966 2538 +4952 2 2 12 9 1120 3405 1943 +4953 2 2 12 9 1202 2636 2344 +4954 2 2 12 9 341 1991 2907 +4955 2 2 12 9 264 2350 2515 +4956 2 2 12 9 312 2516 2351 +4957 2 2 12 9 500 1740 3205 +4958 2 2 12 9 669 2911 3569 +4959 2 2 12 9 777 3266 2809 +4960 2 2 12 9 1010 3080 1876 +4961 2 2 12 9 959 2688 1843 +4962 2 2 12 9 960 1844 2689 +4963 2 2 12 9 527 2069 2508 +4964 2 2 12 9 528 2509 2070 +4965 2 2 12 9 192 193 2579 +4966 2 2 12 9 744 3341 1800 +4967 2 2 12 9 745 1801 3342 +4968 2 2 12 9 712 3472 1755 +4969 2 2 12 9 339 1915 2707 +4970 2 2 12 9 237 3303 1736 +4971 2 2 12 9 858 2100 2419 +4972 2 2 12 9 1621 3306 2352 +4973 2 2 12 9 907 3071 1878 +4974 2 2 12 9 462 1807 3217 +4975 2 2 12 9 997 2651 3637 +4976 2 2 12 9 259 2688 1868 +4977 2 2 12 9 998 3638 2652 +4978 2 2 12 9 317 1869 2689 +4979 2 2 12 9 1108 2828 3364 +4980 2 2 12 9 720 1753 3232 +4981 2 2 12 9 1578 3190 3111 +4982 2 2 12 9 500 3478 1740 +4983 2 2 12 9 1019 2476 1986 +4984 2 2 12 9 1097 2909 2021 +4985 2 2 12 9 359 3405 1784 +4986 2 2 12 9 225 3276 2291 +4987 2 2 12 9 1382 3004 2359 +4988 2 2 12 9 1128 2633 2294 +4989 2 2 12 9 1597 3364 2828 +4990 2 2 12 9 1795 3646 3098 +4991 2 2 12 9 1119 2059 3078 +4992 2 2 12 9 852 2629 2325 +4993 2 2 12 9 853 2326 2630 +4994 2 2 12 9 1412 1919 2914 +4995 2 2 12 9 498 3545 1823 +4996 2 2 12 9 1104 2515 2350 +4997 2 2 12 9 1105 2351 2516 +4998 2 2 12 9 1279 2863 2523 +4999 2 2 12 9 696 3193 1818 +5000 2 2 12 9 1211 3333 2485 +5001 2 2 12 9 263 264 2515 +5002 2 2 12 9 312 313 2516 +5003 2 2 12 9 33 3042 1950 +5004 2 2 12 9 1135 2911 2139 +5005 2 2 12 9 1369 3010 2576 +5006 2 2 12 9 715 2803 3410 +5007 2 2 12 9 1364 2489 3182 +5008 2 2 12 9 5 7 3261 +5009 2 2 12 9 446 3062 2369 +5010 2 2 12 9 512 2717 2049 +5011 2 2 12 9 999 1831 3206 +5012 2 2 12 9 837 2113 2408 +5013 2 2 12 9 418 2506 3423 +5014 2 2 12 9 1164 2038 2467 +5015 2 2 12 9 1237 2369 3062 +5016 2 2 12 9 1040 1823 3545 +5017 2 2 12 9 1111 2413 2022 +5018 2 2 12 9 949 2395 2945 +5019 2 2 12 9 1615 3006 2033 +5020 2 2 12 9 1616 2034 3007 +5021 2 2 12 9 936 1828 3506 +5022 2 2 12 9 938 1945 3063 +5023 2 2 12 9 939 3064 1946 +5024 2 2 12 9 1120 3207 2896 +5025 2 2 12 9 1190 3646 1795 +5026 2 2 12 9 536 2077 2401 +5027 2 2 12 9 559 2254 2656 +5028 2 2 12 9 1032 2625 1934 +5029 2 2 12 9 658 3111 3190 +5030 2 2 12 9 1140 2594 2500 +5031 2 2 12 9 887 2234 2235 +5032 2 2 12 9 931 2372 2134 +5033 2 2 12 9 566 3398 2179 +5034 2 2 12 9 803 3078 2059 +5035 2 2 12 9 669 3569 2437 +5036 2 2 12 9 801 1883 2918 +5037 2 2 12 9 838 2823 2199 +5038 2 2 12 9 1554 2809 3266 +5039 2 2 12 9 448 1813 3604 +5040 2 2 12 9 10 3624 2387 +5041 2 2 12 9 1149 3148 3418 +5042 2 2 12 9 1084 1967 3036 +5043 2 2 12 9 1085 3037 1968 +5044 2 2 12 9 726 2092 2748 +5045 2 2 12 9 686 3476 1791 +5046 2 2 12 9 30 31 3129 +5047 2 2 12 9 670 1815 3254 +5048 2 2 12 9 899 2856 1957 +5049 2 2 12 9 845 2952 1842 +5050 2 2 12 9 1268 2733 3374 +5051 2 2 12 9 1283 2091 2644 +5052 2 2 12 9 5 3261 238 +5053 2 2 12 9 2198 3538 2769 +5054 2 2 12 9 217 2067 3465 +5055 2 2 12 9 766 2849 1965 +5056 2 2 12 9 390 2252 2352 +5057 2 2 12 9 985 2414 3450 +5058 2 2 12 9 1079 3281 1790 +5059 2 2 12 9 511 2134 2372 +5060 2 2 12 9 1031 2915 2384 +5061 2 2 12 9 914 2707 1915 +5062 2 2 12 9 707 1786 3240 +5063 2 2 12 9 986 1977 3466 +5064 2 2 12 9 987 3467 1978 +5065 2 2 12 9 708 3241 1787 +5066 2 2 12 9 985 3450 2727 +5067 2 2 12 9 1730 1982 3365 +5068 2 2 12 9 898 2004 3041 +5069 2 2 12 9 1200 2712 1857 +5070 2 2 12 9 1201 1858 2713 +5071 2 2 12 9 1647 3418 3148 +5072 2 2 12 9 778 2207 3307 +5073 2 2 12 9 1384 2126 2743 +5074 2 2 12 9 1385 2744 2127 +5075 2 2 12 9 1050 1852 2827 +5076 2 2 12 9 661 3514 1899 +5077 2 2 12 9 461 3408 2444 +5078 2 2 12 9 949 2572 3411 +5079 2 2 12 9 1047 3033 1935 +5080 2 2 12 9 1048 1936 3034 +5081 2 2 12 9 873 2505 3429 +5082 2 2 12 9 968 2861 1880 +5083 2 2 12 9 1237 2269 2369 +5084 2 2 12 9 539 3014 2112 +5085 2 2 12 9 1164 3489 2038 +5086 2 2 12 9 512 1789 3488 +5087 2 2 12 9 377 3506 1828 +5088 2 2 12 9 416 2974 2590 +5089 2 2 12 9 762 3367 1765 +5090 2 2 12 9 603 3636 2724 +5091 2 2 12 9 481 1873 2893 +5092 2 2 12 9 482 2894 1874 +5093 2 2 12 9 524 1876 3080 +5094 2 2 12 9 934 1859 2700 +5095 2 2 12 9 540 3239 1763 +5096 2 2 12 9 1176 3131 2329 +5097 2 2 12 9 904 3454 1904 +5098 2 2 12 9 905 1905 3455 +5099 2 2 12 9 1518 3271 2287 +5100 2 2 12 9 621 2872 1839 +5101 2 2 12 9 510 3477 1791 +5102 2 2 12 9 555 3160 2421 +5103 2 2 12 9 477 3430 1754 +5104 2 2 12 9 299 300 2564 +5105 2 2 12 9 237 238 3303 +5106 2 2 12 9 775 1872 2972 +5107 2 2 12 9 899 2296 3023 +5108 2 2 12 9 558 1883 2837 +5109 2 2 12 9 673 2298 2297 +5110 2 2 12 9 1121 3556 2025 +5111 2 2 12 9 1122 2026 3557 +5112 2 2 12 9 1152 3587 1903 +5113 2 2 12 9 429 1809 3442 +5114 2 2 12 9 825 1779 3515 +5115 2 2 12 9 604 2080 2831 +5116 2 2 12 9 1037 2999 2028 +5117 2 2 12 9 1127 3292 3471 +5118 2 2 12 9 1022 2538 1966 +5119 2 2 12 9 1624 2724 3636 +5120 2 2 12 9 620 2919 1850 +5121 2 2 12 9 1055 1937 2927 +5122 2 2 12 9 634 1879 3475 +5123 2 2 12 9 988 2508 2069 +5124 2 2 12 9 989 2070 2509 +5125 2 2 12 9 1019 3054 1983 +5126 2 2 12 9 959 1868 2688 +5127 2 2 12 9 960 2689 1869 +5128 2 2 12 9 399 1864 3203 +5129 2 2 12 9 426 2875 2639 +5130 2 2 12 9 427 2640 2876 +5131 2 2 12 9 1113 2167 2902 +5132 2 2 12 9 1320 2958 2098 +5133 2 2 12 9 1062 2907 1991 +5134 2 2 12 9 1292 3605 2184 +5135 2 2 12 9 1015 1816 3060 +5136 2 2 12 9 1016 3061 1817 +5137 2 2 12 9 408 3377 1897 +5138 2 2 12 9 409 1898 3378 +5139 2 2 12 9 560 2098 2958 +5140 2 2 12 9 601 2213 2754 +5141 2 2 12 9 602 2755 2214 +5142 2 2 12 9 1786 3330 2731 +5143 2 2 12 9 1787 2732 3331 +5144 2 2 12 9 478 2129 2404 +5145 2 2 12 9 479 2405 2130 +5146 2 2 12 9 241 242 2600 +5147 2 2 12 9 334 335 2601 +5148 2 2 12 9 1291 3168 2090 +5149 2 2 12 9 21 22 3551 +5150 2 2 12 9 1294 2339 2793 +5151 2 2 12 9 1076 3246 1964 +5152 2 2 12 9 485 3485 1841 +5153 2 2 12 9 800 2185 3005 +5154 2 2 12 9 424 2513 2983 +5155 2 2 12 9 918 2223 2666 +5156 2 2 12 9 919 2667 2224 +5157 2 2 12 9 1181 3577 2247 +5158 2 2 12 9 683 3334 1953 +5159 2 2 12 9 1177 2481 2194 +5160 2 2 12 9 432 1935 3033 +5161 2 2 12 9 433 3034 1936 +5162 2 2 12 9 1025 2368 2519 +5163 2 2 12 9 1345 3639 1796 +5164 2 2 12 9 1346 1797 3640 +5165 2 2 12 9 781 3123 1866 +5166 2 2 12 9 889 2844 2009 +5167 2 2 12 9 1587 2677 2088 +5168 2 2 12 9 1588 2089 2678 +5169 2 2 12 9 836 3376 2928 +5170 2 2 12 9 1139 2227 3108 +5171 2 2 12 9 1039 1928 3346 +5172 2 2 12 9 752 1997 2784 +5173 2 2 12 9 460 1914 3459 +5174 2 2 12 9 753 2786 2000 +5175 2 2 12 9 1110 2533 2166 +5176 2 2 12 9 504 2823 2106 +5177 2 2 12 9 208 2498 3599 +5178 2 2 12 9 1421 2472 3591 +5179 2 2 12 9 1081 1800 3341 +5180 2 2 12 9 1082 3342 1801 +5181 2 2 12 9 468 3586 2241 +5182 2 2 12 9 386 3402 2154 +5183 2 2 12 9 654 3132 3561 +5184 2 2 12 9 863 2348 2536 +5185 2 2 12 9 655 3562 3133 +5186 2 2 12 9 975 2261 2358 +5187 2 2 12 9 1052 3015 1818 +5188 2 2 12 9 195 3299 2054 +5189 2 2 12 9 949 2945 2572 +5190 2 2 12 9 510 3460 2085 +5191 2 2 12 9 1153 2297 2298 +5192 2 2 12 9 1345 1884 2818 +5193 2 2 12 9 1346 2819 1885 +5194 2 2 12 9 995 2610 2784 +5195 2 2 12 9 1141 2925 1851 +5196 2 2 12 9 996 2786 2611 +5197 2 2 12 9 1469 3551 1792 +5198 2 2 12 9 1398 3486 3546 +5199 2 2 12 9 504 3162 3220 +5200 2 2 12 9 359 1943 3405 +5201 2 2 12 9 768 2120 2797 +5202 2 2 12 9 769 2798 2121 +5203 2 2 12 9 220 221 3040 +5204 2 2 12 9 530 2232 2645 +5205 2 2 12 9 818 2021 3030 +5206 2 2 12 9 957 1971 2674 +5207 2 2 12 9 1219 2534 2347 +5208 2 2 12 9 424 2983 2457 +5209 2 2 12 9 910 2722 1876 +5210 2 2 12 9 1478 3161 1984 +5211 2 2 12 9 932 2500 2594 +5212 2 2 12 9 28 2140 2599 +5213 2 2 12 9 1061 3116 3518 +5214 2 2 12 9 1063 3519 3117 +5215 2 2 12 9 1479 3423 2506 +5216 2 2 12 9 941 2358 2261 +5217 2 2 12 9 702 1809 2996 +5218 2 2 12 9 813 2072 2518 +5219 2 2 12 9 942 2158 2536 +5220 2 2 12 9 1032 1934 3038 +5221 2 2 12 9 1071 2958 3516 +5222 2 2 12 9 860 2304 2540 +5223 2 2 12 9 861 2541 2305 +5224 2 2 12 9 1243 2741 3631 +5225 2 2 12 9 701 1903 3587 +5226 2 2 12 9 1052 1818 3193 +5227 2 2 12 9 1212 2784 2610 +5228 2 2 12 9 1213 2611 2786 +5229 2 2 12 9 1639 2928 3376 +5230 2 2 12 9 1281 3337 2595 +5231 2 2 12 9 1072 1906 2916 +5232 2 2 12 9 380 2427 3371 +5233 2 2 12 9 1339 2905 2363 +5234 2 2 12 9 1246 3420 2238 +5235 2 2 12 9 691 3505 2484 +5236 2 2 12 9 1111 2181 2412 +5237 2 2 12 9 1155 2136 2590 +5238 2 2 12 9 1013 3403 1856 +5239 2 2 12 9 1796 3639 2011 +5240 2 2 12 9 1797 2012 3640 +5241 2 2 12 9 1258 2429 2168 +5242 2 2 12 9 791 3206 1831 +5243 2 2 12 9 1175 2648 2684 +5244 2 2 12 9 1397 2845 3513 +5245 2 2 12 9 681 3350 1865 +5246 2 2 12 9 1454 3130 1918 +5247 2 2 12 9 1206 3298 1838 +5248 2 2 12 9 1207 1839 3300 +5249 2 2 12 9 878 3355 2353 +5250 2 2 12 9 765 2179 2578 +5251 2 2 12 9 280 2674 1971 +5252 2 2 12 9 718 3577 1871 +5253 2 2 12 9 1121 3319 2739 +5254 2 2 12 9 1122 2740 3320 +5255 2 2 12 9 577 2166 2533 +5256 2 2 12 9 808 2559 2082 +5257 2 2 12 9 809 2083 2560 +5258 2 2 12 9 524 3080 3158 +5259 2 2 12 9 516 1871 3086 +5260 2 2 12 9 1156 2054 3299 +5261 2 2 12 9 405 3210 2046 +5262 2 2 12 9 831 2412 2181 +5263 2 2 12 9 1375 1990 2656 +5264 2 2 12 9 748 1804 3375 +5265 2 2 12 9 1029 3180 1806 +5266 2 2 12 9 417 1821 3590 +5267 2 2 12 9 567 1878 3071 +5268 2 2 12 9 13 1910 2706 +5269 2 2 12 9 1181 1887 3086 +5270 2 2 12 9 235 2827 1852 +5271 2 2 12 9 897 2905 1996 +5272 2 2 12 9 338 2092 3392 +5273 2 2 12 9 348 2698 3302 +5274 2 2 12 9 1501 3257 1990 +5275 2 2 12 9 710 1967 3413 +5276 2 2 12 9 711 3414 1968 +5277 2 2 12 9 466 2424 3252 +5278 2 2 12 9 1177 1899 3514 +5279 2 2 12 9 985 1808 3110 +5280 2 2 12 9 554 2644 2091 +5281 2 2 12 9 725 1827 3630 +5282 2 2 12 9 522 2539 2050 +5283 2 2 12 9 1399 2444 3408 +5284 2 2 12 9 227 228 2708 +5285 2 2 12 9 1294 2793 2830 +5286 2 2 12 9 934 2926 1859 +5287 2 2 12 9 428 1859 2926 +5288 2 2 12 9 1480 3308 3431 +5289 2 2 12 9 415 2194 2481 +5290 2 2 12 9 1019 2814 2476 +5291 2 2 12 9 852 2281 2629 +5292 2 2 12 9 853 2630 2282 +5293 2 2 12 9 1068 2748 2092 +5294 2 2 12 9 1578 3220 3162 +5295 2 2 12 9 49 50 2763 +5296 2 2 12 9 171 172 2764 +5297 2 2 12 9 1383 3582 2438 +5298 2 2 12 9 927 1846 2900 +5299 2 2 12 9 928 2901 1847 +5300 2 2 12 9 401 3098 3646 +5301 2 2 12 9 1335 3262 3144 +5302 2 2 12 9 720 1845 3142 +5303 2 2 12 9 531 3347 2463 +5304 2 2 12 9 414 2407 2820 +5305 2 2 12 9 412 1957 2856 +5306 2 2 12 9 429 2184 3605 +5307 2 2 12 9 540 1940 3239 +5308 2 2 12 9 1027 2019 2848 +5309 2 2 12 9 897 1996 2813 +5310 2 2 12 9 935 2022 2662 +5311 2 2 12 9 982 2830 2793 +5312 2 2 12 9 1678 2334 2924 +5313 2 2 12 9 1451 2250 3209 +5314 2 2 12 9 707 3330 1786 +5315 2 2 12 9 708 1787 3331 +5316 2 2 12 9 980 2803 1974 +5317 2 2 12 9 877 2369 2269 +5318 2 2 12 9 549 3108 2227 +5319 2 2 12 9 1125 2737 2464 +5320 2 2 12 9 1126 2465 2738 +5321 2 2 12 9 822 3428 2778 +5322 2 2 12 9 962 1832 3137 +5323 2 2 12 9 666 3242 2788 +5324 2 2 12 9 863 2536 2158 +5325 2 2 12 9 1223 2690 3461 +5326 2 2 12 9 270 271 2696 +5327 2 2 12 9 725 1842 3391 +5328 2 2 12 9 790 1881 3196 +5329 2 2 12 9 14 2954 1910 +5330 2 2 12 9 1118 3102 2116 +5331 2 2 12 9 1275 2209 2471 +5332 2 2 12 9 1308 2263 2520 +5333 2 2 12 9 739 3534 2016 +5334 2 2 12 9 740 2017 3535 +5335 2 2 12 9 1143 2164 2453 +5336 2 2 12 9 1041 2831 2080 +5337 2 2 12 9 1140 3475 1879 +5338 2 2 12 9 1092 2637 2310 +5339 2 2 12 9 1265 2457 2983 +5340 2 2 12 9 513 2206 2897 +5341 2 2 12 9 995 2784 1997 +5342 2 2 12 9 996 2000 2786 +5343 2 2 12 9 389 2028 2999 +5344 2 2 12 9 350 3395 2390 +5345 2 2 12 9 1096 1865 3350 +5346 2 2 12 9 1244 1882 3124 +5347 2 2 12 9 701 3595 2468 +5348 2 2 12 9 984 3098 1832 +5349 2 2 12 9 815 2388 2782 +5350 2 2 12 9 816 2783 2389 +5351 2 2 12 9 1145 2690 3093 +5352 2 2 12 9 416 2590 2136 +5353 2 2 12 9 1146 3094 2691 +5354 2 2 12 9 1143 3614 2010 +5355 2 2 12 9 1004 3212 2023 +5356 2 2 12 9 703 1959 2904 +5357 2 2 12 9 1005 2024 3213 +5358 2 2 12 9 1312 2983 2513 +5359 2 2 12 9 562 2382 2960 +5360 2 2 12 9 564 2961 2383 +5361 2 2 12 9 1000 2684 2648 +5362 2 2 12 9 1097 1877 2909 +5363 2 2 12 9 868 2010 2561 +5364 2 2 12 9 485 1845 3416 +5365 2 2 12 9 245 246 3637 +5366 2 2 12 9 330 331 3638 +5367 2 2 12 9 1146 2691 3555 +5368 2 2 12 9 1003 1932 2941 +5369 2 2 12 9 1501 3507 2522 +5370 2 2 12 9 1098 3528 2284 +5371 2 2 12 9 1162 2820 2407 +5372 2 2 12 9 561 3221 2493 +5373 2 2 12 9 1335 2538 3262 +5374 2 2 12 9 1106 2715 3382 +5375 2 2 12 9 1195 3209 2250 +5376 2 2 12 9 1563 3422 3482 +5377 2 2 12 9 1188 3582 3307 +5378 2 2 12 9 572 3298 2152 +5379 2 2 12 9 405 2116 3102 +5380 2 2 12 9 774 2978 1911 +5381 2 2 12 9 768 3293 2120 +5382 2 2 12 9 769 2121 3294 +5383 2 2 12 9 567 2793 2339 +5384 2 2 12 9 1369 3048 2171 +5385 2 2 12 9 1154 2914 1919 +5386 2 2 12 9 1734 3197 1895 +5387 2 2 12 9 533 2705 2360 +5388 2 2 12 9 1735 1896 3198 +5389 2 2 12 9 1447 2204 3471 +5390 2 2 12 9 1117 2360 2705 +5391 2 2 12 9 377 2951 3506 +5392 2 2 12 9 1165 3459 1914 +5393 2 2 12 9 1027 2432 2765 +5394 2 2 12 9 983 1952 3028 +5395 2 2 12 9 1476 2567 2270 +5396 2 2 12 9 878 2477 3355 +5397 2 2 12 9 1083 2232 2409 +5398 2 2 12 9 261 262 2731 +5399 2 2 12 9 314 315 2732 +5400 2 2 12 9 568 2519 2368 +5401 2 2 12 9 254 255 2739 +5402 2 2 12 9 321 322 2740 +5403 2 2 12 9 766 2968 1933 +5404 2 2 12 9 878 2309 2477 +5405 2 2 12 9 635 3105 1926 +5406 2 2 12 9 1146 3555 3366 +5407 2 2 12 9 510 2186 3460 +5408 2 2 12 9 1563 1953 3422 +5409 2 2 12 9 727 1895 3197 +5410 2 2 12 9 860 2540 2142 +5411 2 2 12 9 861 2143 2541 +5412 2 2 12 9 728 3198 1896 +5413 2 2 12 9 211 3314 2065 +5414 2 2 12 9 565 2344 3055 +5415 2 2 12 9 1232 2615 3504 +5416 2 2 12 9 1007 2800 1912 +5417 2 2 12 9 1144 2046 3210 +5418 2 2 12 9 1083 2645 2232 +5419 2 2 12 9 346 2657 2064 +5420 2 2 12 9 1312 2513 3367 +5421 2 2 12 9 994 1965 2849 +5422 2 2 12 9 1021 3058 2646 +5423 2 2 12 9 1401 3371 2427 +5424 2 2 12 9 1329 3269 2307 +5425 2 2 12 9 1182 3257 3441 +5426 2 2 12 9 783 2011 3639 +5427 2 2 12 9 784 3640 2012 +5428 2 2 12 9 1195 2476 2814 +5429 2 2 12 9 843 1970 2838 +5430 2 2 12 9 453 1962 2807 +5431 2 2 12 9 839 1823 3272 +5432 2 2 12 9 889 2191 2844 +5433 2 2 12 9 823 2573 2122 +5434 2 2 12 9 824 2123 2574 +5435 2 2 12 9 1045 2540 2304 +5436 2 2 12 9 1046 2305 2541 +5437 2 2 12 9 540 3584 3023 +5438 2 2 12 9 486 1904 3454 +5439 2 2 12 9 487 3455 1905 +5440 2 2 12 9 1220 3252 1886 +5441 2 2 12 9 376 1921 3346 +5442 2 2 12 9 1675 3246 2446 +5443 2 2 12 9 609 3235 2608 +5444 2 2 12 9 957 2855 1971 +5445 2 2 12 9 1095 3239 1940 +5446 2 2 12 9 1524 3532 3189 +5447 2 2 12 9 338 3326 2092 +5448 2 2 12 9 667 3010 3366 +5449 2 2 12 9 733 3056 1921 +5450 2 2 12 9 1679 1935 3118 +5451 2 2 12 9 1680 3119 1936 +5452 2 2 12 9 734 1922 3057 +5453 2 2 12 9 559 2656 1990 +5454 2 2 12 9 1080 3162 3436 +5455 2 2 12 9 1156 3389 2054 +5456 2 2 12 9 1584 3604 2003 +5457 2 2 12 9 248 249 2775 +5458 2 2 12 9 327 328 2776 +5459 2 2 12 9 941 2261 3157 +5460 2 2 12 9 899 2556 2296 +5461 2 2 12 9 909 2699 2811 +5462 2 2 12 9 900 2013 3368 +5463 2 2 12 9 235 236 2827 +5464 2 2 12 9 611 2577 3259 +5465 2 2 12 9 909 1914 3647 +5466 2 2 12 9 639 2257 3291 +5467 2 2 12 9 1525 3188 3543 +5468 2 2 12 9 385 3149 2096 +5469 2 2 12 9 384 2097 3150 +5470 2 2 12 9 823 2129 2573 +5471 2 2 12 9 824 2574 2130 +5472 2 2 12 9 596 3262 2538 +5473 2 2 12 9 1032 2386 2978 +5474 2 2 12 9 1554 3266 2420 +5475 2 2 12 9 1043 3228 1941 +5476 2 2 12 9 1044 1942 3229 +5477 2 2 12 9 1043 2629 2281 +5478 2 2 12 9 1640 3366 3010 +5479 2 2 12 9 1044 2282 2630 +5480 2 2 12 9 1328 1894 3400 +5481 2 2 12 9 773 1909 2915 +5482 2 2 12 9 618 2662 2022 +5483 2 2 12 9 610 3028 1952 +5484 2 2 12 9 606 3523 2198 +5485 2 2 12 9 1569 2186 3476 +5486 2 2 12 9 610 3258 2552 +5487 2 2 12 9 1153 2298 3592 +5488 2 2 12 9 990 2608 2923 +5489 2 2 12 9 377 1922 2951 +5490 2 2 12 9 1068 3326 1949 +5491 2 2 12 9 1380 2748 2208 +5492 2 2 12 9 1405 2878 3592 +5493 2 2 12 9 697 3474 1930 +5494 2 2 12 9 429 2804 2830 +5495 2 2 12 9 509 2495 2800 +5496 2 2 12 9 1928 3527 3346 +5497 2 2 12 9 514 2489 3616 +5498 2 2 12 9 489 2030 2770 +5499 2 2 12 9 491 2771 2031 +5500 2 2 12 9 1486 2167 3025 +5501 2 2 12 9 1253 2808 2770 +5502 2 2 12 9 527 2033 3006 +5503 2 2 12 9 528 3007 2034 +5504 2 2 12 9 1070 2254 3362 +5505 2 2 12 9 1166 2065 3314 +5506 2 2 12 9 1283 2644 2884 +5507 2 2 12 9 876 2455 2240 +5508 2 2 12 9 207 3599 2306 +5509 2 2 12 9 1191 2078 3563 +5510 2 2 12 9 611 1954 3074 +5511 2 2 12 9 695 1916 3352 +5512 2 2 12 9 1146 3366 2835 +5513 2 2 12 9 652 2261 3003 +5514 2 2 12 9 1390 2612 3530 +5515 2 2 12 9 1430 3497 1973 +5516 2 2 12 9 275 276 3420 +5517 2 2 12 9 846 2020 2802 +5518 2 2 12 9 1132 3202 2099 +5519 2 2 12 9 871 2695 2064 +5520 2 2 12 9 1094 3381 2576 +5521 2 2 12 9 865 3380 1920 +5522 2 2 12 9 943 1897 3377 +5523 2 2 12 9 944 3378 1898 +5524 2 2 12 9 1703 2357 3109 +5525 2 2 12 9 518 1964 3246 +5526 2 2 12 9 46 47 3018 +5527 2 2 12 9 174 175 3019 +5528 2 2 12 9 955 2562 2192 +5529 2 2 12 9 937 3074 1954 +5530 2 2 12 9 943 2122 2573 +5531 2 2 12 9 944 2574 2123 +5532 2 2 12 9 347 2013 2664 +5533 2 2 12 9 1539 2474 2584 +5534 2 2 12 9 988 3518 2743 +5535 2 2 12 9 989 2744 3519 +5536 2 2 12 9 1489 2788 3242 +5537 2 2 12 9 1474 3373 3078 +5538 2 2 12 9 1279 3251 2590 +5539 2 2 12 9 1189 2646 3058 +5540 2 2 12 9 33 34 3042 +5541 2 2 12 9 1339 2468 3517 +5542 2 2 12 9 931 2086 3302 +5543 2 2 12 9 1603 3506 2951 +5544 2 2 12 9 818 3030 2205 +5545 2 2 12 9 527 2929 2069 +5546 2 2 12 9 528 2070 2930 +5547 2 2 12 9 1058 2871 2461 +5548 2 2 12 9 805 2520 2263 +5549 2 2 12 9 923 3565 3558 +5550 2 2 12 9 924 3559 3566 +5551 2 2 12 9 940 2074 3393 +5552 2 2 12 9 918 2666 2654 +5553 2 2 12 9 919 2655 2667 +5554 2 2 12 9 870 2270 2567 +5555 2 2 12 9 475 2025 2702 +5556 2 2 12 9 476 2703 2026 +5557 2 2 12 9 1206 2152 3298 +5558 2 2 12 9 571 2310 2637 +5559 2 2 12 9 527 3006 2094 +5560 2 2 12 9 528 2095 3007 +5561 2 2 12 9 187 188 3069 +5562 2 2 12 9 1425 2811 2699 +5563 2 2 12 9 378 3143 2056 +5564 2 2 12 9 707 2728 2745 +5565 2 2 12 9 708 2746 2729 +5566 2 2 12 9 895 1958 2879 +5567 2 2 12 9 1348 2493 3221 +5568 2 2 12 9 1012 3472 1913 +5569 2 2 12 9 360 2870 1982 +5570 2 2 12 9 1458 2211 3451 +5571 2 2 12 9 1086 1944 3052 +5572 2 2 12 9 892 3486 2843 +5573 2 2 12 9 945 2599 2140 +5574 2 2 12 9 1021 2533 2613 +5575 2 2 12 9 1197 2120 3293 +5576 2 2 12 9 1198 3294 2121 +5577 2 2 12 9 1753 3142 2496 +5578 2 2 12 9 828 2511 3077 +5579 2 2 12 9 190 191 3075 +5580 2 2 12 9 41 42 3083 +5581 2 2 12 9 179 180 3084 +5582 2 2 12 9 1226 2501 2672 +5583 2 2 12 9 884 2628 3641 +5584 2 2 12 9 1270 2578 2179 +5585 2 2 12 9 1402 2510 2400 +5586 2 2 12 9 850 2924 2334 +5587 2 2 12 9 407 2244 2646 +5588 2 2 12 9 976 2518 2680 +5589 2 2 12 9 1353 2306 3599 +5590 2 2 12 9 586 2873 2480 +5591 2 2 12 9 1397 3079 2478 +5592 2 2 12 9 961 1906 3220 +5593 2 2 12 9 1035 3163 3233 +5594 2 2 12 9 213 214 3104 +5595 2 2 12 9 1036 3234 3164 +5596 2 2 12 9 1446 2947 2603 +5597 2 2 12 9 242 3610 2600 +5598 2 2 12 9 334 2601 3611 +5599 2 2 12 9 1452 3351 3291 +5600 2 2 12 9 962 3137 1951 +5601 2 2 12 9 400 2551 3136 +5602 2 2 12 9 1254 2771 2810 +5603 2 2 12 9 1164 2420 3266 +5604 2 2 12 9 1030 1926 3105 +5605 2 2 12 9 347 3368 2013 +5606 2 2 12 9 1365 2608 3235 +5607 2 2 12 9 1845 1961 3416 +5608 2 2 12 9 712 1913 3472 +5609 2 2 12 9 1381 3576 2349 +5610 2 2 12 9 203 204 3128 +5611 2 2 12 9 1338 2679 3448 +5612 2 2 12 9 913 2672 2501 +5613 2 2 12 9 1457 2742 2436 +5614 2 2 12 9 2128 3282 2682 +5615 2 2 12 9 1350 2824 3613 +5616 2 2 12 9 1498 3548 2832 +5617 2 2 12 9 1499 2834 3549 +5618 2 2 12 9 1328 2477 2309 +5619 2 2 12 9 283 284 2932 +5620 2 2 12 9 1165 3304 3353 +5621 2 2 12 9 1026 2637 2687 +5622 2 2 12 9 953 3226 2088 +5623 2 2 12 9 954 2089 3227 +5624 2 2 12 9 492 1938 3498 +5625 2 2 12 9 489 2770 2808 +5626 2 2 12 9 396 1996 2905 +5627 2 2 12 9 551 3618 1967 +5628 2 2 12 9 552 1968 3619 +5629 2 2 12 9 504 3220 1906 +5630 2 2 12 9 1140 1879 3278 +5631 2 2 12 9 1175 3329 3165 +5632 2 2 12 9 1003 3127 2327 +5633 2 2 12 9 827 2643 2182 +5634 2 2 12 9 293 294 2959 +5635 2 2 12 9 871 2400 2510 +5636 2 2 12 9 964 2146 2692 +5637 2 2 12 9 965 2693 2148 +5638 2 2 12 9 988 2743 2126 +5639 2 2 12 9 989 2127 2744 +5640 2 2 12 9 600 3435 2192 +5641 2 2 12 9 473 2009 2844 +5642 2 2 12 9 1013 1860 3403 +5643 2 2 12 9 1186 3629 2228 +5644 2 2 12 9 201 1973 3497 +5645 2 2 12 9 683 3564 3334 +5646 2 2 12 9 1387 3620 3169 +5647 2 2 12 9 1388 3170 3621 +5648 2 2 12 9 432 3118 1935 +5649 2 2 12 9 433 1936 3119 +5650 2 2 12 9 967 3192 2237 +5651 2 2 12 9 978 2770 2030 +5652 2 2 12 9 979 2031 2771 +5653 2 2 12 9 1053 1929 3290 +5654 2 2 12 9 980 1974 3205 +5655 2 2 12 9 490 2160 2621 +5656 2 2 12 9 1071 2583 2563 +5657 2 2 12 9 1192 2128 3631 +5658 2 2 12 9 1389 2393 3353 +5659 2 2 12 9 341 2965 1991 +5660 2 2 12 9 1007 1912 3421 +5661 2 2 12 9 1024 2563 2583 +5662 2 2 12 9 1116 2701 2151 +5663 2 2 12 9 1035 2502 2852 +5664 2 2 12 9 1036 2853 2503 +5665 2 2 12 9 1959 3632 3009 +5666 2 2 12 9 1293 2198 3523 +5667 2 2 12 9 1184 2480 2873 +5668 2 2 12 9 1294 2830 2804 +5669 2 2 12 9 1068 2208 2748 +5670 2 2 12 9 883 2347 2534 +5671 2 2 12 9 277 3044 2238 +5672 2 2 12 9 535 2854 3209 +5673 2 2 12 9 819 3271 2107 +5674 2 2 12 9 524 2262 2867 +5675 2 2 12 9 1197 3359 2245 +5676 2 2 12 9 1198 2246 3360 +5677 2 2 12 9 953 2088 2677 +5678 2 2 12 9 954 2678 2089 +5679 2 2 12 9 983 3297 1952 +5680 2 2 12 9 491 2810 2771 +5681 2 2 12 9 592 2596 2260 +5682 2 2 12 9 851 3625 2427 +5683 2 2 12 9 973 2117 3089 +5684 2 2 12 9 974 3090 2118 +5685 2 2 12 9 1084 3446 1967 +5686 2 2 12 9 1085 1968 3447 +5687 2 2 12 9 959 2332 2780 +5688 2 2 12 9 960 2781 2333 +5689 2 2 12 9 517 1900 3152 +5690 2 2 12 9 842 2200 2805 +5691 2 2 12 9 518 3153 1901 +5692 2 2 12 9 971 2248 3270 +5693 2 2 12 9 1489 3634 2788 +5694 2 2 12 9 1248 2745 2728 +5695 2 2 12 9 1249 2729 2746 +5696 2 2 12 9 581 2816 2525 +5697 2 2 12 9 582 2526 2817 +5698 2 2 12 9 1110 2613 2533 +5699 2 2 12 9 195 196 3299 +5700 2 2 12 9 1401 2427 3625 +5701 2 2 12 9 934 3106 2141 +5702 2 2 12 9 1037 2884 2644 +5703 2 2 12 9 443 3563 2078 +5704 2 2 12 9 1117 2056 3143 +5705 2 2 12 9 1417 2090 3168 +5706 2 2 12 9 593 2942 2375 +5707 2 2 12 9 978 3385 1975 +5708 2 2 12 9 594 2376 2943 +5709 2 2 12 9 979 1976 3386 +5710 2 2 12 9 1414 2153 2895 +5711 2 2 12 9 497 2366 2860 +5712 2 2 12 9 613 3499 2176 +5713 2 2 12 9 1308 3273 2149 +5714 2 2 12 9 792 1955 3316 +5715 2 2 12 9 1023 3109 2357 +5716 2 2 12 9 1241 2654 2666 +5717 2 2 12 9 401 1951 3137 +5718 2 2 12 9 1242 2667 2655 +5719 2 2 12 9 211 212 3314 +5720 2 2 12 9 420 2792 2172 +5721 2 2 12 9 421 2173 2794 +5722 2 2 12 9 248 2775 3176 +5723 2 2 12 9 328 3177 2776 +5724 2 2 12 9 1021 2646 2244 +5725 2 2 12 9 703 3632 1959 +5726 2 2 12 9 777 3008 1954 +5727 2 2 12 9 1109 3352 1916 +5728 2 2 12 9 1119 3078 3373 +5729 2 2 12 9 624 2122 3493 +5730 2 2 12 9 625 3494 2123 +5731 2 2 12 9 1185 2461 2871 +5732 2 2 12 9 1513 3315 2184 +5733 2 2 12 9 1027 2765 3628 +5734 2 2 12 9 18 19 3354 +5735 2 2 12 9 4 239 3588 +5736 2 2 12 9 3 3589 337 +5737 2 2 12 9 277 278 3044 +5738 2 2 12 9 1086 2432 2622 +5739 2 2 12 9 563 3421 1912 +5740 2 2 12 9 658 3190 2075 +5741 2 2 12 9 595 2634 3560 +5742 2 2 12 9 1488 3091 3211 +5743 2 2 12 9 1208 2805 2093 +5744 2 2 12 9 1079 2550 3281 +5745 2 2 12 9 4 3588 52 +5746 2 2 12 9 3 169 3589 +5747 2 2 12 9 265 266 3606 +5748 2 2 12 9 310 311 3607 +5749 2 2 12 9 977 3011 1929 +5750 2 2 12 9 1110 1958 3585 +5751 2 2 12 9 621 3513 2845 +5752 2 2 12 9 674 3631 2128 +5753 2 2 12 9 368 2753 2430 +5754 2 2 12 9 1120 2180 3207 +5755 2 2 12 9 1061 2069 2929 +5756 2 2 12 9 1000 2648 2290 +5757 2 2 12 9 1063 2930 2070 +5758 2 2 12 9 200 201 3497 +5759 2 2 12 9 881 2675 2228 +5760 2 2 12 9 355 2245 3359 +5761 2 2 12 9 380 3371 1920 +5762 2 2 12 9 356 3360 2246 +5763 2 2 12 9 1320 3516 2958 +5764 2 2 12 9 1448 3043 2226 +5765 2 2 12 9 1136 3096 3181 +5766 2 2 12 9 1401 2597 3371 +5767 2 2 12 9 207 208 3599 +5768 2 2 12 9 10 11 3624 +5769 2 2 12 9 584 2622 2432 +5770 2 2 12 9 896 3073 2496 +5771 2 2 12 9 801 2918 2193 +5772 2 2 12 9 949 2867 2262 +5773 2 2 12 9 1074 3211 3091 +5774 2 2 12 9 994 3478 1965 +5775 2 2 12 9 1310 1918 3130 +5776 2 2 12 9 1113 2589 3025 +5777 2 2 12 9 461 2419 3408 +5778 2 2 12 9 436 3009 2039 +5779 2 2 12 9 879 2683 2189 +5780 2 2 12 9 1307 3136 2551 +5781 2 2 12 9 1481 3274 2114 +5782 2 2 12 9 1482 2115 3277 +5783 2 2 12 9 1822 2499 3641 +5784 2 2 12 9 789 2009 3427 +5785 2 2 12 9 994 2849 2730 +5786 2 2 12 9 1421 3422 1953 +5787 2 2 12 9 846 2134 2749 +5788 2 2 12 9 1441 2260 3070 +5789 2 2 12 9 938 3063 2451 +5790 2 2 12 9 939 2452 3064 +5791 2 2 12 9 992 2366 2649 +5792 2 2 12 9 993 2650 2367 +5793 2 2 12 9 378 2056 2940 +5794 2 2 12 9 1075 3073 2328 +5795 2 2 12 9 553 2580 2806 +5796 2 2 12 9 1674 3392 2092 +5797 2 2 12 9 500 1965 3478 +5798 2 2 12 9 1096 3350 1867 +5799 2 2 12 9 216 217 3465 +5800 2 2 12 9 1517 2843 3486 +5801 2 2 12 9 1096 3531 2977 +5802 2 2 12 9 1092 2687 2637 +5803 2 2 12 9 249 250 3622 +5804 2 2 12 9 326 327 3623 +5805 2 2 12 9 437 3482 3422 +5806 2 2 12 9 1356 2106 2823 +5807 2 2 12 9 835 3402 1969 +5808 2 2 12 9 1451 3209 2854 +5809 2 2 12 9 1000 2290 2638 +5810 2 2 12 9 346 3041 2004 +5811 2 2 12 9 1081 2169 3083 +5812 2 2 12 9 1082 3084 2170 +5813 2 2 12 9 858 2436 2742 +5814 2 2 12 9 610 1952 3274 +5815 2 2 12 9 1354 3451 2211 +5816 2 2 12 9 1080 2075 3190 +5817 2 2 12 9 497 2860 2604 +5818 2 2 12 9 611 3277 1954 +5819 2 2 12 9 225 226 3276 +5820 2 2 12 9 667 2555 2576 +5821 2 2 12 9 1025 2519 2483 +5822 2 2 12 9 972 3464 2107 +5823 2 2 12 9 1555 2628 2529 +5824 2 2 12 9 968 3517 2468 +5825 2 2 12 9 956 2280 3544 +5826 2 2 12 9 1259 2098 3648 +5827 2 2 12 9 1149 3340 2696 +5828 2 2 12 9 247 248 3176 +5829 2 2 12 9 328 329 3177 +5830 2 2 12 9 676 3431 3308 +5831 2 2 12 9 1807 2949 3598 +5832 2 2 12 9 1145 3093 3616 +5833 2 2 12 9 1002 2182 2643 +5834 2 2 12 9 559 1990 3257 +5835 2 2 12 9 1245 2730 2849 +5836 2 2 12 9 366 3457 1939 +5837 2 2 12 9 1492 3026 2210 +5838 2 2 12 9 885 1953 3334 +5839 2 2 12 9 419 2290 2648 +5840 2 2 12 9 1280 2335 2969 +5841 2 2 12 9 1786 2515 3240 +5842 2 2 12 9 1787 3241 2516 +5843 2 2 12 9 1527 2963 3591 +5844 2 2 12 9 436 3147 3263 +5845 2 2 12 9 1612 2624 2842 +5846 2 2 12 9 348 2086 2977 +5847 2 2 12 9 1094 2576 2555 +5848 2 2 12 9 397 2880 3540 +5849 2 2 12 9 866 3598 2159 +5850 2 2 12 9 551 1967 3446 +5851 2 2 12 9 552 3447 1968 +5852 2 2 12 9 296 297 3223 +5853 2 2 12 9 1285 2726 2494 +5854 2 2 12 9 1019 1986 3394 +5855 2 2 12 9 941 3157 2593 +5856 2 2 12 9 1002 2752 2329 +5857 2 2 12 9 1152 2238 3044 +5858 2 2 12 9 657 3365 2546 +5859 2 2 12 9 1491 3560 2634 +5860 2 2 12 9 546 2215 2737 +5861 2 2 12 9 547 2738 2216 +5862 2 2 12 9 622 2584 2474 +5863 2 2 12 9 443 2078 3394 +5864 2 2 12 9 1510 2552 3258 +5865 2 2 12 9 961 2362 3374 +5866 2 2 12 9 41 3083 2169 +5867 2 2 12 9 180 2170 3084 +5868 2 2 12 9 1376 2375 2942 +5869 2 2 12 9 1377 2943 2376 +5870 2 2 12 9 1415 3176 2775 +5871 2 2 12 9 1416 2776 3177 +5872 2 2 12 9 513 3419 2478 +5873 2 2 12 9 1188 2459 3582 +5874 2 2 12 9 1210 2632 3445 +5875 2 2 12 9 716 3601 3403 +5876 2 2 12 9 1065 3356 3479 +5877 2 2 12 9 1511 3259 2577 +5878 2 2 12 9 1030 3105 1973 +5879 2 2 12 9 443 3394 1986 +5880 2 2 12 9 1026 2483 2519 +5881 2 2 12 9 1164 3266 3489 +5882 2 2 12 9 1061 2760 3116 +5883 2 2 12 9 1063 3117 2761 +5884 2 2 12 9 349 2636 3284 +5885 2 2 12 9 1172 3598 2949 +5886 2 2 12 9 1488 2433 3091 +5887 2 2 12 9 385 2449 3139 +5888 2 2 12 9 384 3140 2450 +5889 2 2 12 9 793 3029 1986 +5890 2 2 12 9 612 3180 2458 +5891 2 2 12 9 524 2867 2416 +5892 2 2 12 9 516 2884 2361 +5893 2 2 12 9 911 2094 3006 +5894 2 2 12 9 912 3007 2095 +5895 2 2 12 9 553 2916 2733 +5896 2 2 12 9 1576 3263 3147 +5897 2 2 12 9 541 1993 3343 +5898 2 2 12 9 1047 3173 3571 +5899 2 2 12 9 1048 3572 3174 +5900 2 2 12 9 791 1962 3206 +5901 2 2 12 9 477 1984 3430 +5902 2 2 12 9 1253 2202 2808 +5903 2 2 12 9 1001 2073 3134 +5904 2 2 12 9 471 2891 2379 +5905 2 2 12 9 573 3038 3300 +5906 2 2 12 9 1144 2984 2046 +5907 2 2 12 9 1335 3144 2532 +5908 2 2 12 9 819 2287 3271 +5909 2 2 12 9 629 2477 3400 +5910 2 2 12 9 1087 2895 2153 +5911 2 2 12 9 906 2344 2636 +5912 2 2 12 9 867 2342 2614 +5913 2 2 12 9 865 2062 3184 +5914 2 2 12 9 1246 2238 2865 +5915 2 2 12 9 1112 1928 3305 +5916 2 2 12 9 1139 3108 2568 +5917 2 2 12 9 1622 3311 2852 +5918 2 2 12 9 855 2297 3092 +5919 2 2 12 9 1623 2853 3312 +5920 2 2 12 9 755 3054 2078 +5921 2 2 12 9 275 3420 2212 +5922 2 2 12 9 1359 2716 3351 +5923 2 2 12 9 1254 2810 2203 +5924 2 2 12 9 392 2318 2760 +5925 2 2 12 9 393 2761 2319 +5926 2 2 12 9 410 2969 2335 +5927 2 2 12 9 1136 3181 2598 +5928 2 2 12 9 920 2144 2888 +5929 2 2 12 9 1654 3558 3565 +5930 2 2 12 9 1655 3566 3559 +5931 2 2 12 9 1602 2149 3273 +5932 2 2 12 9 527 2094 2929 +5933 2 2 12 9 528 2930 2095 +5934 2 2 12 9 966 3521 2210 +5935 2 2 12 9 1257 3411 2035 +5936 2 2 12 9 1018 2940 2056 +5937 2 2 12 9 376 3346 3527 +5938 2 2 12 9 1856 3403 3601 +5939 2 2 12 9 982 2165 2996 +5940 2 2 12 9 643 3125 2620 +5941 2 2 12 9 907 3448 2679 +5942 2 2 12 9 491 2031 3495 +5943 2 2 12 9 1112 3527 1928 +5944 2 2 12 9 1142 3144 3262 +5945 2 2 12 9 722 3138 2485 +5946 2 2 12 9 1452 2135 3351 +5947 2 2 12 9 897 2363 2905 +5948 2 2 12 9 305 306 3512 +5949 2 2 12 9 447 3134 2073 +5950 2 2 12 9 489 3573 2030 +5951 2 2 12 9 568 2789 2519 +5952 2 2 12 9 242 243 3610 +5953 2 2 12 9 333 334 3611 +5954 2 2 12 9 1157 3330 2255 +5955 2 2 12 9 1158 2256 3331 +5956 2 2 12 9 1343 3116 2760 +5957 2 2 12 9 934 2141 2970 +5958 2 2 12 9 1344 2761 3117 +5959 2 2 12 9 1030 1973 3231 +5960 2 2 12 9 218 3032 2067 +5961 2 2 12 9 914 2897 2206 +5962 2 2 12 9 950 2754 2213 +5963 2 2 12 9 951 2214 2755 +5964 2 2 12 9 437 3591 2963 +5965 2 2 12 9 560 3648 2098 +5966 2 2 12 9 1026 2687 2483 +5967 2 2 12 9 521 3207 2180 +5968 2 2 12 9 1370 2546 3365 +5969 2 2 12 9 1229 3139 2449 +5970 2 2 12 9 1230 2450 3140 +5971 2 2 12 9 1027 2848 2432 +5972 2 2 12 9 1239 2568 3108 +5973 2 2 12 9 897 2813 2241 +5974 2 2 12 9 1113 3025 2167 +5975 2 2 12 9 559 3329 2254 +5976 2 2 12 9 1328 3400 2477 +5977 2 2 12 9 1573 3578 2752 +5978 2 2 12 9 1409 3416 1961 +5979 2 2 12 9 423 3381 2014 +5980 2 2 12 9 639 3291 3351 +5981 2 2 12 9 523 3553 2008 +5982 2 2 12 9 1231 2008 3553 +5983 2 2 12 9 1211 2485 3138 +5984 2 2 12 9 550 2347 2701 +5985 2 2 12 9 1257 2035 3470 +5986 2 2 12 9 906 3055 2344 +5987 2 2 12 9 1326 2193 2918 +5988 2 2 12 9 497 2649 2366 +5989 2 2 12 9 498 2367 2650 +5990 2 2 12 9 956 3544 2512 +5991 2 2 12 9 411 2329 2752 +5992 2 2 12 9 1006 2225 3232 +5993 2 2 12 9 1456 2512 3544 +5994 2 2 12 9 884 2529 2628 +5995 2 2 12 9 908 2653 2570 +5996 2 2 12 9 744 2033 3341 +5997 2 2 12 9 745 3342 2034 +5998 2 2 12 9 1394 3165 3329 +5999 2 2 12 9 1003 3268 2335 +6000 2 2 12 9 1053 3290 2285 +6001 2 2 12 9 707 2255 3330 +6002 2 2 12 9 708 3331 2256 +6003 2 2 12 9 1010 2799 2244 +6004 2 2 12 9 203 3128 2294 +6005 2 2 12 9 1464 3334 3564 +6006 2 2 12 9 1035 3311 2330 +6007 2 2 12 9 1036 2331 3312 +6008 2 2 12 9 1307 2551 2662 +6009 2 2 12 9 557 2909 2462 +6010 2 2 12 9 639 3351 2716 +6011 2 2 12 9 598 3091 2433 +6012 2 2 12 9 1011 2908 2201 +6013 2 2 12 9 371 1975 3385 +6014 2 2 12 9 372 3386 1976 +6015 2 2 12 9 623 2631 3530 +6016 2 2 12 9 348 3302 2086 +6017 2 2 12 9 758 2150 3305 +6018 2 2 12 9 1056 2288 2816 +6019 2 2 12 9 1057 2817 2289 +6020 2 2 12 9 513 2973 2206 +6021 2 2 12 9 1173 2108 2993 +6022 2 2 12 9 489 2808 2217 +6023 2 2 12 9 410 3268 2682 +6024 2 2 12 9 1152 2865 2238 +6025 2 2 12 9 1153 3092 2297 +6026 2 2 12 9 2025 3556 2702 +6027 2 2 12 9 2026 2703 3557 +6028 2 2 12 9 1490 3005 2185 +6029 2 2 12 9 394 2483 2687 +6030 2 2 12 9 1220 2922 2670 +6031 2 2 12 9 1121 2043 3556 +6032 2 2 12 9 1122 3557 2044 +6033 2 2 12 9 1128 2294 3128 +6034 2 2 12 9 420 3338 2610 +6035 2 2 12 9 480 2141 3106 +6036 2 2 12 9 491 2231 2810 +6037 2 2 12 9 421 2611 3339 +6038 2 2 12 9 1068 2092 3326 +6039 2 2 12 9 1332 3256 2071 +6040 2 2 12 9 1649 3100 2874 +6041 2 2 12 9 1026 2598 2637 +6042 2 2 12 9 1175 2254 3329 +6043 2 2 12 9 632 3503 2066 +6044 2 2 12 9 456 2933 2575 +6045 2 2 12 9 1109 2965 2522 +6046 2 2 12 9 828 3077 2190 +6047 2 2 12 9 915 2417 2762 +6048 2 2 12 9 265 3606 2350 +6049 2 2 12 9 311 2351 3607 +6050 2 2 12 9 252 2088 3226 +6051 2 2 12 9 324 3227 2089 +6052 2 2 12 9 906 2424 3055 +6053 2 2 12 9 608 3393 2074 +6054 2 2 12 9 1536 2709 3487 +6055 2 2 12 9 543 2920 2137 +6056 2 2 12 9 544 2138 2921 +6057 2 2 12 9 890 3556 2043 +6058 2 2 12 9 891 2044 3557 +6059 2 2 12 9 1187 3480 1993 +6060 2 2 12 9 516 3107 2884 +6061 2 2 12 9 1343 2760 2318 +6062 2 2 12 9 1344 2319 2761 +6063 2 2 12 9 1125 2332 2885 +6064 2 2 12 9 1126 2886 2333 +6065 2 2 12 9 1251 2205 3030 +6066 2 2 12 9 1088 2858 2581 +6067 2 2 12 9 1089 2582 2859 +6068 2 2 12 9 1447 3292 3053 +6069 2 2 12 9 630 2780 2332 +6070 2 2 12 9 631 2333 2781 +6071 2 2 12 9 298 3412 2063 +6072 2 2 12 9 935 2662 2551 +6073 2 2 12 9 1104 3317 2728 +6074 2 2 12 9 1105 2729 3318 +6075 2 2 12 9 1107 2803 2527 +6076 2 2 12 9 1247 2620 3125 +6077 2 2 12 9 1474 3078 2403 +6078 2 2 12 9 20 3114 2159 +6079 2 2 12 9 1437 2981 3534 +6080 2 2 12 9 1438 3535 2982 +6081 2 2 12 9 1471 2570 2653 +6082 2 2 12 9 915 2762 3501 +6083 2 2 12 9 637 2265 3179 +6084 2 2 12 9 1004 2047 3212 +6085 2 2 12 9 1005 3213 2048 +6086 2 2 12 9 1112 3305 2150 +6087 2 2 12 9 684 2537 3113 +6088 2 2 12 9 980 2527 2803 +6089 2 2 12 9 764 3202 2176 +6090 2 2 12 9 1283 2884 3107 +6091 2 2 12 9 1110 2166 3146 +6092 2 2 12 9 1477 3479 3356 +6093 2 2 12 9 633 3373 3022 +6094 2 2 12 9 1139 2133 3510 +6095 2 2 12 9 2010 3614 2561 +6096 2 2 12 9 1086 2765 2432 +6097 2 2 12 9 779 2668 3436 +6098 2 2 12 9 1069 2616 2622 +6099 2 2 12 9 1130 2782 2388 +6100 2 2 12 9 1131 2389 2783 +6101 2 2 12 9 646 2315 3275 +6102 2 2 12 9 530 3471 2204 +6103 2 2 12 9 932 3612 2258 +6104 2 2 12 9 1376 2942 3214 +6105 2 2 12 9 1377 3215 2943 +6106 2 2 12 9 414 2820 2945 +6107 2 2 12 9 1192 3282 2128 +6108 2 2 12 9 1324 3233 3163 +6109 2 2 12 9 1325 3164 3234 +6110 2 2 12 9 1226 2672 3208 +6111 2 2 12 9 1474 3022 3373 +6112 2 2 12 9 1100 3214 2942 +6113 2 2 12 9 1527 3591 2472 +6114 2 2 12 9 1101 2943 3215 +6115 2 2 12 9 941 3396 2358 +6116 2 2 12 9 1233 2665 3221 +6117 2 2 12 9 1127 2645 2751 +6118 2 2 12 9 1411 3530 2631 +6119 2 2 12 9 1611 2285 3191 +6120 2 2 12 9 1791 3476 2186 +6121 2 2 12 9 1378 2005 3499 +6122 2 2 12 9 571 2637 2598 +6123 2 2 12 9 1018 2056 3254 +6124 2 2 12 9 794 3574 2053 +6125 2 2 12 9 1090 3045 3171 +6126 2 2 12 9 1091 3172 3046 +6127 2 2 12 9 1348 3221 2665 +6128 2 2 12 9 1026 2789 2598 +6129 2 2 12 9 396 3517 2507 +6130 2 2 12 9 929 2860 2366 +6131 2 2 12 9 1041 2262 3158 +6132 2 2 12 9 791 3389 2112 +6133 2 2 12 9 896 2496 3142 +6134 2 2 12 9 392 2760 2581 +6135 2 2 12 9 393 2582 2761 +6136 2 2 12 9 1608 2394 3574 +6137 2 2 12 9 1123 2051 3413 +6138 2 2 12 9 1124 3414 2052 +6139 2 2 12 9 477 2107 3464 +6140 2 2 12 9 618 2022 3456 +6141 2 2 12 9 687 3169 3620 +6142 2 2 12 9 688 3621 3170 +6143 2 2 12 9 362 2247 3361 +6144 2 2 12 9 1051 3477 2105 +6145 2 2 12 9 1332 2682 3268 +6146 2 2 12 9 714 2494 2726 +6147 2 2 12 9 1083 2751 2645 +6148 2 2 12 9 1320 2658 2773 +6149 2 2 12 9 1221 2854 3429 +6150 2 2 12 9 973 3089 2525 +6151 2 2 12 9 974 2526 3090 +6152 2 2 12 9 929 2322 2801 +6153 2 2 12 9 353 3053 3292 +6154 2 2 12 9 1129 3179 2265 +6155 2 2 12 9 1275 2778 3428 +6156 2 2 12 9 607 2874 3100 +6157 2 2 12 9 666 2788 2554 +6158 2 2 12 9 376 3527 2125 +6159 2 2 12 9 1006 2264 3560 +6160 2 2 12 9 1032 3038 2452 +6161 2 2 12 9 1290 3503 2572 +6162 2 2 12 9 341 2522 2965 +6163 2 2 12 9 626 3135 2704 +6164 2 2 12 9 1296 2350 3606 +6165 2 2 12 9 1297 3607 2351 +6166 2 2 12 9 1161 2226 3043 +6167 2 2 12 9 1429 3263 2338 +6168 2 2 12 9 1140 2050 3475 +6169 2 2 12 9 1086 2622 2616 +6170 2 2 12 9 584 2432 2848 +6171 2 2 12 9 1463 2747 3469 +6172 2 2 12 9 1003 2335 3127 +6173 2 2 12 9 1125 3541 2047 +6174 2 2 12 9 1126 2048 3542 +6175 2 2 12 9 1337 3511 2145 +6176 2 2 12 9 574 2447 3567 +6177 2 2 12 9 836 2431 3376 +6178 2 2 12 9 575 3568 2448 +6179 2 2 12 9 643 3496 3613 +6180 2 2 12 9 590 2338 2931 +6181 2 2 12 9 392 2581 2858 +6182 2 2 12 9 393 2859 2582 +6183 2 2 12 9 1178 2575 2933 +6184 2 2 12 9 1199 3113 2537 +6185 2 2 12 9 818 3249 2229 +6186 2 2 12 9 1026 2519 2789 +6187 2 2 12 9 501 2037 3593 +6188 2 2 12 9 1320 2773 3516 +6189 2 2 12 9 1391 2775 3622 +6190 2 2 12 9 1392 3623 2776 +6191 2 2 12 9 1306 2686 2669 +6192 2 2 12 9 1196 2847 3125 +6193 2 2 12 9 1030 3231 2294 +6194 2 2 12 9 972 2107 3271 +6195 2 2 12 9 540 3023 2296 +6196 2 2 12 9 676 3424 3431 +6197 2 2 12 9 1054 2249 3349 +6198 2 2 12 9 506 3324 2142 +6199 2 2 12 9 507 2143 3325 +6200 2 2 12 9 524 3158 2262 +6201 2 2 12 9 1112 2125 3527 +6202 2 2 12 9 1175 3165 2648 +6203 2 2 12 9 1104 3087 3317 +6204 2 2 12 9 1105 3318 3088 +6205 2 2 12 9 679 3468 2151 +6206 2 2 12 9 1197 3279 2120 +6207 2 2 12 9 1198 2121 3280 +6208 2 2 12 9 543 2440 2920 +6209 2 2 12 9 544 2921 2441 +6210 2 2 12 9 1062 2795 2833 +6211 2 2 12 9 1206 3203 2152 +6212 2 2 12 9 1247 3125 2847 +6213 2 2 12 9 1331 3014 2635 +6214 2 2 12 9 1485 2423 3295 +6215 2 2 12 9 1200 2373 3169 +6216 2 2 12 9 1201 3170 2374 +6217 2 2 12 9 1364 3182 3112 +6218 2 2 12 9 652 3157 2261 +6219 2 2 12 9 585 3052 2408 +6220 2 2 12 9 950 3066 2301 +6221 2 2 12 9 951 2302 3067 +6222 2 2 12 9 1116 2151 3468 +6223 2 2 12 9 1240 2258 3612 +6224 2 2 12 9 250 2275 3622 +6225 2 2 12 9 326 3623 2276 +6226 2 2 12 9 1169 2935 2705 +6227 2 2 12 9 840 3171 2161 +6228 2 2 12 9 841 2162 3172 +6229 2 2 12 9 1725 3050 2936 +6230 2 2 12 9 1726 2937 3051 +6231 2 2 12 9 411 3578 2234 +6232 2 2 12 9 1055 2927 3107 +6233 2 2 12 9 539 2635 3014 +6234 2 2 12 9 1035 2330 3163 +6235 2 2 12 9 1036 3164 2331 +6236 2 2 12 9 1013 2379 2891 +6237 2 2 12 9 812 2093 3550 +6238 2 2 12 9 1038 3424 2415 +6239 2 2 12 9 1069 2149 3522 +6240 2 2 12 9 1359 3351 2135 +6241 2 2 12 9 1097 3250 2303 +6242 2 2 12 9 952 3126 2528 +6243 2 2 12 9 1290 2945 2820 +6244 2 2 12 9 569 2528 3156 +6245 2 2 12 9 1171 3361 2247 +6246 2 2 12 9 975 3003 2261 +6247 2 2 12 9 1141 2697 2925 +6248 2 2 12 9 1061 2581 2760 +6249 2 2 12 9 1063 2761 2582 +6250 2 2 12 9 1239 3108 2836 +6251 2 2 12 9 1147 2472 3186 +6252 2 2 12 9 1035 3233 2502 +6253 2 2 12 9 1036 2503 3234 +6254 2 2 12 9 640 3208 2672 +6255 2 2 12 9 1157 2731 3330 +6256 2 2 12 9 1158 3331 2732 +6257 2 2 12 9 379 3582 2459 +6258 2 2 12 9 338 3245 2308 +6259 2 2 12 9 632 2572 3503 +6260 2 2 12 9 985 2727 2663 +6261 2 2 12 9 458 2114 3348 +6262 2 2 12 9 357 2418 2913 +6263 2 2 12 9 622 3388 3161 +6264 2 2 12 9 287 2237 3192 +6265 2 2 12 9 543 2137 3200 +6266 2 2 12 9 1093 2554 2788 +6267 2 2 12 9 544 3201 2138 +6268 2 2 12 9 1594 2522 3507 +6269 2 2 12 9 221 2230 3040 +6270 2 2 12 9 364 3510 2133 +6271 2 2 12 9 1043 2281 3228 +6272 2 2 12 9 1309 2663 2727 +6273 2 2 12 9 1044 3229 2282 +6274 2 2 12 9 964 2936 3050 +6275 2 2 12 9 1292 2184 3315 +6276 2 2 12 9 965 3051 2937 +6277 2 2 12 9 1038 3085 2479 +6278 2 2 12 9 1136 2598 2789 +6279 2 2 12 9 1170 2484 3505 +6280 2 2 12 9 1273 2897 2482 +6281 2 2 12 9 414 2945 2395 +6282 2 2 12 9 247 3176 2377 +6283 2 2 12 9 329 2378 3177 +6284 2 2 12 9 586 2480 2984 +6285 2 2 12 9 523 2150 3553 +6286 2 2 12 9 949 3411 2867 +6287 2 2 12 9 510 2105 3477 +6288 2 2 12 9 662 2164 3539 +6289 2 2 12 9 1315 3295 2423 +6290 2 2 12 9 603 2902 3636 +6291 2 2 12 9 1189 2833 2795 +6292 2 2 12 9 1135 2308 3245 +6293 2 2 12 9 373 3462 2110 +6294 2 2 12 9 374 2111 3463 +6295 2 2 12 9 640 3522 2149 +6296 2 2 12 9 1054 3500 2249 +6297 2 2 12 9 914 2482 2897 +6298 2 2 12 9 1137 3112 3182 +6299 2 2 12 9 977 2530 3011 +6300 2 2 12 9 629 3451 3355 +6301 2 2 12 9 984 2669 2686 +6302 2 2 12 9 385 3139 3149 +6303 2 2 12 9 384 3150 3140 +6304 2 2 12 9 963 2773 2658 +6305 2 2 12 9 1321 3388 2163 +6306 2 2 12 9 1099 2931 2338 +6307 2 2 12 9 682 3166 2881 +6308 2 2 12 9 619 3186 2472 +6309 2 2 12 9 1327 2681 3286 +6310 2 2 12 9 1065 2249 3356 +6311 2 2 12 9 1295 2604 2860 +6312 2 2 12 9 417 3590 2268 +6313 2 2 12 9 779 3436 2106 +6314 2 2 12 9 934 2700 3106 +6315 2 2 12 9 549 2836 3108 +6316 2 2 12 9 548 3058 2613 +6317 2 2 12 9 1257 2416 2867 +6318 2 2 12 9 1072 2913 2418 +6319 2 2 12 9 1719 3431 3424 +6320 2 2 12 9 879 2189 3321 +6321 2 2 12 9 680 2327 3127 +6322 2 2 12 9 266 2391 3606 +6323 2 2 12 9 310 3607 2392 +6324 2 2 12 9 1455 2657 3601 +6325 2 2 12 9 1274 2704 3135 +6326 2 2 12 9 1771 2349 3576 +6327 2 2 12 9 1024 2583 3344 +6328 2 2 12 9 381 2340 3425 +6329 2 2 12 9 1480 2944 3308 +6330 2 2 12 9 1515 2779 2940 +6331 2 2 12 9 429 3442 2184 +6332 2 2 12 9 1252 3376 2431 +6333 2 2 12 9 1412 2831 3158 +6334 2 2 12 9 556 3225 2638 +6335 2 2 12 9 1059 2174 3488 +6336 2 2 12 9 1071 2563 2958 +6337 2 2 12 9 571 2741 3097 +6338 2 2 12 9 1115 3077 2511 +6339 2 2 12 9 534 3216 2235 +6340 2 2 12 9 1241 2587 3501 +6341 2 2 12 9 1242 3502 2588 +6342 2 2 12 9 572 3063 2654 +6343 2 2 12 9 573 2655 3064 +6344 2 2 12 9 1136 3049 2969 +6345 2 2 12 9 290 3270 2248 +6346 2 2 12 9 893 3093 2320 +6347 2 2 12 9 894 2321 3094 +6348 2 2 12 9 459 3489 2115 +6349 2 2 12 9 1125 2885 2737 +6350 2 2 12 9 1126 2738 2886 +6351 2 2 12 9 943 3493 2122 +6352 2 2 12 9 944 2123 3494 +6353 2 2 12 9 1280 2969 3049 +6354 2 2 12 9 581 3228 2281 +6355 2 2 12 9 582 2282 3229 +6356 2 2 12 9 1656 3550 2398 +6357 2 2 12 9 548 2833 3058 +6358 2 2 12 9 1183 3055 2424 +6359 2 2 12 9 249 3622 2775 +6360 2 2 12 9 327 2776 3623 +6361 2 2 12 9 762 3575 3204 +6362 2 2 12 9 1510 3258 3443 +6363 2 2 12 9 1511 3444 3259 +6364 2 2 12 9 1406 3248 3186 +6365 2 2 12 9 568 3049 2789 +6366 2 2 12 9 1549 3391 2380 +6367 2 2 12 9 1079 2402 3194 +6368 2 2 12 9 559 2990 3329 +6369 2 2 12 9 803 2403 3078 +6370 2 2 12 9 1604 3344 2493 +6371 2 2 12 9 1021 2613 3058 +6372 2 2 12 9 571 3097 2310 +6373 2 2 12 9 659 3296 2461 +6374 2 2 12 9 612 2458 3035 +6375 2 2 12 9 1239 3348 2568 +6376 2 2 12 9 865 2303 3250 +6377 2 2 12 9 1283 3107 2927 +6378 2 2 12 9 550 3529 2347 +6379 2 2 12 9 1227 3627 2433 +6380 2 2 12 9 598 2433 3627 +6381 2 2 12 9 613 3356 2249 +6382 2 2 12 9 391 3115 2346 +6383 2 2 12 9 591 2925 2697 +6384 2 2 12 9 1750 2698 2910 +6385 2 2 12 9 955 2192 3435 +6386 2 2 12 9 1193 3156 2528 +6387 2 2 12 9 454 3163 2330 +6388 2 2 12 9 455 2331 3164 +6389 2 2 12 9 1293 3523 2183 +6390 2 2 12 9 1321 3161 3388 +6391 2 2 12 9 397 3540 2190 +6392 2 2 12 9 707 3240 2728 +6393 2 2 12 9 708 2729 3241 +6394 2 2 12 9 923 3558 2559 +6395 2 2 12 9 924 2560 3559 +6396 2 2 12 9 1102 3635 2790 +6397 2 2 12 9 521 2258 3207 +6398 2 2 12 9 1496 3196 2299 +6399 2 2 12 9 1154 3000 2914 +6400 2 2 12 9 468 2514 3417 +6401 2 2 12 9 896 2328 3073 +6402 2 2 12 9 597 2210 3521 +6403 2 2 12 9 642 2183 3362 +6404 2 2 12 9 1073 2346 3115 +6405 2 2 12 9 629 3355 2477 +6406 2 2 12 9 1246 2212 3420 +6407 2 2 12 9 1143 3539 2164 +6408 2 2 12 9 560 2958 2563 +6409 2 2 12 9 1243 3097 2741 +6410 2 2 12 9 1543 3636 2902 +6411 2 2 12 9 997 3324 2266 +6412 2 2 12 9 998 2267 3325 +6413 2 2 12 9 561 2493 3344 +6414 2 2 12 9 525 3173 2313 +6415 2 2 12 9 526 2314 3174 +6416 2 2 12 9 1269 3009 3632 +6417 2 2 12 9 1387 3149 3139 +6418 2 2 12 9 1388 3140 3150 +6419 2 2 12 9 1163 3012 3141 +6420 2 2 12 9 573 2452 3038 +6421 2 2 12 9 361 2730 2946 +6422 2 2 12 9 1224 2555 3555 +6423 2 2 12 9 943 2573 3016 +6424 2 2 12 9 944 3017 2574 +6425 2 2 12 9 531 3554 2211 +6426 2 2 12 9 774 2625 2978 +6427 2 2 12 9 1065 3479 2349 +6428 2 2 12 9 548 2709 2833 +6429 2 2 12 9 1000 2993 2684 +6430 2 2 12 9 933 2842 2624 +6431 2 2 12 9 1605 3204 3575 +6432 2 2 12 9 963 3275 2315 +6433 2 2 12 9 1073 2211 3554 +6434 2 2 12 9 1303 2881 3166 +6435 2 2 12 9 1214 3191 2285 +6436 2 2 12 9 1387 3169 2373 +6437 2 2 12 9 1388 2374 3170 +6438 2 2 12 9 1921 3056 3346 +6439 2 2 12 9 882 3103 2442 +6440 2 2 12 9 1062 2833 2709 +6441 2 2 12 9 1017 2234 3578 +6442 2 2 12 9 1147 3186 3248 +6443 2 2 12 9 1406 3570 2851 +6444 2 2 12 9 512 3488 2174 +6445 2 2 12 9 613 2249 3500 +6446 2 2 12 9 572 2451 3063 +6447 2 2 12 9 1279 2974 2863 +6448 2 2 12 9 573 3064 2452 +6449 2 2 12 9 566 2766 3398 +6450 2 2 12 9 1453 3605 3615 +6451 2 2 12 9 1087 2851 3570 +6452 2 2 12 9 382 3021 2680 +6453 2 2 12 9 1365 2923 2608 +6454 2 2 12 9 1209 3481 2521 +6455 2 2 12 9 1537 2362 3111 +6456 2 2 12 9 886 3194 2402 +6457 2 2 12 9 802 3260 2473 +6458 2 2 12 9 1167 3443 3258 +6459 2 2 12 9 1168 3259 3444 +6460 2 2 12 9 952 2603 2947 +6461 2 2 12 9 1333 3008 2809 +6462 2 2 12 9 583 2479 3085 +6463 2 2 12 9 340 2284 3528 +6464 2 2 12 9 1056 2816 3644 +6465 2 2 12 9 1057 3645 2817 +6466 2 2 12 9 1394 3329 2990 +6467 2 2 12 9 718 2501 3383 +6468 2 2 12 9 638 2521 3481 +6469 2 2 12 9 574 3567 2832 +6470 2 2 12 9 575 2834 3568 +6471 2 2 12 9 958 3460 2186 +6472 2 2 12 9 425 3516 2773 +6473 2 2 12 9 978 2565 3385 +6474 2 2 12 9 979 3386 2566 +6475 2 2 12 9 1290 2572 2945 +6476 2 2 12 9 1130 2985 2782 +6477 2 2 12 9 1131 2783 2986 +6478 2 2 12 9 1426 3398 2766 +6479 2 2 12 9 1219 2347 3529 +6480 2 2 12 9 619 3570 3186 +6481 2 2 12 9 1154 2796 3000 +6482 2 2 12 9 915 3501 2587 +6483 2 2 12 9 916 2588 3502 +6484 2 2 12 9 622 2474 3388 +6485 2 2 12 9 1032 2978 2625 +6486 2 2 12 9 546 2885 2626 +6487 2 2 12 9 547 2627 2886 +6488 2 2 12 9 1194 3141 3012 +6489 2 2 12 9 1042 2863 2974 +6490 2 2 12 9 1760 3630 2542 +6491 2 2 12 9 410 2335 3268 +6492 2 2 12 9 546 2737 2885 +6493 2 2 12 9 547 2886 2738 +6494 2 2 12 9 348 2910 2698 +6495 2 2 12 9 897 2241 3586 +6496 2 2 12 9 1186 3345 3216 +6497 2 2 12 9 667 3555 2555 +6498 2 2 12 9 305 3512 2535 +6499 2 2 12 9 586 2984 2971 +6500 2 2 12 9 1008 2268 3590 +6501 2 2 12 9 1054 3349 2571 +6502 2 2 12 9 586 2796 2873 +6503 2 2 12 9 1293 3538 2198 +6504 2 2 12 9 1117 2705 2935 +6505 2 2 12 9 1317 2490 3321 +6506 2 2 12 9 467 3614 2453 +6507 2 2 12 9 1354 3355 3451 +6508 2 2 12 9 444 3453 3211 +6509 2 2 12 9 995 2434 3132 +6510 2 2 12 9 996 3133 2435 +6511 2 2 12 9 1634 3427 2300 +6512 2 2 12 9 1076 2446 3246 +6513 2 2 12 9 532 3379 3295 +6514 2 2 12 9 1053 2670 2922 +6515 2 2 12 9 530 2645 3471 +6516 2 2 12 9 1086 3052 2765 +6517 2 2 12 9 983 2881 3297 +6518 2 2 12 9 1192 3181 3096 +6519 2 2 12 9 1245 2946 2730 +6520 2 2 12 9 345 2532 3144 +6521 2 2 12 9 1154 3001 2873 +6522 2 2 12 9 2078 3054 3394 +6523 2 2 12 9 1154 2873 2796 +6524 2 2 12 9 1151 2680 3021 +6525 2 2 12 9 1000 2638 3225 +6526 2 2 12 9 565 3626 2344 +6527 2 2 12 9 534 3629 3216 +6528 2 2 12 9 1075 2328 3434 +6529 2 2 12 9 1832 3098 3137 +6530 2 2 12 9 1491 2634 3647 +6531 2 2 12 9 586 3012 2796 +6532 2 2 12 9 1071 3516 2747 +6533 2 2 12 9 1193 3337 3156 +6534 2 2 12 9 777 2809 3008 +6535 2 2 12 9 1140 3278 2594 +6536 2 2 12 9 1301 2782 2985 +6537 2 2 12 9 1302 2986 2783 +6538 2 2 12 9 1183 2473 3260 +6539 2 2 12 9 401 3137 3098 +6540 2 2 12 9 1144 2917 2971 +6541 2 2 12 9 499 2358 3396 +6542 2 2 12 9 390 3374 2362 +6543 2 2 12 9 1149 2696 3148 +6544 2 2 12 9 1633 3145 2889 +6545 2 2 12 9 401 3646 2312 +6546 2 2 12 9 1442 2812 3435 +6547 2 2 12 9 1106 3382 2407 +6548 2 2 12 9 378 2940 2779 +6549 2 2 12 9 1066 2525 3089 +6550 2 2 12 9 1067 3090 2526 +6551 2 2 12 9 1485 3295 3379 +6552 2 2 12 9 637 3353 2393 +6553 2 2 12 9 1212 2610 3338 +6554 2 2 12 9 1213 3339 2611 +6555 2 2 12 9 508 2349 3479 +6556 2 2 12 9 1193 2528 3126 +6557 2 2 12 9 1461 3237 3504 +6558 2 2 12 9 1226 3383 2501 +6559 2 2 12 9 909 3647 2634 +6560 2 2 12 9 1240 3612 3423 +6561 2 2 12 9 1391 3622 2275 +6562 2 2 12 9 1392 2276 3623 +6563 2 2 12 9 1354 2353 3355 +6564 2 2 12 9 1144 2971 2984 +6565 2 2 12 9 1303 3297 2881 +6566 2 2 12 9 669 3434 2328 +6567 2 2 12 9 428 3449 2725 +6568 2 2 12 9 509 3286 2428 +6569 2 2 12 9 595 3560 2264 +6570 2 2 12 9 37 2355 3357 +6571 2 2 12 9 184 3358 2356 +6572 2 2 12 9 1129 2265 3584 +6573 2 2 12 9 887 3345 2806 +6574 2 2 12 9 1236 2535 3512 +6575 2 2 12 9 1102 2998 3635 +6576 2 2 12 9 386 3594 2785 +6577 2 2 12 9 551 3446 2373 +6578 2 2 12 9 552 2374 3447 +6579 2 2 12 9 619 2895 3570 +6580 2 2 12 9 1450 3452 3267 +6581 2 2 12 9 1038 3120 3424 +6582 2 2 12 9 587 2502 3233 +6583 2 2 12 9 588 3234 2503 +6584 2 2 12 9 1463 3469 3313 +6585 2 2 12 9 1488 3211 3453 +6586 2 2 12 9 1194 2971 2917 +6587 2 2 12 9 1151 2485 3333 +6588 2 2 12 9 879 3321 2490 +6589 2 2 12 9 422 2406 3634 +6590 2 2 12 9 1110 3585 2613 +6591 2 2 12 9 560 2287 3648 +6592 2 2 12 9 1389 2295 3580 +6593 2 2 12 9 941 3247 3396 +6594 2 2 12 9 1093 3634 2406 +6595 2 2 12 9 1522 2593 3157 +6596 2 2 12 9 1689 2396 3482 +6597 2 2 12 9 584 3224 2622 +6598 2 2 12 9 604 2914 3000 +6599 2 2 12 9 1058 2461 3296 +6600 2 2 12 9 1163 3000 2796 +6601 2 2 12 9 1202 2344 3626 +6602 2 2 12 9 442 3544 2280 +6603 2 2 12 9 1281 3156 3337 +6604 2 2 12 9 1754 3430 2556 +6605 2 2 12 9 1143 2339 3539 +6606 2 2 12 9 1153 2878 3452 +6607 2 2 12 9 571 2598 3181 +6608 2 2 12 9 676 2415 3424 +6609 2 2 12 9 678 2878 3643 +6610 2 2 12 9 1397 3581 3079 +6611 2 2 12 9 1190 2312 3646 +6612 2 2 12 9 418 2594 3278 +6613 2 2 12 9 571 3181 2741 +6614 2 2 12 9 1532 3450 2414 +6615 2 2 12 9 1563 3482 2396 +6616 2 2 12 9 968 3595 2861 +6617 2 2 12 9 1304 3047 3102 +6618 2 2 12 9 955 3435 2812 +6619 2 2 12 9 873 3429 2445 +6620 2 2 12 9 1178 2933 3208 +6621 2 2 12 9 933 2463 3347 +6622 2 2 12 9 759 3313 3469 +6623 2 2 12 9 1142 3262 2673 +6624 2 2 12 9 413 3349 3175 +6625 2 2 12 9 1232 3504 3237 +6626 2 2 12 9 1163 2796 3012 +6627 2 2 12 9 1257 2867 3411 +6628 2 2 12 9 1592 3404 3406 +6629 2 2 12 9 1690 3106 2700 +6630 2 2 12 9 1453 2804 3605 +6631 2 2 12 9 677 2899 3315 +6632 2 2 12 9 2022 2413 3456 +6633 2 2 12 9 1163 3141 2946 +6634 2 2 12 9 1169 3401 2935 +6635 2 2 12 9 936 2478 3419 +6636 2 2 12 9 1184 2873 3001 +6637 2 2 12 9 271 3148 2696 +6638 2 2 12 9 586 2971 3012 +6639 2 2 12 9 1015 2832 3567 +6640 2 2 12 9 1016 3568 2834 +6641 2 2 12 9 1638 2806 3345 +6642 2 2 12 9 678 3267 3452 +6643 2 2 12 9 1289 2966 3195 +6644 2 2 12 9 1387 3139 3620 +6645 2 2 12 9 1388 3621 3140 +6646 2 2 12 9 677 3079 3581 +6647 2 2 12 9 1155 2590 3251 +6648 2 2 12 9 1227 3199 3627 +6649 2 2 12 9 1143 2453 3614 +6650 2 2 12 9 1189 3058 2833 +6651 2 2 12 9 1227 2647 3199 +6652 2 2 12 9 585 2765 3052 +6653 2 2 12 9 1243 2675 3097 +6654 2 2 12 9 1135 3569 2911 +6655 2 2 12 9 1405 3643 2878 +6656 2 2 12 9 1000 3225 2993 +6657 2 2 12 9 1104 2728 3240 +6658 2 2 12 9 1105 3241 2729 +6659 2 2 12 9 1060 2514 3390 +6660 2 2 12 9 419 2648 3165 +6661 2 2 12 9 1104 3240 2515 +6662 2 2 12 9 1105 2516 3241 +6663 2 2 12 9 1107 3410 2803 +6664 2 2 12 9 1194 3012 2971 +6665 2 2 12 9 633 3022 3511 +6666 2 2 12 9 1296 3606 2391 +6667 2 2 12 9 1297 2392 3607 +6668 2 2 12 9 1069 2622 3224 +6669 2 2 12 9 1292 3615 3605 +6670 2 2 12 9 410 2682 3282 +6671 2 2 12 9 1125 2464 3541 +6672 2 2 12 9 1126 3542 2465 +6673 2 2 12 9 1060 3417 2514 +6674 2 2 12 9 405 3102 3047 +6675 2 2 12 9 1163 2946 3183 +6676 2 2 12 9 1582 3567 2447 +6677 2 2 12 9 1583 2448 3568 +6678 2 2 12 9 968 2507 3517 +6679 2 2 12 9 1673 3410 3160 +6680 2 2 12 9 1761 3338 2862 +6681 2 2 12 9 1762 2864 3339 +6682 2 2 12 9 1192 2741 3181 +6683 2 2 12 9 559 3257 2990 +6684 2 2 12 9 497 3426 2649 +6685 2 2 12 9 1177 3514 2481 +6686 2 2 12 9 498 2650 3545 +6687 2 2 12 9 1145 3616 2489 +6688 2 2 12 9 535 3209 2814 +6689 2 2 12 9 1141 3406 3404 +6690 2 2 12 9 362 3199 2647 +6691 2 2 12 9 1477 3399 3479 +6692 2 2 12 9 400 3136 3323 +6693 2 2 12 9 1136 2789 3049 +6694 2 2 12 9 214 2956 3104 +6695 2 2 12 9 1929 3011 3290 +6696 2 2 12 9 1200 3169 3287 +6697 2 2 12 9 1201 3288 3170 +6698 2 2 12 9 411 2752 3578 +6699 2 2 12 9 1334 3323 3136 +6700 2 2 12 9 1330 3456 2413 +6701 2 2 12 9 1248 2728 3317 +6702 2 2 12 9 1249 3318 2729 +6703 2 2 12 9 1578 3162 3190 +6704 2 2 12 9 596 2673 3262 +6705 2 2 12 9 1386 3245 3392 +6706 2 2 12 9 1292 3315 2899 +6707 2 2 12 9 379 2438 3582 +6708 2 2 12 9 410 3096 2969 +6709 2 2 12 9 1386 2437 3569 +6710 2 2 12 9 1523 3627 3199 +6711 2 2 12 9 1196 3104 2956 +6712 2 2 12 9 1136 2969 3096 +6713 2 2 12 9 501 3593 2553 +6714 2 2 12 9 403 3541 2464 +6715 2 2 12 9 404 2465 3542 +6716 2 2 12 9 1245 3183 2946 +6717 2 2 12 9 413 2571 3349 +6718 2 2 12 9 1169 2725 3449 +6719 2 2 12 9 1376 3359 3293 +6720 2 2 12 9 1377 3294 3360 +6721 2 2 12 9 1042 2889 3145 +6722 2 2 12 9 1458 3451 3387 +6723 2 2 12 9 1041 3158 2831 +6724 2 2 12 9 508 3479 3399 +6725 2 2 12 9 561 3344 2583 +6726 2 2 12 9 1536 3487 3583 +6727 2 2 12 9 412 3580 2567 +6728 2 2 12 9 1151 3415 2680 +6729 2 2 12 9 1677 3496 2620 +6730 2 2 12 9 373 2690 3462 +6731 2 2 12 9 374 3463 2691 +6732 2 2 12 9 532 3295 3095 +6733 2 2 12 9 395 3290 3011 +6734 2 2 12 9 1075 3434 2531 +6735 2 2 12 9 1277 3222 3187 +6736 2 2 12 9 1457 3448 2753 +6737 2 2 12 9 643 2620 3496 +6738 2 2 12 9 1118 3379 3103 +6739 2 2 12 9 1376 3214 3359 +6740 2 2 12 9 1377 3360 3215 +6741 2 2 12 9 1357 3033 3571 +6742 2 2 12 9 1358 3572 3034 +6743 2 2 12 9 361 2946 3141 +6744 2 2 12 9 1270 3398 3247 +6745 2 2 12 9 1153 3452 3092 +6746 2 2 12 9 338 3392 3245 +6747 2 2 12 9 360 2769 3538 +6748 2 2 12 9 629 3387 3451 +6749 2 2 12 9 661 3340 2756 +6750 2 2 12 9 1047 3571 3033 +6751 2 2 12 9 1048 3034 3572 +6752 2 2 12 9 1240 3520 2896 +6753 2 2 12 9 209 3546 2498 +6754 2 2 12 9 693 3583 3487 +6755 2 2 12 9 1197 3293 3359 +6756 2 2 12 9 1198 3360 3294 +6757 2 2 12 9 1195 2814 3209 +6758 2 2 12 9 1525 3543 3529 +6759 2 2 12 9 1383 2553 3593 +6760 2 2 12 9 682 3552 3166 +6761 2 2 12 9 976 2680 3415 +6762 2 2 12 9 1080 3190 3162 +6763 2 2 12 9 1370 3498 2546 +6764 2 2 12 9 968 2468 3595 +6765 2 2 12 9 1470 2564 3438 +6766 2 2 12 9 1149 2756 3340 +6767 2 2 12 9 1035 2852 3311 +6768 2 2 12 9 1036 3312 2853 +6769 2 2 12 9 1226 3208 2933 +6770 2 2 12 9 1708 3490 2858 +6771 2 2 12 9 1709 2859 3491 +6772 2 2 12 9 699 2896 3520 +6773 2 2 12 9 551 2591 3618 +6774 2 2 12 9 552 3619 2592 +6775 2 2 12 9 604 3000 3183 +6776 2 2 12 9 1219 3529 3543 +6777 2 2 12 9 1475 3438 2564 +6778 2 2 12 9 1223 3462 2690 +6779 2 2 12 9 1224 2691 3463 +6780 2 2 12 9 548 2613 3585 +6781 2 2 12 9 1193 3123 3337 +6782 2 2 12 9 467 2561 3614 +6783 2 2 12 9 1148 3195 2966 +6784 2 2 12 9 1523 3199 3361 +6785 2 2 12 9 1315 3095 3295 +6786 2 2 12 9 1163 3183 3000 +6787 2 2 12 9 1274 3135 3439 +6788 2 2 12 9 355 3359 3214 +6789 2 2 12 9 356 3215 3360 +6790 2 2 12 9 1312 3367 3204 +6791 2 2 12 9 1205 3187 3222 +6792 2 2 12 9 1127 3471 2645 +6793 2 2 12 9 1400 3166 3552 +6794 2 2 12 9 216 3465 2847 +6795 2 2 12 9 884 3641 2499 +6796 2 2 12 9 1426 3247 3398 +6797 2 2 12 9 907 2753 3448 +6798 2 2 12 9 1597 3260 2948 +6799 2 2 12 9 1173 2993 3225 +6800 2 2 12 9 1093 2788 3634 +6801 2 2 12 9 910 2714 3579 +6802 2 2 12 9 802 2948 3260 +6803 2 2 12 9 245 3637 2651 +6804 2 2 12 9 331 2652 3638 +6805 2 2 12 9 1145 3461 2690 +6806 2 2 12 9 1099 3308 2944 +6807 2 2 12 9 932 2594 3612 +6808 2 2 12 9 890 2702 3556 +6809 2 2 12 9 891 3557 2703 +6810 2 2 12 9 1474 3417 3022 +6811 2 2 12 9 1116 3468 2659 +6812 2 2 12 9 916 3502 2872 +6813 2 2 12 9 420 2862 3338 +6814 2 2 12 9 421 3339 2864 +6815 2 2 12 9 1472 3369 3483 +6816 2 2 12 9 1473 3484 3370 +6817 2 2 12 9 762 3204 3367 +6818 2 2 12 9 1182 2990 3257 +6819 2 2 12 9 1215 2919 3372 +6820 2 2 12 9 1386 3569 3245 +6821 2 2 12 9 496 2727 3450 +6822 2 2 12 9 1406 3186 3570 +6823 2 2 12 9 1546 3024 3296 +6824 2 2 12 9 678 3452 2878 +6825 2 2 12 9 1613 3440 3505 +6826 2 2 12 9 410 3282 3096 +6827 2 2 12 9 425 2747 3516 +6828 2 2 12 9 1179 3483 3369 +6829 2 2 12 9 1180 3370 3484 +6830 2 2 12 9 1644 2785 3437 +6831 2 2 12 9 1207 3323 3285 +6832 2 2 12 9 1224 3555 2691 +6833 2 2 12 9 667 3366 3555 +6834 2 2 12 9 1247 2847 3465 +6835 2 2 12 9 670 2935 3401 +6836 2 2 12 9 1839 2872 3502 +6837 2 2 12 9 620 3372 2919 +6838 2 2 12 9 1233 3221 3617 +6839 2 2 12 9 1238 3579 2714 +6840 2 2 12 9 545 2790 3635 +6841 2 2 12 9 687 3287 3169 +6842 2 2 12 9 688 3170 3288 +6843 2 2 12 9 1138 3159 3267 +6844 2 2 12 9 1060 3022 3417 +6845 2 2 12 9 1450 3267 3159 +6846 2 2 12 9 1233 3617 3313 +6847 2 2 12 9 1266 3335 3327 +6848 2 2 12 9 1267 3328 3336 +6849 2 2 12 9 1019 3394 3054 +6850 2 2 12 9 366 2955 3457 +6851 2 2 12 9 1135 3245 3569 +6852 2 2 12 9 1039 3346 3056 +6853 2 2 12 9 1170 3505 3440 +6854 2 2 12 9 614 2743 3518 +6855 2 2 12 9 615 3519 2744 +6856 2 2 12 9 1058 3296 3024 +6857 2 2 12 9 1192 3096 3282 +6858 2 2 12 9 614 3518 3116 +6859 2 2 12 9 615 3117 3519 +6860 2 2 12 9 348 2977 3531 +6861 2 2 12 9 1571 3322 3563 +6862 2 2 12 9 1421 3591 3422 +6863 2 2 12 9 1334 3285 3323 +6864 2 2 12 9 429 3605 2804 +6865 2 2 12 9 1790 3281 3217 +6866 2 2 12 9 1129 2785 3594 +6867 2 2 12 9 1153 3592 2878 +6868 2 2 12 9 781 3337 3123 +6869 2 2 12 9 1324 3327 3335 +6870 2 2 12 9 1325 3336 3328 +6871 2 2 12 9 578 3317 3087 +6872 2 2 12 9 579 3088 3318 +6873 2 2 12 9 1411 3236 3530 +6874 2 2 12 9 1192 3631 2741 +6875 2 2 12 9 1390 3530 3236 +6876 2 2 12 9 585 3628 2765 +6877 2 2 12 9 1871 3577 3086 +6878 2 2 12 9 362 3361 3199 +6879 2 2 12 9 1087 3570 2895 +6880 2 2 12 9 437 3422 3591 +6881 2 2 12 9 1166 3613 2824 +6882 2 2 12 9 1107 3160 3410 +6883 2 2 12 9 1719 3424 3120 +6884 2 2 12 9 1324 3335 3233 +6885 2 2 12 9 1325 3234 3336 +6886 2 2 12 9 1450 3092 3452 +6887 2 2 12 9 485 3416 3485 +6888 2 2 12 9 462 3217 3281 +6889 2 2 12 9 1259 3457 2955 +6890 2 2 12 9 1264 3439 3135 +6891 2 2 12 9 2047 3541 3212 +6892 2 2 12 9 2048 3213 3542 +6893 2 2 12 9 865 3250 3380 +6894 2 2 12 9 587 3233 3335 +6895 2 2 12 9 588 3336 3234 +6896 2 2 12 9 1591 3380 3250 +6897 2 2 12 9 348 3531 2910 +6898 2 2 12 9 581 3644 2816 +6899 2 2 12 9 582 2817 3645 +6900 2 2 12 9 1181 3086 3577 +6901 2 2 12 9 403 3212 3541 +6902 2 2 12 9 404 3542 3213 +6903 2 2 12 9 1159 3534 2981 +6904 2 2 12 9 1160 2982 3535 +6905 2 2 12 9 621 3285 3513 +6906 2 2 12 9 1426 3396 3247 +6907 2 2 12 9 1464 3564 3101 +6908 2 2 12 9 1409 3485 3416 +6909 2 2 12 9 1570 3635 2998 +6910 2 2 12 9 1413 3101 3564 +6911 2 2 12 9 1434 3179 3594 +6912 2 2 12 9 1169 3449 3401 +6913 2 2 12 9 943 3377 3493 +6914 2 2 12 9 944 3494 3378 +6915 2 2 12 9 1334 3513 3285 +6916 2 2 12 9 1667 3493 3377 +6917 2 2 12 9 1668 3378 3494 +6918 2 2 12 9 1229 3620 3139 +6919 2 2 12 9 1230 3140 3621 +6920 2 2 12 9 1577 3401 3449 +6921 2 2 12 9 1129 3594 3179 +6922 2 2 12 9 561 3617 3221 +6923 2 2 12 9 1191 3563 3322 +6924 2 2 12 9 1463 3313 3617 +6925 2 2 12 9 1340 3547 3552 +6926 2 2 12 9 1186 3216 3629 +6927 2 2 12 9 1240 3423 3520 +6928 2 2 12 9 1479 3520 3423 +6929 2 2 12 9 1313 3508 3561 +6930 2 2 12 9 1314 3562 3509 +6931 2 2 12 9 243 3602 3610 +6932 2 2 12 9 333 3611 3603 +6933 2 2 12 9 1400 3552 3547 +6934 2 2 12 9 1334 3581 3513 +6935 2 2 12 9 1443 3561 3508 +6936 2 2 12 9 1444 3509 3562 +6937 2 2 12 9 1397 3513 3581 +6938 2 2 12 9 1435 3610 3602 +6939 2 2 12 9 1436 3603 3611 +6940 2 2 13 11 6754 3899 4643 +6941 2 2 13 11 6325 3789 4827 +6942 2 2 13 11 6326 4828 3790 +6943 2 2 13 11 4769 3899 6754 +6944 2 2 13 11 4741 6325 4827 +6945 2 2 13 11 4742 4828 6326 +6946 2 2 13 11 4469 4994 5539 +6947 2 2 13 11 6465 4881 4039 +6948 2 2 13 11 5539 4994 3847 +6949 2 2 13 11 6217 4855 5027 +6950 2 2 13 11 6218 5028 4856 +6951 2 2 13 11 5066 5829 3774 +6952 2 2 13 11 6107 4090 4935 +6953 2 2 13 11 4698 4881 6465 +6954 2 2 13 11 6025 5002 3650 +6955 2 2 13 11 4782 5101 6705 +6956 2 2 13 11 3999 4855 6217 +6957 2 2 13 11 4000 6218 4856 +6958 2 2 13 11 5089 3840 5587 +6959 2 2 13 11 4594 6501 5305 +6960 2 2 13 11 4543 5002 6025 +6961 2 2 13 11 5829 4873 3774 +6962 2 2 13 11 6693 4148 4831 +6963 2 2 13 11 6209 4103 4940 +6964 2 2 13 11 4634 6107 4935 +6965 2 2 13 11 4128 4771 6903 +6966 2 2 13 11 4129 6904 4772 +6967 2 2 13 11 4808 6693 4831 +6968 2 2 13 11 6947 4762 3701 +6969 2 2 13 11 5465 4068 6859 +6970 2 2 13 11 6903 4771 4868 +6971 2 2 13 11 6904 4869 4772 +6972 2 2 13 11 4657 6209 4940 +6973 2 2 13 11 6802 4888 4687 +6974 2 2 13 11 4846 6947 3701 +6975 2 2 13 11 4501 5089 5587 +6976 2 2 13 11 4790 4852 6823 +6977 2 2 13 11 3922 6802 4687 +6978 2 2 13 11 4622 4878 6342 +6979 2 2 13 11 5715 5071 4131 +6980 2 2 13 11 5101 3909 6705 +6981 2 2 13 11 6510 5331 3754 +6982 2 2 13 11 6485 4632 5117 +6983 2 2 13 11 4544 6032 4923 +6984 2 2 13 11 6001 4111 4423 +6985 2 2 13 11 6032 3669 4923 +6986 2 2 13 11 5267 3994 5848 +6987 2 2 13 11 6241 4995 3739 +6988 2 2 13 11 6342 4878 3923 +6989 2 2 13 11 6155 4943 4158 +6990 2 2 13 11 4111 5268 4423 +6991 2 2 13 11 5953 4033 4868 +6992 2 2 13 11 5954 4869 4034 +6993 2 2 13 11 4575 5071 5715 +6994 2 2 13 11 6823 4852 4009 +6995 2 2 13 11 6501 3938 5305 +6996 2 2 13 11 4530 5201 6238 +6997 2 2 13 11 3921 4632 6485 +6998 2 2 13 11 5848 3994 4945 +6999 2 2 13 11 5165 6180 4243 +7000 2 2 13 11 6691 4019 4470 +7001 2 2 13 11 315 6049 5157 +7002 2 2 13 11 261 5158 6050 +7003 2 2 13 11 6468 3765 5203 +7004 2 2 13 11 6469 5204 3766 +7005 2 2 13 11 4070 5509 4441 +7006 2 2 13 11 4071 4442 5510 +7007 2 2 13 11 5084 5261 6311 +7008 2 2 13 11 4340 6037 5313 +7009 2 2 13 11 4341 5316 6038 +7010 2 2 13 11 3985 4928 4512 +7011 2 2 13 11 3656 4757 5637 +7012 2 2 13 11 6422 4895 3924 +7013 2 2 13 11 6423 3925 4896 +7014 2 2 13 11 3950 4659 4873 +7015 2 2 13 11 3761 4930 4531 +7016 2 2 13 11 3963 5312 4520 +7017 2 2 13 11 4737 4899 6322 +7018 2 2 13 11 5086 4033 5953 +7019 2 2 13 11 5087 5954 4034 +7020 2 2 13 11 6648 5815 4389 +7021 2 2 13 11 6649 4390 5816 +7022 2 2 13 11 3950 4656 5617 +7023 2 2 13 11 4098 5279 5591 +7024 2 2 13 11 4097 4920 5590 +7025 2 2 13 11 4098 5591 4921 +7026 2 2 13 11 4222 5067 5335 +7027 2 2 13 11 4097 5590 5304 +7028 2 2 13 11 3985 4512 4954 +7029 2 2 13 11 3967 5176 4976 +7030 2 2 13 11 4647 4895 6422 +7031 2 2 13 11 4648 6423 4896 +7032 2 2 13 11 3915 4582 5743 +7033 2 2 13 11 3756 6419 4509 +7034 2 2 13 11 4424 4678 6276 +7035 2 2 13 11 289 4712 290 +7036 2 2 13 11 4086 4443 5454 +7037 2 2 13 11 5769 6275 3972 +7038 2 2 13 11 4716 4995 6241 +7039 2 2 13 11 291 4793 292 +7040 2 2 13 11 4164 4968 5034 +7041 2 2 13 11 3781 4881 4698 +7042 2 2 13 11 275 4721 276 +7043 2 2 13 11 4130 6744 4562 +7044 2 2 13 11 4612 4943 6155 +7045 2 2 13 11 4070 4441 6303 +7046 2 2 13 11 3950 5617 4659 +7047 2 2 13 11 4071 6304 4442 +7048 2 2 13 11 6275 4836 3972 +7049 2 2 13 11 6859 4068 4540 +7050 2 2 13 11 4601 6180 5165 +7051 2 2 13 11 277 4797 278 +7052 2 2 13 11 4345 5248 5249 +7053 2 2 13 11 3984 4571 4894 +7054 2 2 13 11 4035 4858 4596 +7055 2 2 13 11 3785 5041 4925 +7056 2 2 13 11 4413 5280 6033 +7057 2 2 13 11 3742 5004 4496 +7058 2 2 13 11 3734 4594 5305 +7059 2 2 13 11 3975 4764 4635 +7060 2 2 13 11 4027 6536 4519 +7061 2 2 13 11 3998 4551 5107 +7062 2 2 13 11 110 4993 6581 +7063 2 2 13 11 4937 5571 5961 +7064 2 2 13 11 4689 5331 6510 +7065 2 2 13 11 4152 4890 4662 +7066 2 2 13 11 4068 5269 4540 +7067 2 2 13 11 4004 4571 6293 +7068 2 2 13 11 4100 4463 6797 +7069 2 2 13 11 4470 4019 5379 +7070 2 2 13 11 4019 4737 6322 +7071 2 2 13 11 4014 4994 5795 +7072 2 2 13 11 3902 4663 5102 +7073 2 2 13 11 3903 5103 4664 +7074 2 2 13 11 3984 5765 4571 +7075 2 2 13 11 3712 4540 5269 +7076 2 2 13 11 3882 4581 6736 +7077 2 2 13 11 3999 5160 4475 +7078 2 2 13 11 4000 4476 5161 +7079 2 2 13 11 3934 4731 4703 +7080 2 2 13 11 3935 4704 4732 +7081 2 2 13 11 4483 5917 5728 +7082 2 2 13 11 3762 4855 4618 +7083 2 2 13 11 3763 4619 4856 +7084 2 2 13 11 4977 5593 6130 +7085 2 2 13 11 3853 4681 5303 +7086 2 2 13 11 318 4627 319 +7087 2 2 13 11 257 4628 258 +7088 2 2 13 11 4163 6139 4591 +7089 2 2 13 11 4111 5025 4774 +7090 2 2 13 11 4270 4590 6146 +7091 2 2 13 11 3995 4634 5301 +7092 2 2 13 11 3939 5307 4620 +7093 2 2 13 11 3917 4596 6702 +7094 2 2 13 11 3878 5495 4485 +7095 2 2 13 11 3803 4780 5655 +7096 2 2 13 11 3851 5115 4496 +7097 2 2 13 11 3926 5228 6126 +7098 2 2 13 11 3916 4882 4661 +7099 2 2 13 11 4086 5618 4443 +7100 2 2 13 11 3661 5477 4584 +7101 2 2 13 11 5074 6545 5843 +7102 2 2 13 11 4596 4858 6702 +7103 2 2 13 11 4280 4965 6074 +7104 2 2 13 11 4281 6075 4966 +7105 2 2 13 11 5201 3910 6238 +7106 2 2 13 11 3868 5513 4883 +7107 2 2 13 11 4092 4682 4891 +7108 2 2 13 11 4201 4801 4803 +7109 2 2 13 11 3998 5749 4551 +7110 2 2 13 11 113 114 4616 +7111 2 2 13 11 4259 5402 4941 +7112 2 2 13 11 4629 6468 5203 +7113 2 2 13 11 4630 5204 6469 +7114 2 2 13 11 4175 4595 5303 +7115 2 2 13 11 4044 5006 5205 +7116 2 2 13 11 4045 5206 5007 +7117 2 2 13 11 4773 6806 5397 +7118 2 2 13 11 3948 4746 4877 +7119 2 2 13 11 4515 6581 4993 +7120 2 2 13 11 5257 6534 5832 +7121 2 2 13 11 5258 5833 6535 +7122 2 2 13 11 4374 5257 5832 +7123 2 2 13 11 4375 5833 5258 +7124 2 2 13 11 5929 4472 3862 +7125 2 2 13 11 3875 5062 4457 +7126 2 2 13 11 4065 5092 5433 +7127 2 2 13 11 4094 4490 5571 +7128 2 2 13 11 4183 5237 5181 +7129 2 2 13 11 4244 5281 4640 +7130 2 2 13 11 3851 4496 5309 +7131 2 2 13 11 4958 6837 6185 +7132 2 2 13 11 3777 5034 4968 +7133 2 2 13 11 4130 4870 6744 +7134 2 2 13 11 4151 5261 5084 +7135 2 2 13 11 3822 5249 5248 +7136 2 2 13 11 3986 5060 4549 +7137 2 2 13 11 4004 6293 4617 +7138 2 2 13 11 4028 5049 4479 +7139 2 2 13 11 3926 6610 5228 +7140 2 2 13 11 3651 4576 5899 +7141 2 2 13 11 3815 4550 5147 +7142 2 2 13 11 292 4793 6245 +7143 2 2 13 11 4083 4865 5064 +7144 2 2 13 11 3976 5020 5580 +7145 2 2 13 11 3977 5581 5021 +7146 2 2 13 11 3848 4498 5519 +7147 2 2 13 11 3803 5655 6002 +7148 2 2 13 11 4280 6156 4965 +7149 2 2 13 11 4281 4966 6157 +7150 2 2 13 11 3823 5107 4551 +7151 2 2 13 11 278 4797 6269 +7152 2 2 13 11 3789 4813 4827 +7153 2 2 13 11 3790 4828 4814 +7154 2 2 13 11 5010 5719 6386 +7155 2 2 13 11 4410 5517 6123 +7156 2 2 13 11 5720 5011 6387 +7157 2 2 13 11 4130 4562 6189 +7158 2 2 13 11 3860 5071 5751 +7159 2 2 13 11 4813 5712 6914 +7160 2 2 13 11 4814 6915 5713 +7161 2 2 13 11 4191 5642 5289 +7162 2 2 13 11 3941 5366 4974 +7163 2 2 13 11 3942 4975 5367 +7164 2 2 13 11 4014 5795 4992 +7165 2 2 13 11 3849 4464 5599 +7166 2 2 13 11 4701 6887 5702 +7167 2 2 13 11 3674 4636 5895 +7168 2 2 13 11 3811 4941 5402 +7169 2 2 13 11 117 5926 4541 +7170 2 2 13 11 4140 6817 4746 +7171 2 2 13 11 4099 6880 4486 +7172 2 2 13 11 3676 5050 5172 +7173 2 2 13 11 3906 5381 4803 +7174 2 2 13 11 4163 4525 5774 +7175 2 2 13 11 3733 4745 4774 +7176 2 2 13 11 3710 6509 5164 +7177 2 2 13 11 4677 6758 5128 +7178 2 2 13 11 4044 5205 4860 +7179 2 2 13 11 4045 4861 5206 +7180 2 2 13 11 3767 4557 6607 +7181 2 2 13 11 3916 4550 4882 +7182 2 2 13 11 3848 6276 4678 +7183 2 2 13 11 4719 5889 5666 +7184 2 2 13 11 3869 4514 5134 +7185 2 2 13 11 6758 3755 5128 +7186 2 2 13 11 3874 4538 4969 +7187 2 2 13 11 3876 4970 4539 +7188 2 2 13 11 6890 4706 6302 +7189 2 2 13 11 3665 4958 6185 +7190 2 2 13 11 6265 4159 4955 +7191 2 2 13 11 4472 5775 3862 +7192 2 2 13 11 4032 5447 4929 +7193 2 2 13 11 3753 5593 4977 +7194 2 2 13 11 6837 4514 6185 +7195 2 2 13 11 4151 4587 5427 +7196 2 2 13 11 3733 4800 4839 +7197 2 2 13 11 4105 6624 4641 +7198 2 2 13 11 3708 4513 5399 +7199 2 2 13 11 4102 4591 5516 +7200 2 2 13 11 4727 6385 5232 +7201 2 2 13 11 4175 5303 4681 +7202 2 2 13 11 4060 4526 5245 +7203 2 2 13 11 4169 5514 4602 +7204 2 2 13 11 4005 4904 4691 +7205 2 2 13 11 4170 4603 5515 +7206 2 2 13 11 4031 4839 4800 +7207 2 2 13 11 4525 4641 6624 +7208 2 2 13 11 4691 4904 6883 +7209 2 2 13 11 3915 5743 4697 +7210 2 2 13 11 3746 4510 6591 +7211 2 2 13 11 3747 6592 4511 +7212 2 2 13 11 4385 5532 5212 +7213 2 2 13 11 4386 5213 5533 +7214 2 2 13 11 3702 5660 4681 +7215 2 2 13 11 4006 4774 4745 +7216 2 2 13 11 3723 6175 5702 +7217 2 2 13 11 3849 6698 4464 +7218 2 2 13 11 5352 5815 6648 +7219 2 2 13 11 5353 6649 5816 +7220 2 2 13 11 3656 5637 5840 +7221 2 2 13 11 4708 5774 5656 +7222 2 2 13 11 3987 4621 5065 +7223 2 2 13 11 4480 5751 5071 +7224 2 2 13 11 4746 6817 4877 +7225 2 2 13 11 4206 4873 4659 +7226 2 2 13 11 4163 4708 6139 +7227 2 2 13 11 3694 4891 4682 +7228 2 2 13 11 156 5486 5441 +7229 2 2 13 11 65 5442 5487 +7230 2 2 13 11 3882 6736 4823 +7231 2 2 13 11 5278 4864 6513 +7232 2 2 13 11 4383 5433 5092 +7233 2 2 13 11 4005 4564 6378 +7234 2 2 13 11 6923 3873 5887 +7235 2 2 13 11 3991 6529 4653 +7236 2 2 13 11 4028 4479 5560 +7237 2 2 13 11 3979 5796 4669 +7238 2 2 13 11 6934 5149 3908 +7239 2 2 13 11 4515 6528 5604 +7240 2 2 13 11 3848 5351 4498 +7241 2 2 13 11 4094 5202 4490 +7242 2 2 13 11 4060 6266 4526 +7243 2 2 13 11 4002 5034 5985 +7244 2 2 13 11 3857 5939 4465 +7245 2 2 13 11 3858 4466 5940 +7246 2 2 13 11 3945 4568 6013 +7247 2 2 13 11 4340 5313 6288 +7248 2 2 13 11 4341 6289 5316 +7249 2 2 13 11 4176 4925 5041 +7250 2 2 13 11 4054 4509 4996 +7251 2 2 13 11 4224 4563 6032 +7252 2 2 13 11 4050 4827 4813 +7253 2 2 13 11 4051 4814 4828 +7254 2 2 13 11 4091 5391 4999 +7255 2 2 13 11 3737 4771 5612 +7256 2 2 13 11 3738 5613 4772 +7257 2 2 13 11 4201 4803 5381 +7258 2 2 13 11 3988 6441 4613 +7259 2 2 13 11 3991 4636 6529 +7260 2 2 13 11 3901 4762 5902 +7261 2 2 13 11 3708 5504 4513 +7262 2 2 13 11 3874 5238 4538 +7263 2 2 13 11 3876 4539 5239 +7264 2 2 13 11 3749 4803 4801 +7265 2 2 13 11 3867 5728 5917 +7266 2 2 13 11 3757 4662 4890 +7267 2 2 13 11 3714 4592 5341 +7268 2 2 13 11 3715 5342 4593 +7269 2 2 13 11 3917 6233 4733 +7270 2 2 13 11 3851 5946 5115 +7271 2 2 13 11 4325 4883 5513 +7272 2 2 13 11 3955 5565 6000 +7273 2 2 13 11 4976 5176 6208 +7274 2 2 13 11 3719 5212 5532 +7275 2 2 13 11 3720 5533 5213 +7276 2 2 13 11 3857 4465 5566 +7277 2 2 13 11 3858 5567 4466 +7278 2 2 13 11 4012 5033 5002 +7279 2 2 13 11 4602 5514 6391 +7280 2 2 13 11 4603 6392 5515 +7281 2 2 13 11 3823 4551 5358 +7282 2 2 13 11 3983 4886 4677 +7283 2 2 13 11 4615 6265 4955 +7284 2 2 13 11 3668 4549 5060 +7285 2 2 13 11 3706 5057 4524 +7286 2 2 13 11 4032 5792 6330 +7287 2 2 13 11 4530 5985 5034 +7288 2 2 13 11 3673 5571 5560 +7289 2 2 13 11 3853 4470 5379 +7290 2 2 13 11 6341 5012 3744 +7291 2 2 13 11 6343 3745 5013 +7292 2 2 13 11 3668 6229 4495 +7293 2 2 13 11 4359 5340 5419 +7294 2 2 13 11 3688 5831 6366 +7295 2 2 13 11 3945 6778 4568 +7296 2 2 13 11 4033 5719 5010 +7297 2 2 13 11 4034 5011 5720 +7298 2 2 13 11 4236 4937 5961 +7299 2 2 13 11 4404 5843 6545 +7300 2 2 13 11 3768 5774 4525 +7301 2 2 13 11 4196 5838 5395 +7302 2 2 13 11 4314 4974 5366 +7303 2 2 13 11 4315 5367 4975 +7304 2 2 13 11 4311 5520 5671 +7305 2 2 13 11 4183 5181 4676 +7306 2 2 13 11 4413 6280 5280 +7307 2 2 13 11 3709 4529 5061 +7308 2 2 13 11 4168 4584 5477 +7309 2 2 13 11 4102 4760 5196 +7310 2 2 13 11 3943 5038 4561 +7311 2 2 13 11 4090 5362 4600 +7312 2 2 13 11 4864 4309 6513 +7313 2 2 13 11 4236 4995 4716 +7314 2 2 13 11 4075 4988 4718 +7315 2 2 13 11 4678 6158 5014 +7316 2 2 13 11 3930 4516 5150 +7317 2 2 13 11 4070 4884 4938 +7318 2 2 13 11 4071 4939 4885 +7319 2 2 13 11 3717 6201 4646 +7320 2 2 13 11 3746 4938 4884 +7321 2 2 13 11 4372 4733 6355 +7322 2 2 13 11 3747 4885 4939 +7323 2 2 13 11 3750 4964 4824 +7324 2 2 13 11 3739 4995 4886 +7325 2 2 13 11 3875 4457 5638 +7326 2 2 13 11 4003 4706 6890 +7327 2 2 13 11 6914 5712 3964 +7328 2 2 13 11 6915 3965 5713 +7329 2 2 13 11 4073 4824 4964 +7330 2 2 13 11 3975 4599 6120 +7331 2 2 13 11 6883 4904 3958 +7332 2 2 13 11 4623 5580 6631 +7333 2 2 13 11 4624 6632 5581 +7334 2 2 13 11 4307 5580 5020 +7335 2 2 13 11 4308 5021 5581 +7336 2 2 13 11 6778 5368 4568 +7337 2 2 13 11 4278 4631 6093 +7338 2 2 13 11 4244 5678 5281 +7339 2 2 13 11 4610 6408 5395 +7340 2 2 13 11 303 5378 6220 +7341 2 2 13 11 3884 5970 4547 +7342 2 2 13 11 3885 4548 5971 +7343 2 2 13 11 3788 5064 4865 +7344 2 2 13 11 3676 5172 4686 +7345 2 2 13 11 3815 6040 4550 +7346 2 2 13 11 4451 4733 6233 +7347 2 2 13 11 4032 6330 4944 +7348 2 2 13 11 114 5394 4616 +7349 2 2 13 11 3951 5037 5569 +7350 2 2 13 11 4027 4519 5066 +7351 2 2 13 11 3746 6030 4510 +7352 2 2 13 11 3747 4511 6031 +7353 2 2 13 11 4610 5337 6355 +7354 2 2 13 11 3698 5335 5067 +7355 2 2 13 11 6435 4815 4006 +7356 2 2 13 11 4149 5002 5033 +7357 2 2 13 11 3999 4475 5675 +7358 2 2 13 11 4000 5676 4476 +7359 2 2 13 11 3735 4931 6314 +7360 2 2 13 11 3917 6473 4596 +7361 2 2 13 11 5337 4372 6355 +7362 2 2 13 11 4771 6070 5612 +7363 2 2 13 11 4772 5613 6071 +7364 2 2 13 11 4214 5605 4534 +7365 2 2 13 11 4525 6681 4641 +7366 2 2 13 11 4410 6555 5517 +7367 2 2 13 11 4023 6043 5905 +7368 2 2 13 11 4438 5697 5317 +7369 2 2 13 11 4439 5318 5698 +7370 2 2 13 11 3669 4561 5936 +7371 2 2 13 11 4023 5905 4936 +7372 2 2 13 11 3993 5074 5843 +7373 2 2 13 11 5914 5293 3682 +7374 2 2 13 11 117 4541 5287 +7375 2 2 13 11 5916 3683 5294 +7376 2 2 13 11 5115 5946 6684 +7377 2 2 13 11 3897 4522 5072 +7378 2 2 13 11 3898 5073 4523 +7379 2 2 13 11 309 5231 5700 +7380 2 2 13 11 4149 4980 5345 +7381 2 2 13 11 3975 4635 5127 +7382 2 2 13 11 4151 6309 4587 +7383 2 2 13 11 3675 4713 5222 +7384 2 2 13 11 3959 4710 5383 +7385 2 2 13 11 4207 5224 5015 +7386 2 2 13 11 4208 5016 5226 +7387 2 2 13 11 4126 5080 5162 +7388 2 2 13 11 4311 4999 5391 +7389 2 2 13 11 3757 5311 5024 +7390 2 2 13 11 3904 5578 4711 +7391 2 2 13 11 3816 4623 6631 +7392 2 2 13 11 3817 6632 4624 +7393 2 2 13 11 4100 5451 4463 +7394 2 2 13 11 4252 4841 6279 +7395 2 2 13 11 4490 5560 5571 +7396 2 2 13 11 4313 6254 4638 +7397 2 2 13 11 4046 5096 6811 +7398 2 2 13 11 3672 6446 5392 +7399 2 2 13 11 3821 5419 5340 +7400 2 2 13 11 3744 5012 4577 +7401 2 2 13 11 3745 4578 5013 +7402 2 2 13 11 3735 6314 5820 +7403 2 2 13 11 4007 4557 5880 +7404 2 2 13 11 3786 5177 6290 +7405 2 2 13 11 3787 6291 5178 +7406 2 2 13 11 4163 6235 4525 +7407 2 2 13 11 4636 5233 5895 +7408 2 2 13 11 3853 5303 4470 +7409 2 2 13 11 4027 4840 6536 +7410 2 2 13 11 3755 4715 5128 +7411 2 2 13 11 4047 6812 5099 +7412 2 2 13 11 3664 5448 5297 +7413 2 2 13 11 4001 5014 6158 +7414 2 2 13 11 3934 4978 5615 +7415 2 2 13 11 3935 5616 4979 +7416 2 2 13 11 3930 5164 4516 +7417 2 2 13 11 6385 4319 5232 +7418 2 2 13 11 3989 4585 5494 +7419 2 2 13 11 4762 6947 5902 +7420 2 2 13 11 3927 4714 6932 +7421 2 2 13 11 4566 5293 5914 +7422 2 2 13 11 4567 5916 5294 +7423 2 2 13 11 3756 4509 5253 +7424 2 2 13 11 3987 5004 4621 +7425 2 2 13 11 4180 4708 5656 +7426 2 2 13 11 4089 5399 4513 +7427 2 2 13 11 4382 4688 5194 +7428 2 2 13 11 3992 5047 6870 +7429 2 2 13 11 4318 4632 6117 +7430 2 2 13 11 4590 5403 6146 +7431 2 2 13 11 4733 6516 6355 +7432 2 2 13 11 3868 4883 5606 +7433 2 2 13 11 4663 5012 6341 +7434 2 2 13 11 4664 6343 5013 +7435 2 2 13 11 3959 5383 6138 +7436 2 2 13 11 3944 6072 6727 +7437 2 2 13 11 3888 4986 5481 +7438 2 2 13 11 4435 6067 4848 +7439 2 2 13 11 3865 4574 5884 +7440 2 2 13 11 4537 5702 6175 +7441 2 2 13 11 5016 6397 6151 +7442 2 2 13 11 4379 4776 5887 +7443 2 2 13 11 4032 4944 5447 +7444 2 2 13 11 4516 5164 6509 +7445 2 2 13 11 4187 4590 5873 +7446 2 2 13 11 3998 4657 5749 +7447 2 2 13 11 4526 131 5596 +7448 2 2 13 11 6887 3723 5702 +7449 2 2 13 11 4005 6378 4654 +7450 2 2 13 11 3802 5498 4963 +7451 2 2 13 11 4084 5015 5224 +7452 2 2 13 11 4085 5226 5016 +7453 2 2 13 11 3736 5627 4655 +7454 2 2 13 11 4728 6870 5047 +7455 2 2 13 11 289 5362 4712 +7456 2 2 13 11 3671 5422 6190 +7457 2 2 13 11 3708 5399 5117 +7458 2 2 13 11 3891 5674 4671 +7459 2 2 13 11 4406 5439 5324 +7460 2 2 13 11 3960 4592 5035 +7461 2 2 13 11 3961 5036 4593 +7462 2 2 13 11 3848 4678 5014 +7463 2 2 13 11 5397 6806 4008 +7464 2 2 13 11 4125 4518 5310 +7465 2 2 13 11 4048 4741 4827 +7466 2 2 13 11 4049 4828 4742 +7467 2 2 13 11 3678 4924 5273 +7468 2 2 13 11 3760 4503 6432 +7469 2 2 13 11 273 6147 5156 +7470 2 2 13 11 4144 4532 5215 +7471 2 2 13 11 4145 5216 4533 +7472 2 2 13 11 4065 5433 4531 +7473 2 2 13 11 4110 4902 5096 +7474 2 2 13 11 3863 5682 5173 +7475 2 2 13 11 3864 5174 5683 +7476 2 2 13 11 107 108 4702 +7477 2 2 13 11 3775 4667 5132 +7478 2 2 13 11 3776 5133 4668 +7479 2 2 13 11 4053 4852 4790 +7480 2 2 13 11 3706 4524 5598 +7481 2 2 13 11 3878 4485 5763 +7482 2 2 13 11 3749 5501 4611 +7483 2 2 13 11 4224 5724 4563 +7484 2 2 13 11 4457 5297 5448 +7485 2 2 13 11 4052 5623 4500 +7486 2 2 13 11 3870 6093 4631 +7487 2 2 13 11 4212 5845 5661 +7488 2 2 13 11 4401 5569 5037 +7489 2 2 13 11 4127 4646 4915 +7490 2 2 13 11 3834 5324 5439 +7491 2 2 13 11 3984 6067 5765 +7492 2 2 13 11 4552 6168 5398 +7493 2 2 13 11 4611 5501 5681 +7494 2 2 13 11 4278 5523 4631 +7495 2 2 13 11 3976 4747 5020 +7496 2 2 13 11 3977 5021 4748 +7497 2 2 13 11 3988 6888 6441 +7498 2 2 13 11 83 5667 5094 +7499 2 2 13 11 3911 4805 5527 +7500 2 2 13 11 3912 5528 4806 +7501 2 2 13 11 3830 5317 5697 +7502 2 2 13 11 3831 5698 5318 +7503 2 2 13 11 4092 5358 4551 +7504 2 2 13 11 4024 4899 4737 +7505 2 2 13 11 4144 6766 4532 +7506 2 2 13 11 4145 4533 6767 +7507 2 2 13 11 4212 5661 5041 +7508 2 2 13 11 3860 5751 4940 +7509 2 2 13 11 4112 5099 4905 +7510 2 2 13 11 6408 4426 5395 +7511 2 2 13 11 4149 5345 5733 +7512 2 2 13 11 3869 5134 4558 +7513 2 2 13 11 4832 5149 6934 +7514 2 2 13 11 3744 4577 6062 +7515 2 2 13 11 3745 6064 4578 +7516 2 2 13 11 4515 5604 6581 +7517 2 2 13 11 4118 4616 5394 +7518 2 2 13 11 4041 4990 6459 +7519 2 2 13 11 4042 6460 4991 +7520 2 2 13 11 154 155 4695 +7521 2 2 13 11 66 67 4696 +7522 2 2 13 11 4998 5834 6247 +7523 2 2 13 11 4679 6575 5929 +7524 2 2 13 11 4081 5132 4527 +7525 2 2 13 11 5131 6435 4006 +7526 2 2 13 11 3784 4604 5875 +7527 2 2 13 11 4082 4528 5133 +7528 2 2 13 11 3767 6607 4852 +7529 2 2 13 11 3856 6640 5245 +7530 2 2 13 11 3670 5592 4761 +7531 2 2 13 11 3688 6366 5236 +7532 2 2 13 11 3944 6814 6072 +7533 2 2 13 11 4382 6395 4688 +7534 2 2 13 11 4826 6201 6228 +7535 2 2 13 11 3979 6765 5796 +7536 2 2 13 11 3975 6120 4764 +7537 2 2 13 11 4353 5615 4978 +7538 2 2 13 11 4354 4979 5616 +7539 2 2 13 11 302 5378 303 +7540 2 2 13 11 3756 4795 6419 +7541 2 2 13 11 3709 5892 4529 +7542 2 2 13 11 3852 5762 4935 +7543 2 2 13 11 4962 6310 5986 +7544 2 2 13 11 3668 5990 4549 +7545 2 2 13 11 4776 6923 5887 +7546 2 2 13 11 4488 5585 6386 +7547 2 2 13 11 4489 6387 5586 +7548 2 2 13 11 4147 5302 4626 +7549 2 2 13 11 4756 6811 5096 +7550 2 2 13 11 3995 5301 4947 +7551 2 2 13 11 3757 4890 5311 +7552 2 2 13 11 315 5157 316 +7553 2 2 13 11 260 5158 261 +7554 2 2 13 11 4065 4531 5991 +7555 2 2 13 11 3824 5785 6384 +7556 2 2 13 11 4175 4681 5660 +7557 2 2 13 11 3962 5108 4753 +7558 2 2 13 11 3907 4680 5575 +7559 2 2 13 11 4757 5099 6812 +7560 2 2 13 11 3666 5207 4572 +7561 2 2 13 11 4095 5431 5327 +7562 2 2 13 11 3667 4573 5208 +7563 2 2 13 11 4096 5328 5432 +7564 2 2 13 11 4099 4486 5508 +7565 2 2 13 11 3927 6932 4783 +7566 2 2 13 11 3880 4544 5494 +7567 2 2 13 11 4618 4855 6614 +7568 2 2 13 11 4619 6615 4856 +7569 2 2 13 11 4190 5666 5889 +7570 2 2 13 11 4568 5382 6013 +7571 2 2 13 11 4052 4500 5254 +7572 2 2 13 11 3799 5707 4622 +7573 2 2 13 11 3915 4697 4984 +7574 2 2 13 11 4521 5245 6640 +7575 2 2 13 11 3760 5065 4621 +7576 2 2 13 11 3750 4521 6443 +7577 2 2 13 11 4066 6583 4507 +7578 2 2 13 11 4067 4508 6584 +7579 2 2 13 11 4196 5125 5838 +7580 2 2 13 11 3698 4816 5335 +7581 2 2 13 11 3671 6843 5422 +7582 2 2 13 11 4069 4554 5385 +7583 2 2 13 11 3661 4584 6719 +7584 2 2 13 11 4246 5936 4561 +7585 2 2 13 11 3775 5132 5105 +7586 2 2 13 11 3776 5106 5133 +7587 2 2 13 11 3736 4655 4987 +7588 2 2 13 11 3734 5305 4900 +7589 2 2 13 11 3668 4495 5541 +7590 2 2 13 11 3841 4708 5546 +7591 2 2 13 11 4841 5026 6279 +7592 2 2 13 11 4208 6397 5016 +7593 2 2 13 11 4332 5481 4986 +7594 2 2 13 11 4629 5203 6634 +7595 2 2 13 11 4630 6635 5204 +7596 2 2 13 11 4941 5710 6270 +7597 2 2 13 11 3947 4862 5195 +7598 2 2 13 11 3964 5343 6914 +7599 2 2 13 11 3965 6915 5344 +7600 2 2 13 11 3948 4877 6659 +7601 2 2 13 11 4510 5173 5682 +7602 2 2 13 11 4511 5683 5174 +7603 2 2 13 11 3947 4651 5058 +7604 2 2 13 11 4132 5284 4957 +7605 2 2 13 11 5849 4041 6459 +7606 2 2 13 11 5850 6460 4042 +7607 2 2 13 11 4172 4711 5578 +7608 2 2 13 11 3897 5417 4522 +7609 2 2 13 11 3898 4523 5418 +7610 2 2 13 11 4312 4963 5498 +7611 2 2 13 11 4880 6629 6688 +7612 2 2 13 11 3746 4926 4874 +7613 2 2 13 11 3747 4875 4927 +7614 2 2 13 11 4112 4834 5775 +7615 2 2 13 11 4465 5157 6049 +7616 2 2 13 11 4466 6050 5158 +7617 2 2 13 11 3778 5614 4666 +7618 2 2 13 11 3928 6216 4613 +7619 2 2 13 11 4335 5117 5399 +7620 2 2 13 11 4213 5274 5064 +7621 2 2 13 11 4883 5957 5606 +7622 2 2 13 11 3674 6894 4636 +7623 2 2 13 11 4313 4638 6574 +7624 2 2 13 11 4311 4690 5520 +7625 2 2 13 11 3939 6112 5307 +7626 2 2 13 11 3963 4520 5732 +7627 2 2 13 11 6439 3757 5024 +7628 2 2 13 11 3675 4609 6471 +7629 2 2 13 11 3711 5938 5179 +7630 2 2 13 11 3649 4725 6633 +7631 2 2 13 11 4093 5181 5237 +7632 2 2 13 11 5185 6360 5924 +7633 2 2 13 11 4222 4604 5067 +7634 2 2 13 11 3984 4848 6067 +7635 2 2 13 11 3985 4880 4928 +7636 2 2 13 11 3816 6353 4623 +7637 2 2 13 11 3817 4624 6354 +7638 2 2 13 11 4455 4744 6501 +7639 2 2 13 11 3760 6428 4503 +7640 2 2 13 11 4054 5253 4509 +7641 2 2 13 11 4351 5257 5424 +7642 2 2 13 11 3672 5392 6279 +7643 2 2 13 11 4352 5425 5258 +7644 2 2 13 11 3928 6761 4764 +7645 2 2 13 11 4180 5546 4708 +7646 2 2 13 11 3742 4496 5549 +7647 2 2 13 11 4218 5527 4805 +7648 2 2 13 11 4219 4806 5528 +7649 2 2 13 11 3690 4876 4844 +7650 2 2 13 11 3712 5623 4540 +7651 2 2 13 11 3943 4561 5354 +7652 2 2 13 11 267 5701 5314 +7653 2 2 13 11 4026 5185 5924 +7654 2 2 13 11 4441 4784 6303 +7655 2 2 13 11 3702 4719 5666 +7656 2 2 13 11 4442 6304 4785 +7657 2 2 13 11 4222 5875 4604 +7658 2 2 13 11 4888 5867 6829 +7659 2 2 13 11 3824 6384 4821 +7660 2 2 13 11 3792 5113 4920 +7661 2 2 13 11 3793 4921 5114 +7662 2 2 13 11 3815 5867 4888 +7663 2 2 13 11 3651 5882 4576 +7664 2 2 13 11 3751 5427 4587 +7665 2 2 13 11 3666 4572 5557 +7666 2 2 13 11 3667 5558 4573 +7667 2 2 13 11 4140 4746 5470 +7668 2 2 13 11 4019 6033 4737 +7669 2 2 13 11 4487 6515 4913 +7670 2 2 13 11 139 140 5030 +7671 2 2 13 11 4672 5645 6503 +7672 2 2 13 11 6604 3884 4547 +7673 2 2 13 11 4673 6504 5646 +7674 2 2 13 11 6606 4548 3885 +7675 2 2 13 11 4066 4507 5557 +7676 2 2 13 11 4067 5558 4508 +7677 2 2 13 11 4040 4570 5491 +7678 2 2 13 11 4066 6634 5203 +7679 2 2 13 11 4067 5204 6635 +7680 2 2 13 11 3692 5873 4590 +7681 2 2 13 11 3764 4558 5941 +7682 2 2 13 11 3655 5096 4902 +7683 2 2 13 11 3970 5851 5104 +7684 2 2 13 11 4636 6894 5044 +7685 2 2 13 11 4418 4940 5751 +7686 2 2 13 11 4083 5064 5274 +7687 2 2 13 11 3650 6200 6322 +7688 2 2 13 11 4543 6073 5002 +7689 2 2 13 11 110 111 4993 +7690 2 2 13 11 4605 6345 5295 +7691 2 2 13 11 4606 5296 6346 +7692 2 2 13 11 3761 4531 5433 +7693 2 2 13 11 6266 131 4526 +7694 2 2 13 11 3865 6051 4574 +7695 2 2 13 11 4048 4827 4950 +7696 2 2 13 11 4049 4951 4828 +7697 2 2 13 11 142 143 4738 +7698 2 2 13 11 5440 5725 3687 +7699 2 2 13 11 3737 4868 4771 +7700 2 2 13 11 3738 4772 4869 +7701 2 2 13 11 4638 6254 6563 +7702 2 2 13 11 4065 4853 5092 +7703 2 2 13 11 3966 4808 4831 +7704 2 2 13 11 4214 4534 6153 +7705 2 2 13 11 4099 5349 6880 +7706 2 2 13 11 3767 5880 4557 +7707 2 2 13 11 3810 6033 5280 +7708 2 2 13 11 3693 5473 4944 +7709 2 2 13 11 6263 5236 5007 +7710 2 2 13 11 4077 5398 6168 +7711 2 2 13 11 3678 5273 4916 +7712 2 2 13 11 4013 5798 4693 +7713 2 2 13 11 3767 6692 6246 +7714 2 2 13 11 3734 4674 5881 +7715 2 2 13 11 4239 5793 4722 +7716 2 2 13 11 4240 4723 5794 +7717 2 2 13 11 4081 4527 6194 +7718 2 2 13 11 4082 6195 4528 +7719 2 2 13 11 4093 5237 4739 +7720 2 2 13 11 4189 4622 5707 +7721 2 2 13 11 4015 6133 5199 +7722 2 2 13 11 3936 4676 5491 +7723 2 2 13 11 4016 5200 6134 +7724 2 2 13 11 3760 4621 5138 +7725 2 2 13 11 4414 4935 5762 +7726 2 2 13 11 3908 4688 6395 +7727 2 2 13 11 4469 5244 5795 +7728 2 2 13 11 6575 4472 5929 +7729 2 2 13 11 3711 5250 5938 +7730 2 2 13 11 3669 6774 4561 +7731 2 2 13 11 3656 4905 5099 +7732 2 2 13 11 3750 5380 4521 +7733 2 2 13 11 3751 4587 6562 +7734 2 2 13 11 4591 6139 5516 +7735 2 2 13 11 3655 4756 5096 +7736 2 2 13 11 4081 4649 5105 +7737 2 2 13 11 4082 5106 4650 +7738 2 2 13 11 4595 6135 5303 +7739 2 2 13 11 3717 4646 5459 +7740 2 2 13 11 6325 5212 4256 +7741 2 2 13 11 6326 4257 5213 +7742 2 2 13 11 3964 5712 5992 +7743 2 2 13 11 3965 5993 5713 +7744 2 2 13 11 4100 6797 5350 +7745 2 2 13 11 3718 5315 6313 +7746 2 2 13 11 3844 4945 6022 +7747 2 2 13 11 4004 6142 4571 +7748 2 2 13 11 3656 5099 4757 +7749 2 2 13 11 3698 5912 4816 +7750 2 2 13 11 5926 119 5166 +7751 2 2 13 11 3754 4880 6688 +7752 2 2 13 11 3654 5322 4649 +7753 2 2 13 11 3653 4650 5323 +7754 2 2 13 11 4618 6614 6811 +7755 2 2 13 11 4619 6812 6615 +7756 2 2 13 11 5710 3909 6270 +7757 2 2 13 11 3716 6355 6516 +7758 2 2 13 11 3761 5641 4930 +7759 2 2 13 11 4491 6747 4845 +7760 2 2 13 11 5225 6171 6024 +7761 2 2 13 11 4484 6000 5565 +7762 2 2 13 11 3928 4764 6921 +7763 2 2 13 11 3975 6845 4599 +7764 2 2 13 11 3926 4739 5237 +7765 2 2 13 11 3665 5722 5721 +7766 2 2 13 11 82 83 5094 +7767 2 2 13 11 325 5168 5588 +7768 2 2 13 11 251 5589 5169 +7769 2 2 13 11 4500 5104 5851 +7770 2 2 13 11 5605 6718 4534 +7771 2 2 13 11 4015 5045 6133 +7772 2 2 13 11 4016 6134 5046 +7773 2 2 13 11 3749 4611 5507 +7774 2 2 13 11 4026 4562 5526 +7775 2 2 13 11 75 76 4744 +7776 2 2 13 11 5673 4273 6417 +7777 2 2 13 11 4711 6718 5605 +7778 2 2 13 11 4331 6201 4826 +7779 2 2 13 11 3774 4825 5911 +7780 2 2 13 11 3822 5248 4596 +7781 2 2 13 11 4125 5396 4518 +7782 2 2 13 11 4059 4798 5549 +7783 2 2 13 11 4015 5136 4672 +7784 2 2 13 11 4016 4673 5137 +7785 2 2 13 11 6405 4326 5128 +7786 2 2 13 11 4039 5892 4729 +7787 2 2 13 11 4479 5915 6286 +7788 2 2 13 11 3869 5770 4514 +7789 2 2 13 11 3662 6303 4784 +7790 2 2 13 11 3663 4785 6304 +7791 2 2 13 11 4142 5498 4675 +7792 2 2 13 11 3995 5620 4712 +7793 2 2 13 11 3938 6501 4744 +7794 2 2 13 11 6345 4020 5295 +7795 2 2 13 11 6346 5296 4021 +7796 2 2 13 11 3768 4525 6624 +7797 2 2 13 11 108 5604 4702 +7798 2 2 13 11 3915 6254 4582 +7799 2 2 13 11 3759 5632 4670 +7800 2 2 13 11 4293 6110 4863 +7801 2 2 13 11 4300 5441 5486 +7802 2 2 13 11 4301 5487 5442 +7803 2 2 13 11 3916 5197 4550 +7804 2 2 13 11 4690 6439 5024 +7805 2 2 13 11 4230 6263 5007 +7806 2 2 13 11 4015 4672 5045 +7807 2 2 13 11 4016 5046 4673 +7808 2 2 13 11 4138 5437 4703 +7809 2 2 13 11 4139 4704 5438 +7810 2 2 13 11 3902 5102 6255 +7811 2 2 13 11 3880 5679 4544 +7812 2 2 13 11 3903 6256 5103 +7813 2 2 13 11 3894 4616 5577 +7814 2 2 13 11 4057 4565 6267 +7815 2 2 13 11 4287 4835 5503 +7816 2 2 13 11 4189 5779 4622 +7817 2 2 13 11 3692 4590 5801 +7818 2 2 13 11 3794 5692 6231 +7819 2 2 13 11 4255 4944 5473 +7820 2 2 13 11 3960 5341 4592 +7821 2 2 13 11 3961 4593 5342 +7822 2 2 13 11 3998 5626 4721 +7823 2 2 13 11 4635 4764 6761 +7824 2 2 13 11 4210 5159 5081 +7825 2 2 13 11 4845 6747 6223 +7826 2 2 13 11 4040 5745 4570 +7827 2 2 13 11 3702 4681 5797 +7828 2 2 13 11 301 5525 302 +7829 2 2 13 11 3979 4669 6548 +7830 2 2 13 11 325 5588 326 +7831 2 2 13 11 250 5589 251 +7832 2 2 13 11 3962 4971 4765 +7833 2 2 13 11 4026 5573 4562 +7834 2 2 13 11 3684 5424 5257 +7835 2 2 13 11 3685 5258 5425 +7836 2 2 13 11 3847 4994 4773 +7837 2 2 13 11 3761 5839 5246 +7838 2 2 13 11 4863 6110 6377 +7839 2 2 13 11 4052 5254 4658 +7840 2 2 13 11 4113 5681 5501 +7841 2 2 13 11 3983 4677 5128 +7842 2 2 13 11 4543 6285 6073 +7843 2 2 13 11 275 5559 4721 +7844 2 2 13 11 3714 5862 4592 +7845 2 2 13 11 3715 4593 5863 +7846 2 2 13 11 4239 4722 5772 +7847 2 2 13 11 4240 5773 4723 +7848 2 2 13 11 4059 6374 4656 +7849 2 2 13 11 3785 5348 5041 +7850 2 2 13 11 3889 6391 5514 +7851 2 2 13 11 4114 4611 5152 +7852 2 2 13 11 3890 5515 6392 +7853 2 2 13 11 6158 5308 4235 +7854 2 2 13 11 3769 5675 4791 +7855 2 2 13 11 3770 4792 5676 +7856 2 2 13 11 3857 5566 4577 +7857 2 2 13 11 3858 4578 5567 +7858 2 2 13 11 4741 5212 6325 +7859 2 2 13 11 3724 6480 4683 +7860 2 2 13 11 4742 6326 5213 +7861 2 2 13 11 4186 4775 5260 +7862 2 2 13 11 3958 5306 4683 +7863 2 2 13 11 4052 4540 5623 +7864 2 2 13 11 3783 4651 6181 +7865 2 2 13 11 4488 6678 5585 +7866 2 2 13 11 4489 5586 6679 +7867 2 2 13 11 4035 4596 5248 +7868 2 2 13 11 6560 5066 3774 +7869 2 2 13 11 4689 6047 5331 +7870 2 2 13 11 4089 4513 5519 +7871 2 2 13 11 4576 6553 5899 +7872 2 2 13 11 4076 4981 4658 +7873 2 2 13 11 3953 4913 6515 +7874 2 2 13 11 4641 5725 5440 +7875 2 2 13 11 3906 6593 4666 +7876 2 2 13 11 4241 5027 5298 +7877 2 2 13 11 4242 5299 5028 +7878 2 2 13 11 3767 5049 6692 +7879 2 2 13 11 3752 5795 5244 +7880 2 2 13 11 3706 5059 5057 +7881 2 2 13 11 3730 5184 4665 +7882 2 2 13 11 3714 5772 4722 +7883 2 2 13 11 3715 4723 5773 +7884 2 2 13 11 3783 5703 4651 +7885 2 2 13 11 3822 4596 5406 +7886 2 2 13 11 3934 4703 5437 +7887 2 2 13 11 4005 5736 4564 +7888 2 2 13 11 3935 5438 4704 +7889 2 2 13 11 3891 5218 4644 +7890 2 2 13 11 3988 4613 6216 +7891 2 2 13 11 3915 6563 6254 +7892 2 2 13 11 308 5622 5231 +7893 2 2 13 11 3769 4817 5675 +7894 2 2 13 11 3770 5676 4818 +7895 2 2 13 11 4420 5721 5722 +7896 2 2 13 11 3836 5651 5102 +7897 2 2 13 11 3837 5103 5652 +7898 2 2 13 11 4131 5347 4767 +7899 2 2 13 11 5191 6039 6116 +7900 2 2 13 11 3665 5127 4635 +7901 2 2 13 11 4217 5389 5024 +7902 2 2 13 11 4001 5003 5014 +7903 2 2 13 11 3670 5095 5592 +7904 2 2 13 11 4156 5415 4751 +7905 2 2 13 11 4157 4752 5416 +7906 2 2 13 11 3933 6206 4646 +7907 2 2 13 11 3799 4622 5292 +7908 2 2 13 11 302 5525 5378 +7909 2 2 13 11 4632 6590 6117 +7910 2 2 13 11 4118 5577 4616 +7911 2 2 13 11 4144 4920 5113 +7912 2 2 13 11 4145 5114 4921 +7913 2 2 13 11 4288 5867 5147 +7914 2 2 13 11 3719 4751 5415 +7915 2 2 13 11 3720 5416 4752 +7916 2 2 13 11 4360 5022 5735 +7917 2 2 13 11 3697 5470 4746 +7918 2 2 13 11 4518 6161 5372 +7919 2 2 13 11 4077 5247 5398 +7920 2 2 13 11 4198 5695 4730 +7921 2 2 13 11 5275 6451 6197 +7922 2 2 13 11 3744 6062 6424 +7923 2 2 13 11 3745 6425 6064 +7924 2 2 13 11 3710 5164 5764 +7925 2 2 13 11 4013 4689 6510 +7926 2 2 13 11 4058 4876 5083 +7927 2 2 13 11 4715 6405 5128 +7928 2 2 13 11 4409 5986 6310 +7929 2 2 13 11 118 119 5926 +7930 2 2 13 11 3994 4725 5001 +7931 2 2 13 11 4749 6914 5343 +7932 2 2 13 11 4114 5507 4611 +7933 2 2 13 11 4750 5344 6915 +7934 2 2 13 11 4286 5076 5820 +7935 2 2 13 11 4050 6914 4749 +7936 2 2 13 11 4050 4950 4827 +7937 2 2 13 11 3734 5330 4594 +7938 2 2 13 11 4206 4659 5806 +7939 2 2 13 11 4051 4750 6915 +7940 2 2 13 11 4051 4828 4951 +7941 2 2 13 11 6693 5272 5093 +7942 2 2 13 11 4074 4928 4880 +7943 2 2 13 11 4058 4844 4876 +7944 2 2 13 11 4187 5403 4590 +7945 2 2 13 11 4407 5102 5651 +7946 2 2 13 11 4283 5327 5431 +7947 2 2 13 11 4408 5652 5103 +7948 2 2 13 11 4284 5432 5328 +7949 2 2 13 11 4147 4626 5699 +7950 2 2 13 11 4187 5873 4651 +7951 2 2 13 11 4134 6762 4565 +7952 2 2 13 11 3709 5061 5070 +7953 2 2 13 11 3846 5337 4610 +7954 2 2 13 11 4229 5006 5235 +7955 2 2 13 11 3902 4722 5793 +7956 2 2 13 11 3903 5794 4723 +7957 2 2 13 11 4069 5932 4554 +7958 2 2 13 11 4481 6261 4962 +7959 2 2 13 11 4232 5263 5210 +7960 2 2 13 11 3872 5868 4826 +7961 2 2 13 11 4233 5211 5264 +7962 2 2 13 11 3846 5260 5828 +7963 2 2 13 11 3686 5092 4853 +7964 2 2 13 11 3853 5345 4681 +7965 2 2 13 11 4153 5423 4765 +7966 2 2 13 11 4477 6022 4945 +7967 2 2 13 11 4043 6758 4677 +7968 2 2 13 11 3675 6471 4713 +7969 2 2 13 11 3994 5175 4945 +7970 2 2 13 11 3862 6162 5929 +7971 2 2 13 11 4036 4690 5024 +7972 2 2 13 11 124 125 4777 +7973 2 2 13 11 4492 6141 6364 +7974 2 2 13 11 273 5156 274 +7975 2 2 13 11 4104 5426 6123 +7976 2 2 13 11 3901 6938 4762 +7977 2 2 13 11 5095 6715 6213 +7978 2 2 13 11 4191 5153 5642 +7979 2 2 13 11 4081 5199 4649 +7980 2 2 13 11 4473 6659 4877 +7981 2 2 13 11 4032 4929 4964 +7982 2 2 13 11 4082 4650 5200 +7983 2 2 13 11 4112 5775 5357 +7984 2 2 13 11 4269 5116 5371 +7985 2 2 13 11 3838 5815 5352 +7986 2 2 13 11 3839 5353 5816 +7987 2 2 13 11 4127 4652 6348 +7988 2 2 13 11 3981 4767 5017 +7989 2 2 13 11 3765 4672 5136 +7990 2 2 13 11 3766 5137 4673 +7991 2 2 13 11 3818 5153 5118 +7992 2 2 13 11 3760 5138 4676 +7993 2 2 13 11 3794 6231 5224 +7994 2 2 13 11 4291 6247 5834 +7995 2 2 13 11 4154 5172 5050 +7996 2 2 13 11 115 116 4811 +7997 2 2 13 11 3958 4683 5082 +7998 2 2 13 11 5645 4037 6503 +7999 2 2 13 11 6504 4038 5646 +8000 2 2 13 11 3986 4549 6937 +8001 2 2 13 11 4002 4922 5540 +8002 2 2 13 11 4009 5095 6213 +8003 2 2 13 11 4582 5246 5839 +8004 2 2 13 11 4161 5173 4874 +8005 2 2 13 11 4162 4875 5174 +8006 2 2 13 11 4774 5025 5714 +8007 2 2 13 11 3746 6591 4938 +8008 2 2 13 11 3747 4939 6592 +8009 2 2 13 11 4747 6871 5909 +8010 2 2 13 11 4748 5910 6872 +8011 2 2 13 11 4123 4702 5604 +8012 2 2 13 11 4879 6724 6640 +8013 2 2 13 11 4149 5033 4980 +8014 2 2 13 11 4050 4813 6914 +8015 2 2 13 11 4051 6915 4814 +8016 2 2 13 11 4126 5162 4925 +8017 2 2 13 11 4006 4745 5022 +8018 2 2 13 11 3709 5070 6400 +8019 2 2 13 11 3786 6426 5177 +8020 2 2 13 11 3787 5178 6427 +8021 2 2 13 11 4010 5488 4900 +8022 2 2 13 11 6579 5270 4087 +8023 2 2 13 11 4002 5540 4989 +8024 2 2 13 11 80 81 4889 +8025 2 2 13 11 4270 6043 4590 +8026 2 2 13 11 318 5182 4627 +8027 2 2 13 11 258 4628 5183 +8028 2 2 13 11 4678 5308 6158 +8029 2 2 13 11 4187 4651 5703 +8030 2 2 13 11 3742 4798 6536 +8031 2 2 13 11 3845 4763 4997 +8032 2 2 13 11 4231 6084 4780 +8033 2 2 13 11 4058 5162 5080 +8034 2 2 13 11 4366 4797 5107 +8035 2 2 13 11 3995 4793 5620 +8036 2 2 13 11 4215 5188 4849 +8037 2 2 13 11 4216 4850 5189 +8038 2 2 13 11 3962 4765 5423 +8039 2 2 13 11 4107 5371 5116 +8040 2 2 13 11 4336 5828 5260 +8041 2 2 13 11 4055 4874 4926 +8042 2 2 13 11 4056 4927 4875 +8043 2 2 13 11 4057 5122 5911 +8044 2 2 13 11 4052 5324 4540 +8045 2 2 13 11 4707 6593 6824 +8046 2 2 13 11 4680 6713 5575 +8047 2 2 13 11 4258 5997 4738 +8048 2 2 13 11 4134 4565 6953 +8049 2 2 13 11 4040 5138 4621 +8050 2 2 13 11 3932 4789 5680 +8051 2 2 13 11 3998 4797 5626 +8052 2 2 13 11 4059 4656 6165 +8053 2 2 13 11 5122 6560 3774 +8054 2 2 13 11 4084 5180 4807 +8055 2 2 13 11 3661 5699 4626 +8056 2 2 13 11 3792 5639 5942 +8057 2 2 13 11 3793 5943 5640 +8058 2 2 13 11 3861 6497 4833 +8059 2 2 13 11 4004 5273 5075 +8060 2 2 13 11 161 162 4778 +8061 2 2 13 11 59 60 4779 +8062 2 2 13 11 3869 4558 6339 +8063 2 2 13 11 4105 5440 6053 +8064 2 2 13 11 3958 6809 5306 +8065 2 2 13 11 3784 6163 4604 +8066 2 2 13 11 4110 6152 4833 +8067 2 2 13 11 3846 4610 5395 +8068 2 2 13 11 4493 6313 5315 +8069 2 2 13 11 3697 4957 5284 +8070 2 2 13 11 4348 5398 5247 +8071 2 2 13 11 4013 6431 4689 +8072 2 2 13 11 4237 5909 6871 +8073 2 2 13 11 4238 6872 5910 +8074 2 2 13 11 3796 5081 5159 +8075 2 2 13 11 4359 6245 4793 +8076 2 2 13 11 3718 5960 5315 +8077 2 2 13 11 4163 4591 5764 +8078 2 2 13 11 4646 6201 4915 +8079 2 2 13 11 4725 5267 6633 +8080 2 2 13 11 4378 6669 4661 +8081 2 2 13 11 4366 6269 4797 +8082 2 2 13 11 3690 4844 5744 +8083 2 2 13 11 3688 5139 5831 +8084 2 2 13 11 4113 5335 4816 +8085 2 2 13 11 3761 5246 5641 +8086 2 2 13 11 120 5047 6140 +8087 2 2 13 11 4008 5166 5705 +8088 2 2 13 11 4079 5862 4722 +8089 2 2 13 11 4080 4723 5863 +8090 2 2 13 11 3906 6824 6593 +8091 2 2 13 11 142 4738 5146 +8092 2 2 13 11 4367 4761 5539 +8093 2 2 13 11 3822 5406 6176 +8094 2 2 13 11 4031 4800 6548 +8095 2 2 13 11 4235 5075 5273 +8096 2 2 13 11 139 5030 6011 +8097 2 2 13 11 4177 5730 4794 +8098 2 2 13 11 4088 5262 6557 +8099 2 2 13 11 3999 4817 6614 +8100 2 2 13 11 4000 6615 4818 +8101 2 2 13 11 4176 5390 4925 +8102 2 2 13 11 3854 5018 5746 +8103 2 2 13 11 3750 6554 5380 +8104 2 2 13 11 3855 5747 5019 +8105 2 2 13 11 3881 5152 4611 +8106 2 2 13 11 3807 5750 5069 +8107 2 2 13 11 3654 5210 5263 +8108 2 2 13 11 3717 4871 5680 +8109 2 2 13 11 3653 5264 5211 +8110 2 2 13 11 4047 5099 5042 +8111 2 2 13 11 3909 5101 6270 +8112 2 2 13 11 3807 5913 5750 +8113 2 2 13 11 6417 4273 4887 +8114 2 2 13 11 4158 5057 5059 +8115 2 2 13 11 4176 5473 5390 +8116 2 2 13 11 4675 5498 6800 +8117 2 2 13 11 4268 5819 4822 +8118 2 2 13 11 3692 5801 4692 +8119 2 2 13 11 4022 4959 5386 +8120 2 2 13 11 4155 5729 5783 +8121 2 2 13 11 3857 4577 5529 +8122 2 2 13 11 3858 5530 4578 +8123 2 2 13 11 3710 4807 5180 +8124 2 2 13 11 3968 5376 5008 +8125 2 2 13 11 3969 5009 5377 +8126 2 2 13 11 4166 4734 5594 +8127 2 2 13 11 4167 5595 4735 +8128 2 2 13 11 4012 6308 5033 +8129 2 2 13 11 4268 4822 5572 +8130 2 2 13 11 4046 5029 5096 +8131 2 2 13 11 4377 4906 5927 +8132 2 2 13 11 4993 6935 6493 +8133 2 2 13 11 3973 4962 6261 +8134 2 2 13 11 5008 5376 6109 +8135 2 2 13 11 3901 4754 5223 +8136 2 2 13 11 5009 6111 5377 +8137 2 2 13 11 3700 5927 4906 +8138 2 2 13 11 5070 5994 6400 +8139 2 2 13 11 117 118 5926 +8140 2 2 13 11 4357 6650 4759 +8141 2 2 13 11 4109 5014 5003 +8142 2 2 13 11 4589 6322 6200 +8143 2 2 13 11 3891 6087 6184 +8144 2 2 13 11 309 5700 310 +8145 2 2 13 11 266 5701 267 +8146 2 2 13 11 4322 6073 6285 +8147 2 2 13 11 4671 5674 6893 +8148 2 2 13 11 4044 4860 5489 +8149 2 2 13 11 164 165 4909 +8150 2 2 13 11 56 57 4910 +8151 2 2 13 11 4045 5490 4861 +8152 2 2 13 11 3760 4676 5181 +8153 2 2 13 11 3999 6614 4855 +8154 2 2 13 11 3810 5290 4737 +8155 2 2 13 11 4000 4856 6615 +8156 2 2 13 11 4148 6693 5093 +8157 2 2 13 11 4526 6106 5245 +8158 2 2 13 11 306 4830 307 +8159 2 2 13 11 4191 5118 5153 +8160 2 2 13 11 159 4842 5111 +8161 2 2 13 11 62 5112 4843 +8162 2 2 13 11 4119 5205 4933 +8163 2 2 13 11 4120 4934 5206 +8164 2 2 13 11 4046 4817 5029 +8165 2 2 13 11 4092 4551 5436 +8166 2 2 13 11 4825 6580 5911 +8167 2 2 13 11 4483 5831 5139 +8168 2 2 13 11 4287 5503 5825 +8169 2 2 13 11 3792 5942 5113 +8170 2 2 13 11 3793 5114 5943 +8171 2 2 13 11 4047 5042 4818 +8172 2 2 13 11 4039 4729 6465 +8173 2 2 13 11 4036 5024 5389 +8174 2 2 13 11 5292 6297 4285 +8175 2 2 13 11 3679 5737 4707 +8176 2 2 13 11 4298 5077 5400 +8177 2 2 13 11 3959 6789 4710 +8178 2 2 13 11 4299 5401 5078 +8179 2 2 13 11 3762 4618 5740 +8180 2 2 13 11 4043 4677 6572 +8181 2 2 13 11 3763 5741 4619 +8182 2 2 13 11 3894 6167 4616 +8183 2 2 13 11 3882 5522 4581 +8184 2 2 13 11 4019 6691 6033 +8185 2 2 13 11 4229 5235 5725 +8186 2 2 13 11 4012 5002 6073 +8187 2 2 13 11 4531 4930 6654 +8188 2 2 13 11 4515 4993 6493 +8189 2 2 13 11 159 160 4842 +8190 2 2 13 11 61 62 4843 +8191 2 2 13 11 3764 5517 4558 +8192 2 2 13 11 4479 5049 5915 +8193 2 2 13 11 3757 5391 4662 +8194 2 2 13 11 3910 5201 4755 +8195 2 2 13 11 6866 5538 4317 +8196 2 2 13 11 3703 5141 4734 +8197 2 2 13 11 3704 4735 5142 +8198 2 2 13 11 4320 4763 6224 +8199 2 2 13 11 4008 5000 5397 +8200 2 2 13 11 4639 6441 6888 +8201 2 2 13 11 3967 4822 5819 +8202 2 2 13 11 4159 5070 5061 +8203 2 2 13 11 4110 5812 6152 +8204 2 2 13 11 4159 5155 5070 +8205 2 2 13 11 4318 6198 4632 +8206 2 2 13 11 4720 5380 6554 +8207 2 2 13 11 4061 5534 5141 +8208 2 2 13 11 4062 5142 5535 +8209 2 2 13 11 4553 6184 6087 +8210 2 2 13 11 4078 5123 5276 +8211 2 2 13 11 3820 5735 5022 +8212 2 2 13 11 3833 5842 5661 +8213 2 2 13 11 4031 6548 6418 +8214 2 2 13 11 4057 5911 5974 +8215 2 2 13 11 4319 5191 6116 +8216 2 2 13 11 4209 4665 5768 +8217 2 2 13 11 4079 4722 5684 +8218 2 2 13 11 4080 5685 4723 +8219 2 2 13 11 4331 4826 5868 +8220 2 2 13 11 3806 4841 5689 +8221 2 2 13 11 3908 5149 4688 +8222 2 2 13 11 4108 4681 5345 +8223 2 2 13 11 3991 5233 4636 +8224 2 2 13 11 3769 5029 4817 +8225 2 2 13 11 3952 4686 5172 +8226 2 2 13 11 4546 6213 5570 +8227 2 2 13 11 4495 6229 4952 +8228 2 2 13 11 3932 5680 4871 +8229 2 2 13 11 3758 5075 5308 +8230 2 2 13 11 3741 5053 4936 +8231 2 2 13 11 3759 4870 5632 +8232 2 2 13 11 3877 6364 6141 +8233 2 2 13 11 4025 5176 4768 +8234 2 2 13 11 3713 5834 4998 +8235 2 2 13 11 4057 5413 4565 +8236 2 2 13 11 3851 5240 5946 +8237 2 2 13 11 4235 5308 5075 +8238 2 2 13 11 4013 6510 4829 +8239 2 2 13 11 4172 5209 4633 +8240 2 2 13 11 5026 6274 6048 +8241 2 2 13 11 3780 4980 5033 +8242 2 2 13 11 3770 4818 5042 +8243 2 2 13 11 4039 4881 6292 +8244 2 2 13 11 4246 4561 5771 +8245 2 2 13 11 3989 5494 4923 +8246 2 2 13 11 5076 6675 5820 +8247 2 2 13 11 4094 5462 5202 +8248 2 2 13 11 4091 4662 5391 +8249 2 2 13 11 4812 5306 6809 +8250 2 2 13 11 4886 4995 6572 +8251 2 2 13 11 4007 5592 4557 +8252 2 2 13 11 4519 6536 4798 +8253 2 2 13 11 4004 4617 6511 +8254 2 2 13 11 4599 6845 5653 +8255 2 2 13 11 3921 4738 5997 +8256 2 2 13 11 3736 6773 6065 +8257 2 2 13 11 3660 5321 4687 +8258 2 2 13 11 4760 6363 5196 +8259 2 2 13 11 3919 4791 6566 +8260 2 2 13 11 3920 6567 4792 +8261 2 2 13 11 94 5383 4710 +8262 2 2 13 11 4364 4734 5141 +8263 2 2 13 11 4524 4833 6497 +8264 2 2 13 11 4365 5142 4735 +8265 2 2 13 11 3955 6669 5565 +8266 2 2 13 11 4802 5538 6866 +8267 2 2 13 11 3844 5671 5520 +8268 2 2 13 11 4035 5070 5155 +8269 2 2 13 11 4202 4743 5505 +8270 2 2 13 11 4060 5225 6266 +8271 2 2 13 11 4153 5372 6161 +8272 2 2 13 11 3724 4683 6337 +8273 2 2 13 11 3650 6322 4899 +8274 2 2 13 11 4023 5659 4692 +8275 2 2 13 11 4421 6053 5440 +8276 2 2 13 11 4173 5686 4731 +8277 2 2 13 11 4174 4732 5687 +8278 2 2 13 11 3891 4671 6087 +8279 2 2 13 11 4043 4799 6758 +8280 2 2 13 11 4073 4964 4929 +8281 2 2 13 11 4396 5746 5018 +8282 2 2 13 11 4483 5728 6577 +8283 2 2 13 11 4397 5019 5747 +8284 2 2 13 11 4319 5556 5232 +8285 2 2 13 11 4218 5219 5203 +8286 2 2 13 11 4219 5204 5220 +8287 2 2 13 11 3833 5145 5842 +8288 2 2 13 11 4584 5824 5407 +8289 2 2 13 11 4079 4592 5862 +8290 2 2 13 11 4080 5863 4593 +8291 2 2 13 11 4563 6774 6032 +8292 2 2 13 11 3995 6107 4634 +8293 2 2 13 11 4081 5105 5132 +8294 2 2 13 11 4494 5000 6275 +8295 2 2 13 11 4082 5133 5106 +8296 2 2 13 11 4022 5386 6278 +8297 2 2 13 11 3686 4853 5209 +8298 2 2 13 11 4039 5023 5892 +8299 2 2 13 11 3970 4780 5040 +8300 2 2 13 11 3955 4598 5499 +8301 2 2 13 11 4243 6118 5165 +8302 2 2 13 11 3751 6562 4847 +8303 2 2 13 11 3923 6609 4796 +8304 2 2 13 11 4040 4621 5854 +8305 2 2 13 11 5428 6579 4087 +8306 2 2 13 11 4066 5203 5219 +8307 2 2 13 11 3736 6088 5627 +8308 2 2 13 11 4067 5220 5204 +8309 2 2 13 11 96 97 4956 +8310 2 2 13 11 6573 3986 5311 +8311 2 2 13 11 4317 5502 5578 +8312 2 2 13 11 4076 4658 6841 +8313 2 2 13 11 4422 6219 6282 +8314 2 2 13 11 4090 4712 5362 +8315 2 2 13 11 4060 6171 5225 +8316 2 2 13 11 80 4889 6605 +8317 2 2 13 11 3982 4582 6740 +8318 2 2 13 11 4182 5062 5227 +8319 2 2 13 11 4378 4661 6337 +8320 2 2 13 11 4005 4691 5736 +8321 2 2 13 11 4396 6243 5409 +8322 2 2 13 11 4397 5410 6244 +8323 2 2 13 11 4104 6123 5278 +8324 2 2 13 11 4497 4796 6609 +8325 2 2 13 11 4676 5138 5491 +8326 2 2 13 11 3909 5710 5100 +8327 2 2 13 11 5259 6639 4073 +8328 2 2 13 11 4173 4731 5615 +8329 2 2 13 11 4174 5616 4732 +8330 2 2 13 11 4102 6136 4591 +8331 2 2 13 11 3964 6627 5343 +8332 2 2 13 11 3965 5344 6628 +8333 2 2 13 11 4474 6138 5383 +8334 2 2 13 11 3856 4879 6640 +8335 2 2 13 11 4555 6424 6062 +8336 2 2 13 11 4556 6064 6425 +8337 2 2 13 11 319 4627 5554 +8338 2 2 13 11 257 5555 4628 +8339 2 2 13 11 3736 4987 6773 +8340 2 2 13 11 4070 5452 4884 +8341 2 2 13 11 4071 4885 5453 +8342 2 2 13 11 5120 5729 6416 +8343 2 2 13 11 4422 6282 5456 +8344 2 2 13 11 6860 3842 5771 +8345 2 2 13 11 3762 5313 6037 +8346 2 2 13 11 3763 6038 5316 +8347 2 2 13 11 4166 5639 4647 +8348 2 2 13 11 4167 4648 5640 +8349 2 2 13 11 4320 5450 4763 +8350 2 2 13 11 4318 4961 6846 +8351 2 2 13 11 4475 6566 4791 +8352 2 2 13 11 4476 4792 6567 +8353 2 2 13 11 3748 6275 5000 +8354 2 2 13 11 3654 4649 6133 +8355 2 2 13 11 3653 6134 4650 +8356 2 2 13 11 3911 4607 5461 +8357 2 2 13 11 3862 5023 6162 +8358 2 2 13 11 3912 5463 4608 +8359 2 2 13 11 3795 6287 5694 +8360 2 2 13 11 3955 5422 4598 +8361 2 2 13 11 3655 6118 4756 +8362 2 2 13 11 72 73 4959 +8363 2 2 13 11 5998 5389 4217 +8364 2 2 13 11 5429 4088 6557 +8365 2 2 13 11 4396 5885 6243 +8366 2 2 13 11 4397 6244 5886 +8367 2 2 13 11 4169 4602 5700 +8368 2 2 13 11 3891 4644 5674 +8369 2 2 13 11 3677 5241 4758 +8370 2 2 13 11 4170 5701 4603 +8371 2 2 13 11 4013 6600 5798 +8372 2 2 13 11 4796 6297 5292 +8373 2 2 13 11 3934 5615 4731 +8374 2 2 13 11 3935 4732 5616 +8375 2 2 13 11 4497 6609 5632 +8376 2 2 13 11 4504 5392 6446 +8377 2 2 13 11 4244 4640 5840 +8378 2 2 13 11 4252 5689 4841 +8379 2 2 13 11 3947 5195 4651 +8380 2 2 13 11 3692 4692 5654 +8381 2 2 13 11 5033 6308 5480 +8382 2 2 13 11 4246 6654 4930 +8383 2 2 13 11 4175 6805 4595 +8384 2 2 13 11 4638 5389 5998 +8385 2 2 13 11 4059 5549 5115 +8386 2 2 13 11 267 5314 268 +8387 2 2 13 11 4221 5193 5737 +8388 2 2 13 11 3762 5027 4855 +8389 2 2 13 11 4214 4867 5605 +8390 2 2 13 11 4424 5308 4678 +8391 2 2 13 11 4107 5043 5419 +8392 2 2 13 11 3763 4856 5028 +8393 2 2 13 11 6213 6514 5570 +8394 2 2 13 11 3963 6129 5312 +8395 2 2 13 11 3995 5340 4793 +8396 2 2 13 11 4358 5705 5166 +8397 2 2 13 11 4363 5202 5462 +8398 2 2 13 11 3775 5534 4667 +8399 2 2 13 11 3751 5706 5427 +8400 2 2 13 11 4862 5814 5195 +8401 2 2 13 11 3776 4668 5535 +8402 2 2 13 11 4404 5256 5699 +8403 2 2 13 11 5343 3786 6290 +8404 2 2 13 11 5344 6291 3787 +8405 2 2 13 11 4462 5156 6147 +8406 2 2 13 11 4142 4675 5300 +8407 2 2 13 11 4171 5054 5414 +8408 2 2 13 11 4749 5343 6290 +8409 2 2 13 11 4750 6291 5344 +8410 2 2 13 11 3661 4626 5477 +8411 2 2 13 11 3946 4743 6411 +8412 2 2 13 11 3982 5743 4582 +8413 2 2 13 11 3734 5881 6690 +8414 2 2 13 11 6200 4149 4589 +8415 2 2 13 11 4121 5400 5077 +8416 2 2 13 11 4122 5078 5401 +8417 2 2 13 11 3804 4933 5205 +8418 2 2 13 11 3991 4870 5233 +8419 2 2 13 11 3805 5206 4934 +8420 2 2 13 11 4707 5737 6593 +8421 2 2 13 11 4467 6290 5177 +8422 2 2 13 11 4468 5178 6291 +8423 2 2 13 11 116 5287 4811 +8424 2 2 13 11 3959 4825 6789 +8425 2 2 13 11 4464 4889 5599 +8426 2 2 13 11 4405 5338 4901 +8427 2 2 13 11 4039 6292 6162 +8428 2 2 13 11 3978 5026 4841 +8429 2 2 13 11 4005 4654 5230 +8430 2 2 13 11 90 4656 6374 +8431 2 2 13 11 3781 5696 4857 +8432 2 2 13 11 3778 5192 5614 +8433 2 2 13 11 4550 6429 5147 +8434 2 2 13 11 3743 4680 5436 +8435 2 2 13 11 3845 6224 4763 +8436 2 2 13 11 4335 5399 5356 +8437 2 2 13 11 4900 5488 6356 +8438 2 2 13 11 3886 5086 6187 +8439 2 2 13 11 3887 6188 5087 +8440 2 2 13 11 4387 5100 5710 +8441 2 2 13 11 4253 4857 5696 +8442 2 2 13 11 3661 6719 4996 +8443 2 2 13 11 4072 5223 6882 +8444 2 2 13 11 4572 5417 6642 +8445 2 2 13 11 4573 6643 5418 +8446 2 2 13 11 4364 5141 5534 +8447 2 2 13 11 4365 5535 5142 +8448 2 2 13 11 3949 6529 5044 +8449 2 2 13 11 4728 5047 6608 +8450 2 2 13 11 3691 5542 4637 +8451 2 2 13 11 4890 6573 5311 +8452 2 2 13 11 3875 5227 5062 +8453 2 2 13 11 3854 4892 5018 +8454 2 2 13 11 3855 5019 4893 +8455 2 2 13 11 3662 5719 4809 +8456 2 2 13 11 3663 4810 5720 +8457 2 2 13 11 4555 6625 4990 +8458 2 2 13 11 4556 4991 6626 +8459 2 2 13 11 5038 6860 5771 +8460 2 2 13 11 120 121 5047 +8461 2 2 13 11 3998 6209 4657 +8462 2 2 13 11 4013 4693 6672 +8463 2 2 13 11 3866 5407 5824 +8464 2 2 13 11 4112 5042 5099 +8465 2 2 13 11 3775 5601 5534 +8466 2 2 13 11 3776 5535 5602 +8467 2 2 13 11 5319 6910 4124 +8468 2 2 13 11 3904 5605 4867 +8469 2 2 13 11 4152 4662 6137 +8470 2 2 13 11 4181 6593 5737 +8471 2 2 13 11 5375 6248 6561 +8472 2 2 13 11 4405 5614 5192 +8473 2 2 13 11 4110 5096 5029 +8474 2 2 13 11 4052 4658 5935 +8475 2 2 13 11 4024 5229 4899 +8476 2 2 13 11 308 5231 309 +8477 2 2 13 11 3675 5222 5649 +8478 2 2 13 11 3730 4665 5450 +8479 2 2 13 11 4527 6187 5086 +8480 2 2 13 11 4528 5087 6188 +8481 2 2 13 11 3889 4990 6625 +8482 2 2 13 11 3890 6626 4991 +8483 2 2 13 11 3904 4711 5605 +8484 2 2 13 11 3723 4787 5274 +8485 2 2 13 11 3773 4835 5119 +8486 2 2 13 11 4133 4901 5338 +8487 2 2 13 11 268 5314 6090 +8488 2 2 13 11 4414 5053 5934 +8489 2 2 13 11 4754 6882 5223 +8490 2 2 13 11 3973 6310 4962 +8491 2 2 13 11 322 4897 323 +8492 2 2 13 11 253 4898 254 +8493 2 2 13 11 4058 5083 5162 +8494 2 2 13 11 4598 5422 6843 +8495 2 2 13 11 3815 4888 6040 +8496 2 2 13 11 3741 5934 5053 +8497 2 2 13 11 133 134 4962 +8498 2 2 13 11 4358 6140 5047 +8499 2 2 13 11 6591 3996 5509 +8500 2 2 13 11 6592 5510 3997 +8501 2 2 13 11 3665 4635 5722 +8502 2 2 13 11 165 6079 4909 +8503 2 2 13 11 56 4910 6080 +8504 2 2 13 11 4318 6846 6198 +8505 2 2 13 11 4079 6114 4592 +8506 2 2 13 11 4080 4593 6115 +8507 2 2 13 11 4116 6087 5711 +8508 2 2 13 11 3928 4613 5977 +8509 2 2 13 11 4747 5909 6916 +8510 2 2 13 11 4748 6917 5910 +8511 2 2 13 11 3937 4698 6465 +8512 2 2 13 11 113 4616 5336 +8513 2 2 13 11 96 4956 6621 +8514 2 2 13 11 4057 4758 5122 +8515 2 2 13 11 3778 4666 5866 +8516 2 2 13 11 4195 4997 5569 +8517 2 2 13 11 4069 6340 6620 +8518 2 2 13 11 4092 5436 4680 +8519 2 2 13 11 3675 5449 4609 +8520 2 2 13 11 3967 4768 5176 +8521 2 2 13 11 3946 4604 5505 +8522 2 2 13 11 3756 5253 5462 +8523 2 2 13 11 4127 5800 4652 +8524 2 2 13 11 4683 6480 5082 +8525 2 2 13 11 4378 6337 4683 +8526 2 2 13 11 4414 6226 5053 +8527 2 2 13 11 3911 5852 4607 +8528 2 2 13 11 4003 5184 4706 +8529 2 2 13 11 3912 4608 5853 +8530 2 2 13 11 3998 5107 4797 +8531 2 2 13 11 3795 5226 6287 +8532 2 2 13 11 4325 6224 5548 +8533 2 2 13 11 3815 5147 5867 +8534 2 2 13 11 4061 5018 4892 +8535 2 2 13 11 4075 4936 5053 +8536 2 2 13 11 4062 4893 5019 +8537 2 2 13 11 3660 4687 6127 +8538 2 2 13 11 3989 6433 4585 +8539 2 2 13 11 3674 5798 4988 +8540 2 2 13 11 5354 6721 5877 +8541 2 2 13 11 3705 6003 5037 +8542 2 2 13 11 4026 4775 5573 +8543 2 2 13 11 4168 5824 4584 +8544 2 2 13 11 3917 4733 6473 +8545 2 2 13 11 4780 6084 5040 +8546 2 2 13 11 3928 6921 6216 +8547 2 2 13 11 4846 6130 6947 +8548 2 2 13 11 4286 5670 5076 +8549 2 2 13 11 4220 4755 5201 +8550 2 2 13 11 4938 6591 5509 +8551 2 2 13 11 4939 5510 6592 +8552 2 2 13 11 3946 5505 4743 +8553 2 2 13 11 4171 5727 4705 +8554 2 2 13 11 4090 4600 5633 +8555 2 2 13 11 4044 5489 5109 +8556 2 2 13 11 4045 5110 5490 +8557 2 2 13 11 4854 6639 5259 +8558 2 2 13 11 3870 4631 6234 +8559 2 2 13 11 4078 5088 5085 +8560 2 2 13 11 3741 5301 4634 +8561 2 2 13 11 3937 6465 4729 +8562 2 2 13 11 4140 4724 5277 +8563 2 2 13 11 3938 5836 5305 +8564 2 2 13 11 4264 4816 5912 +8565 2 2 13 11 4552 5398 6489 +8566 2 2 13 11 4089 5356 5399 +8567 2 2 13 11 4061 5754 4667 +8568 2 2 13 11 4062 4668 5755 +8569 2 2 13 11 4030 6539 5090 +8570 2 2 13 11 3725 6280 5716 +8571 2 2 13 11 3768 5656 5774 +8572 2 2 13 11 3782 5003 5791 +8573 2 2 13 11 3782 5791 4976 +8574 2 2 13 11 3690 5123 4876 +8575 2 2 13 11 4101 5094 5325 +8576 2 2 13 11 4359 5419 5043 +8577 2 2 13 11 4220 5950 4755 +8578 2 2 13 11 3881 4816 5835 +8579 2 2 13 11 4149 5733 4589 +8580 2 2 13 11 4182 4839 5062 +8581 2 2 13 11 4027 4758 5241 +8582 2 2 13 11 4583 5427 5706 +8583 2 2 13 11 3821 5403 4919 +8584 2 2 13 11 3819 4691 5662 +8585 2 2 13 11 3899 5355 4643 +8586 2 2 13 11 4600 5362 6564 +8587 2 2 13 11 4123 5604 6528 +8588 2 2 13 11 3717 5680 6228 +8589 2 2 13 11 4404 5699 6703 +8590 2 2 13 11 3802 6800 5498 +8591 2 2 13 11 4740 6052 6704 +8592 2 2 13 11 3800 5531 5214 +8593 2 2 13 11 4199 5710 4941 +8594 2 2 13 11 75 4744 6380 +8595 2 2 13 11 4362 6040 4888 +8596 2 2 13 11 4730 5695 6931 +8597 2 2 13 11 4695 5930 5668 +8598 2 2 13 11 4696 5669 5931 +8599 2 2 13 11 4236 4716 6041 +8600 2 2 13 11 4661 6669 5499 +8601 2 2 13 11 4645 6129 6854 +8602 2 2 13 11 4078 5083 4876 +8603 2 2 13 11 4024 4983 5229 +8604 2 2 13 11 4844 6499 5744 +8605 2 2 13 11 4183 4676 5582 +8606 2 2 13 11 3784 4783 5611 +8607 2 2 13 11 4072 5076 6108 +8608 2 2 13 11 3718 5232 5556 +8609 2 2 13 11 3772 4705 5727 +8610 2 2 13 11 4077 5280 6280 +8611 2 2 13 11 4087 6603 4609 +8612 2 2 13 11 4414 6559 6226 +8613 2 2 13 11 4105 4641 5440 +8614 2 2 13 11 4455 6380 4744 +8615 2 2 13 11 4057 6267 4758 +8616 2 2 13 11 3808 5281 5678 +8617 2 2 13 11 4029 5147 6429 +8618 2 2 13 11 3886 6855 5086 +8619 2 2 13 11 3887 5087 6856 +8620 2 2 13 11 3886 6148 6855 +8621 2 2 13 11 3887 6856 6150 +8622 2 2 13 11 4574 6612 5884 +8623 2 2 13 11 3946 5799 4604 +8624 2 2 13 11 4366 5483 5048 +8625 2 2 13 11 4087 4609 5449 +8626 2 2 13 11 4320 5603 5450 +8627 2 2 13 11 4177 5562 5730 +8628 2 2 13 11 4221 5737 6069 +8629 2 2 13 11 4475 4791 5675 +8630 2 2 13 11 4476 5676 4792 +8631 2 2 13 11 4450 5326 5653 +8632 2 2 13 11 4636 5044 6529 +8633 2 2 13 11 4182 5802 4745 +8634 2 2 13 11 3879 5653 5326 +8635 2 2 13 11 4473 5228 6610 +8636 2 2 13 11 4202 5094 5667 +8637 2 2 13 11 4125 5048 5483 +8638 2 2 13 11 4464 6605 4889 +8639 2 2 13 11 4954 6933 5361 +8640 2 2 13 11 3950 6165 4656 +8641 2 2 13 11 4117 5085 5088 +8642 2 2 13 11 3943 5354 5877 +8643 2 2 13 11 4372 5337 6176 +8644 2 2 13 11 4024 4737 5290 +8645 2 2 13 11 4340 5651 5298 +8646 2 2 13 11 77 5143 5883 +8647 2 2 13 11 4341 5299 5652 +8648 2 2 13 11 72 4959 6375 +8649 2 2 13 11 4185 5654 4692 +8650 2 2 13 11 3819 5736 4691 +8651 2 2 13 11 4349 4988 5798 +8652 2 2 13 11 4347 6366 5831 +8653 2 2 13 11 4671 5711 6087 +8654 2 2 13 11 3743 6713 4680 +8655 2 2 13 11 3918 6406 4908 +8656 2 2 13 11 4550 6040 4882 +8657 2 2 13 11 70 71 4946 +8658 2 2 13 11 3717 5459 4871 +8659 2 2 13 11 4453 6151 6397 +8660 2 2 13 11 4372 5406 4733 +8661 2 2 13 11 6910 5126 4124 +8662 2 2 13 11 4109 5276 5123 +8663 2 2 13 11 4055 5111 4842 +8664 2 2 13 11 4056 4843 5112 +8665 2 2 13 11 6052 3809 6704 +8666 2 2 13 11 3691 4637 5734 +8667 2 2 13 11 90 5617 4656 +8668 2 2 13 11 3666 4911 5207 +8669 2 2 13 11 3667 5208 4912 +8670 2 2 13 11 4086 6284 4725 +8671 2 2 13 11 4367 5539 6191 +8672 2 2 13 11 6933 3877 5361 +8673 2 2 13 11 4201 5903 4801 +8674 2 2 13 11 4322 4821 5500 +8675 2 2 13 11 4347 5831 5135 +8676 2 2 13 11 4027 5745 4840 +8677 2 2 13 11 4041 5293 6251 +8678 2 2 13 11 4042 6252 5294 +8679 2 2 13 11 3995 4947 5340 +8680 2 2 13 11 3881 4611 5681 +8681 2 2 13 11 3785 4925 5162 +8682 2 2 13 11 4363 5462 5253 +8683 2 2 13 11 5090 6539 5538 +8684 2 2 13 11 4622 5779 4878 +8685 2 2 13 11 3706 6320 5059 +8686 2 2 13 11 150 151 4982 +8687 2 2 13 11 4130 5233 4870 +8688 2 2 13 11 3921 5997 4632 +8689 2 2 13 11 4642 6072 6814 +8690 2 2 13 11 3984 5319 4848 +8691 2 2 13 11 5027 6037 5298 +8692 2 2 13 11 5028 5299 6038 +8693 2 2 13 11 4163 5774 4708 +8694 2 2 13 11 297 4949 298 +8695 2 2 13 11 3686 5803 5092 +8696 2 2 13 11 155 5441 4695 +8697 2 2 13 11 66 4696 5442 +8698 2 2 13 11 4480 6012 5170 +8699 2 2 13 11 4661 4882 5876 +8700 2 2 13 11 4153 4765 6673 +8701 2 2 13 11 3830 6386 5585 +8702 2 2 13 11 3831 5586 6387 +8703 2 2 13 11 3705 6197 6451 +8704 2 2 13 11 3670 4761 6333 +8705 2 2 13 11 4078 4876 5123 +8706 2 2 13 11 4108 5355 4719 +8707 2 2 13 11 4388 6742 5079 +8708 2 2 13 11 4482 6190 5422 +8709 2 2 13 11 4566 6251 5293 +8710 2 2 13 11 3727 4642 5460 +8711 2 2 13 11 4567 5294 6252 +8712 2 2 13 11 4485 5495 6436 +8713 2 2 13 11 3765 5645 4672 +8714 2 2 13 11 3766 4673 5646 +8715 2 2 13 11 3809 5076 5670 +8716 2 2 13 11 4699 6752 6453 +8717 2 2 13 11 4700 6454 6753 +8718 2 2 13 11 107 4702 6542 +8719 2 2 13 11 4265 5445 5168 +8720 2 2 13 11 4266 5169 5446 +8721 2 2 13 11 4007 5880 6777 +8722 2 2 13 11 3994 5267 4725 +8723 2 2 13 11 3952 5937 4686 +8724 2 2 13 11 4462 5948 5466 +8725 2 2 13 11 4023 6616 5659 +8726 2 2 13 11 3939 4620 5730 +8727 2 2 13 11 4100 4717 5451 +8728 2 2 13 11 4353 5415 5475 +8729 2 2 13 11 4354 5476 5416 +8730 2 2 13 11 4822 6376 5572 +8731 2 2 13 11 5654 5361 6733 +8732 2 2 13 11 4172 4633 5752 +8733 2 2 13 11 4400 5005 5185 +8734 2 2 13 11 3860 5466 5948 +8735 2 2 13 11 4387 4844 5855 +8736 2 2 13 11 3764 6123 5517 +8737 2 2 13 11 154 4695 5668 +8738 2 2 13 11 67 5669 4696 +8739 2 2 13 11 4059 5167 6374 +8740 2 2 13 11 143 5907 4738 +8741 2 2 13 11 4091 5420 4662 +8742 2 2 13 11 3785 5085 5348 +8743 2 2 13 11 3962 5423 5108 +8744 2 2 13 11 4997 6596 5569 +8745 2 2 13 11 4605 5411 6345 +8746 2 2 13 11 4606 6346 5412 +8747 2 2 13 11 4002 5985 4922 +8748 2 2 13 11 4138 5168 5445 +8749 2 2 13 11 4139 5446 5169 +8750 2 2 13 11 3728 5170 6012 +8751 2 2 13 11 3680 5333 4837 +8752 2 2 13 11 3681 4838 5334 +8753 2 2 13 11 4759 6650 5309 +8754 2 2 13 11 4327 6947 6130 +8755 2 2 13 11 4270 4947 5301 +8756 2 2 13 11 3956 4956 6430 +8757 2 2 13 11 4646 6206 5459 +8758 2 2 13 11 4258 4738 5907 +8759 2 2 13 11 134 6660 4962 +8760 2 2 13 11 3875 5148 4961 +8761 2 2 13 11 4092 5921 4682 +8762 2 2 13 11 4505 6430 4956 +8763 2 2 13 11 3781 4698 5696 +8764 2 2 13 11 4124 4848 5319 +8765 2 2 13 11 4089 6613 6900 +8766 2 2 13 11 3820 6117 6590 +8767 2 2 13 11 4264 5835 4816 +8768 2 2 13 11 3804 5536 4933 +8769 2 2 13 11 4775 5924 5260 +8770 2 2 13 11 3660 4755 5950 +8771 2 2 13 11 4438 5317 6035 +8772 2 2 13 11 3805 4934 5537 +8773 2 2 13 11 4209 6034 4665 +8774 2 2 13 11 4439 6036 5318 +8775 2 2 13 11 5361 4416 6733 +8776 2 2 13 11 99 6166 6268 +8777 2 2 13 11 4190 4705 5619 +8778 2 2 13 11 3929 5780 4736 +8779 2 2 13 11 4311 5671 4999 +8780 2 2 13 11 4198 4736 5271 +8781 2 2 13 11 4187 4919 5403 +8782 2 2 13 11 4254 5899 6553 +8783 2 2 13 11 3933 4646 5944 +8784 2 2 13 11 3902 5793 4663 +8785 2 2 13 11 3903 4664 5794 +8786 2 2 13 11 4392 6345 5411 +8787 2 2 13 11 4393 5412 6346 +8788 2 2 13 11 4069 5385 6340 +8789 2 2 13 11 4247 4716 6241 +8790 2 2 13 11 4134 4865 5255 +8791 2 2 13 11 4451 6516 4733 +8792 2 2 13 11 3859 4903 6027 +8793 2 2 13 11 3678 6882 4754 +8794 2 2 13 11 4335 5217 6485 +8795 2 2 13 11 4633 5619 5752 +8796 2 2 13 11 3758 4894 5075 +8797 2 2 13 11 4083 5274 4787 +8798 2 2 13 11 4053 4790 5813 +8799 2 2 13 11 4182 5227 5802 +8800 2 2 13 11 3916 4661 6826 +8801 2 2 13 11 3882 4766 5522 +8802 2 2 13 11 3971 6130 4846 +8803 2 2 13 11 3779 5553 5821 +8804 2 2 13 11 4023 4692 5801 +8805 2 2 13 11 3700 6311 5261 +8806 2 2 13 11 3899 4705 5889 +8807 2 2 13 11 3962 4753 6264 +8808 2 2 13 11 3772 5752 5619 +8809 2 2 13 11 4078 5085 5083 +8810 2 2 13 11 3779 5711 4671 +8811 2 2 13 11 4544 4923 5494 +8812 2 2 13 11 3673 5961 5571 +8813 2 2 13 11 4666 5614 6490 +8814 2 2 13 11 4058 5855 4844 +8815 2 2 13 11 5217 5766 6485 +8816 2 2 13 11 4645 5553 6129 +8817 2 2 13 11 3975 5127 5479 +8818 2 2 13 11 4623 6353 5359 +8819 2 2 13 11 4624 5360 6354 +8820 2 2 13 11 4329 5783 5729 +8821 2 2 13 11 290 4712 5620 +8822 2 2 13 11 3699 5289 5642 +8823 2 2 13 11 4207 5015 6922 +8824 2 2 13 11 3803 5285 4942 +8825 2 2 13 11 4195 5541 4997 +8826 2 2 13 11 4117 5688 5564 +8827 2 2 13 11 4357 4759 6455 +8828 2 2 13 11 3753 5778 4768 +8829 2 2 13 11 4207 6922 6396 +8830 2 2 13 11 3729 4688 5813 +8831 2 2 13 11 4220 5201 5731 +8832 2 2 13 11 4072 6108 5223 +8833 2 2 13 11 4043 5928 5739 +8834 2 2 13 11 3662 4784 6786 +8835 2 2 13 11 3663 6787 4785 +8836 2 2 13 11 4127 5944 4646 +8837 2 2 13 11 3672 5026 6048 +8838 2 2 13 11 77 78 5143 +8839 2 2 13 11 4260 6052 4740 +8840 2 2 13 11 4202 5325 5094 +8841 2 2 13 11 4247 6282 4716 +8842 2 2 13 11 4123 5922 4702 +8843 2 2 13 11 116 117 5287 +8844 2 2 13 11 4449 4905 6449 +8845 2 2 13 11 4075 4718 6616 +8846 2 2 13 11 4177 4794 5430 +8847 2 2 13 11 3804 5205 5006 +8848 2 2 13 11 3805 5007 5206 +8849 2 2 13 11 4165 4637 5949 +8850 2 2 13 11 4419 6451 5275 +8851 2 2 13 11 3742 4840 5854 +8852 2 2 13 11 4659 6906 5806 +8853 2 2 13 11 4649 5322 6944 +8854 2 2 13 11 4650 6945 5323 +8855 2 2 13 11 4166 4647 5630 +8856 2 2 13 11 4167 5631 4648 +8857 2 2 13 11 4670 5632 6609 +8858 2 2 13 11 4401 5037 6003 +8859 2 2 13 11 3812 6156 5295 +8860 2 2 13 11 3813 5296 6157 +8861 2 2 13 11 4130 5444 4693 +8862 2 2 13 11 276 4721 5626 +8863 2 2 13 11 4061 4667 5534 +8864 2 2 13 11 4062 5535 4668 +8865 2 2 13 11 3919 6579 4791 +8866 2 2 13 11 4095 5322 5265 +8867 2 2 13 11 4096 5266 5323 +8868 2 2 13 11 4312 5644 4963 +8869 2 2 13 11 4783 6932 5611 +8870 2 2 13 11 4165 5734 4637 +8871 2 2 13 11 3847 4773 5397 +8872 2 2 13 11 4311 6439 4690 +8873 2 2 13 11 3713 6416 5729 +8874 2 2 13 11 4996 5843 6703 +8875 2 2 13 11 4867 6676 6016 +8876 2 2 13 11 3734 6356 4674 +8877 2 2 13 11 106 4726 5543 +8878 2 2 13 11 4337 5946 5240 +8879 2 2 13 11 3936 5582 4676 +8880 2 2 13 11 3703 4734 5630 +8881 2 2 13 11 3704 5631 4735 +8882 2 2 13 11 3780 5995 5658 +8883 2 2 13 11 3741 4634 5934 +8884 2 2 13 11 5054 6093 5414 +8885 2 2 13 11 4572 5207 5417 +8886 2 2 13 11 4573 5418 5208 +8887 2 2 13 11 4543 5518 6285 +8888 2 2 13 11 4474 6621 4956 +8889 2 2 13 11 3927 4801 5903 +8890 2 2 13 11 3836 5298 5651 +8891 2 2 13 11 3837 5652 5299 +8892 2 2 13 11 4999 5671 6448 +8893 2 2 13 11 4292 5214 5531 +8894 2 2 13 11 3998 4721 6209 +8895 2 2 13 11 3995 4712 6107 +8896 2 2 13 11 3899 5742 4705 +8897 2 2 13 11 4734 6948 5594 +8898 2 2 13 11 4036 5389 4984 +8899 2 2 13 11 4735 5595 6949 +8900 2 2 13 11 125 5695 4777 +8901 2 2 13 11 3680 4837 6009 +8902 2 2 13 11 3681 6010 4838 +8903 2 2 13 11 3920 4792 6557 +8904 2 2 13 11 4425 6248 5375 +8905 2 2 13 11 3841 6139 4708 +8906 2 2 13 11 3750 4824 6554 +8907 2 2 13 11 4392 6453 6752 +8908 2 2 13 11 4393 6753 6454 +8909 2 2 13 11 4298 4909 6079 +8910 2 2 13 11 4299 6080 4910 +8911 2 2 13 11 4146 4674 5488 +8912 2 2 13 11 4509 5843 4996 +8913 2 2 13 11 4431 4778 6327 +8914 2 2 13 11 4432 6328 4779 +8915 2 2 13 11 3727 5788 4642 +8916 2 2 13 11 6060 3924 4695 +8917 2 2 13 11 6061 4696 3925 +8918 2 2 13 11 158 159 5111 +8919 2 2 13 11 62 63 5112 +8920 2 2 13 11 4102 5516 4760 +8921 2 2 13 11 3729 6582 4688 +8922 2 2 13 11 4190 5889 4705 +8923 2 2 13 11 147 6381 4815 +8924 2 2 13 11 4398 5359 6353 +8925 2 2 13 11 4399 6354 5360 +8926 2 2 13 11 4146 6319 4674 +8927 2 2 13 11 4119 4860 5205 +8928 2 2 13 11 4212 5041 5348 +8929 2 2 13 11 3914 6489 5398 +8930 2 2 13 11 4120 5206 4861 +8931 2 2 13 11 4285 5108 5423 +8932 2 2 13 11 3753 6094 5778 +8933 2 2 13 11 4156 5475 5415 +8934 2 2 13 11 4157 5416 5476 +8935 2 2 13 11 3719 5532 4751 +8936 2 2 13 11 3720 4752 5533 +8937 2 2 13 11 3699 6378 6810 +8938 2 2 13 11 4130 4693 5895 +8939 2 2 13 11 4235 5273 4924 +8940 2 2 13 11 4382 5194 6587 +8941 2 2 13 11 3856 5245 6106 +8942 2 2 13 11 3649 5618 4725 +8943 2 2 13 11 3842 5524 4770 +8944 2 2 13 11 4535 6246 6692 +8945 2 2 13 11 3849 5426 6698 +8946 2 2 13 11 3772 5619 4705 +8947 2 2 13 11 3899 4719 5355 +8948 2 2 13 11 4092 4680 5921 +8949 2 2 13 11 6016 6676 3658 +8950 2 2 13 11 4151 5717 5261 +8951 2 2 13 11 3972 4836 6776 +8952 2 2 13 11 4367 6333 4761 +8953 2 2 13 11 5135 5831 6577 +8954 2 2 13 11 4124 5126 5148 +8955 2 2 13 11 3991 4653 6951 +8956 2 2 13 11 4086 4725 5618 +8957 2 2 13 11 4642 6816 6072 +8958 2 2 13 11 4426 6409 5395 +8959 2 2 13 11 5079 6742 5983 +8960 2 2 13 11 4269 5371 5163 +8961 2 2 13 11 5057 6738 6836 +8962 2 2 13 11 4078 5276 5088 +8963 2 2 13 11 3967 6842 4822 +8964 2 2 13 11 4651 5873 5058 +8965 2 2 13 11 3714 5341 6518 +8966 2 2 13 11 3715 6519 5342 +8967 2 2 13 11 4467 6827 5333 +8968 2 2 13 11 4468 5334 6828 +8969 2 2 13 11 4148 5597 4831 +8970 2 2 13 11 4020 6722 4909 +8971 2 2 13 11 4021 4910 6723 +8972 2 2 13 11 3976 6871 4747 +8973 2 2 13 11 3977 4748 6872 +8974 2 2 13 11 3750 6443 4964 +8975 2 2 13 11 3976 6074 4965 +8976 2 2 13 11 3977 4966 6075 +8977 2 2 13 11 4109 5003 5276 +8978 2 2 13 11 4172 5578 5502 +8979 2 2 13 11 4192 6063 5050 +8980 2 2 13 11 4249 6164 4709 +8981 2 2 13 11 4076 6841 4963 +8982 2 2 13 11 4097 4849 5188 +8983 2 2 13 11 4098 5189 4850 +8984 2 2 13 11 4138 4703 5588 +8985 2 2 13 11 4139 5589 4704 +8986 2 2 13 11 4384 6375 4959 +8987 2 2 13 11 3918 4908 6401 +8988 2 2 13 11 4767 5347 6873 +8989 2 2 13 11 4361 4922 5985 +8990 2 2 13 11 3792 4920 5188 +8991 2 2 13 11 3793 5189 4921 +8992 2 2 13 11 4065 4770 6696 +8993 2 2 13 11 3879 6377 6110 +8994 2 2 13 11 5039 6199 6262 +8995 2 2 13 11 4647 5639 4895 +8996 2 2 13 11 4648 4896 5640 +8997 2 2 13 11 3680 6035 4950 +8998 2 2 13 11 3681 4951 6036 +8999 2 2 13 11 4547 5150 6604 +9000 2 2 13 11 4372 6176 5406 +9001 2 2 13 11 4548 6606 5151 +9002 2 2 13 11 4065 5991 4770 +9003 2 2 13 11 4158 5059 5285 +9004 2 2 13 11 4645 5821 5553 +9005 2 2 13 11 162 6327 4778 +9006 2 2 13 11 59 4779 6328 +9007 2 2 13 11 4250 5265 5322 +9008 2 2 13 11 4108 4719 5797 +9009 2 2 13 11 4251 5323 5266 +9010 2 2 13 11 5061 6850 6763 +9011 2 2 13 11 3923 4878 5920 +9012 2 2 13 11 4127 4726 5944 +9013 2 2 13 11 4643 5658 5995 +9014 2 2 13 11 3654 5263 5322 +9015 2 2 13 11 3653 5323 5264 +9016 2 2 13 11 5059 6320 5837 +9017 2 2 13 11 4687 4888 6829 +9018 2 2 13 11 4146 5488 4958 +9019 2 2 13 11 4143 4961 5148 +9020 2 2 13 11 3743 4657 5999 +9021 2 2 13 11 3735 5765 5718 +9022 2 2 13 11 4084 4807 5610 +9023 2 2 13 11 4427 6220 5378 +9024 2 2 13 11 5092 5803 6379 +9025 2 2 13 11 4292 5231 5622 +9026 2 2 13 11 4317 5063 5502 +9027 2 2 13 11 3773 5503 4835 +9028 2 2 13 11 3794 5628 6393 +9029 2 2 13 11 3795 6394 5629 +9030 2 2 13 11 4093 4739 5901 +9031 2 2 13 11 3656 6449 4905 +9032 2 2 13 11 4215 5668 5930 +9033 2 2 13 11 4216 5931 5669 +9034 2 2 13 11 3733 6215 4745 +9035 2 2 13 11 4481 4962 6660 +9036 2 2 13 11 4232 6370 5263 +9037 2 2 13 11 4233 5264 6371 +9038 2 2 13 11 4605 5295 6156 +9039 2 2 13 11 4606 6157 5296 +9040 2 2 13 11 4454 6554 4824 +9041 2 2 13 11 4165 5611 6932 +9042 2 2 13 11 4945 5175 6042 +9043 2 2 13 11 4276 4805 5461 +9044 2 2 13 11 4277 5463 4806 +9045 2 2 13 11 4743 5288 6411 +9046 2 2 13 11 3812 5295 5400 +9047 2 2 13 11 3813 5401 5296 +9048 2 2 13 11 3987 4759 6782 +9049 2 2 13 11 5201 6558 5731 +9050 2 2 13 11 4127 5543 4726 +9051 2 2 13 11 4297 5920 4878 +9052 2 2 13 11 3907 4682 5921 +9053 2 2 13 11 3788 4865 5421 +9054 2 2 13 11 3676 4686 5521 +9055 2 2 13 11 4406 5324 5935 +9056 2 2 13 11 4491 4845 6890 +9057 2 2 13 11 104 4652 5980 +9058 2 2 13 11 3782 5276 5003 +9059 2 2 13 11 4388 5079 5393 +9060 2 2 13 11 4029 5285 5059 +9061 2 2 13 11 6348 4652 104 +9062 2 2 13 11 3929 4736 5891 +9063 2 2 13 11 4391 5765 6067 +9064 2 2 13 11 3759 4670 6412 +9065 2 2 13 11 3785 5162 5083 +9066 2 2 13 11 94 4710 6853 +9067 2 2 13 11 3791 5187 5052 +9068 2 2 13 11 4298 5400 5295 +9069 2 2 13 11 4299 5296 5401 +9070 2 2 13 11 4348 5247 5704 +9071 2 2 13 11 4407 6255 5102 +9072 2 2 13 11 4408 5103 6256 +9073 2 2 13 11 3756 4851 5482 +9074 2 2 13 11 4057 5974 5413 +9075 2 2 13 11 4364 5534 5601 +9076 2 2 13 11 4365 5602 5535 +9077 2 2 13 11 4348 5704 5576 +9078 2 2 13 11 3670 4854 5259 +9079 2 2 13 11 4217 5024 5311 +9080 2 2 13 11 4132 5052 5284 +9081 2 2 13 11 4398 5756 5359 +9082 2 2 13 11 4399 5360 5757 +9083 2 2 13 11 4431 6924 4778 +9084 2 2 13 11 4432 4779 6925 +9085 2 2 13 11 4189 4891 5779 +9086 2 2 13 11 4140 5470 4724 +9087 2 2 13 11 3743 5749 4657 +9088 2 2 13 11 4276 6009 4837 +9089 2 2 13 11 4277 4838 6010 +9090 2 2 13 11 4492 4907 6141 +9091 2 2 13 11 3937 6296 4698 +9092 2 2 13 11 3785 5083 5085 +9093 2 2 13 11 4695 3924 5930 +9094 2 2 13 11 4696 5931 3925 +9095 2 2 13 11 4530 5034 6558 +9096 2 2 13 11 3913 4716 6282 +9097 2 2 13 11 3806 6756 4841 +9098 2 2 13 11 3651 4831 5597 +9099 2 2 13 11 3812 4965 6156 +9100 2 2 13 11 3813 6157 4966 +9101 2 2 13 11 4196 5748 6362 +9102 2 2 13 11 3679 4707 6196 +9103 2 2 13 11 4329 5729 5120 +9104 2 2 13 11 4332 5790 6451 +9105 2 2 13 11 3832 4929 5447 +9106 2 2 13 11 4133 5542 4901 +9107 2 2 13 11 4718 5659 6616 +9108 2 2 13 11 4721 5559 6209 +9109 2 2 13 11 4449 6717 4905 +9110 2 2 13 11 4127 6348 5543 +9111 2 2 13 11 4499 5315 5960 +9112 2 2 13 11 4415 5332 5728 +9113 2 2 13 11 4036 6066 4690 +9114 2 2 13 11 4022 6278 5330 +9115 2 2 13 11 3678 4916 6882 +9116 2 2 13 11 3985 5089 6629 +9117 2 2 13 11 5050 6063 5575 +9118 2 2 13 11 3777 6558 5034 +9119 2 2 13 11 4756 6118 5636 +9120 2 2 13 11 3702 5797 4719 +9121 2 2 13 11 4353 4978 5415 +9122 2 2 13 11 4354 5416 4979 +9123 2 2 13 11 3882 5709 4766 +9124 2 2 13 11 4191 4689 6431 +9125 2 2 13 11 3694 4682 5904 +9126 2 2 13 11 4073 4929 5496 +9127 2 2 13 11 4359 4793 5340 +9128 2 2 13 11 4171 4705 5742 +9129 2 2 13 11 4086 5154 5187 +9130 2 2 13 11 4150 6788 4724 +9131 2 2 13 11 4106 5331 6047 +9132 2 2 13 11 4379 6065 4776 +9133 2 2 13 11 4514 6837 5134 +9134 2 2 13 11 4330 5314 5544 +9135 2 2 13 11 4134 5421 4865 +9136 2 2 13 11 4193 5146 6344 +9137 2 2 13 11 4048 6035 5317 +9138 2 2 13 11 4049 5318 6036 +9139 2 2 13 11 4189 6128 4891 +9140 2 2 13 11 3922 4687 6801 +9141 2 2 13 11 3992 5271 4872 +9142 2 2 13 11 161 4778 5583 +9143 2 2 13 11 60 5584 4779 +9144 2 2 13 11 3848 5014 5351 +9145 2 2 13 11 4744 5883 6177 +9146 2 2 13 11 88 89 5167 +9147 2 2 13 11 4249 4709 5785 +9148 2 2 13 11 4202 5667 4743 +9149 2 2 13 11 76 5883 4744 +9150 2 2 13 11 3911 5461 4805 +9151 2 2 13 11 4612 5984 6015 +9152 2 2 13 11 3912 4806 5463 +9153 2 2 13 11 3906 4666 6490 +9154 2 2 13 11 3678 4822 6746 +9155 2 2 13 11 4166 5630 4734 +9156 2 2 13 11 4167 4735 5631 +9157 2 2 13 11 330 5686 4972 +9158 2 2 13 11 246 4973 5687 +9159 2 2 13 11 3773 5855 5080 +9160 2 2 13 11 4524 5057 6836 +9161 2 2 13 11 3796 5454 5081 +9162 2 2 13 11 4731 5686 6481 +9163 2 2 13 11 4732 6482 5687 +9164 2 2 13 11 3897 6642 5417 +9165 2 2 13 11 4227 5346 4906 +9166 2 2 13 11 3898 5418 6643 +9167 2 2 13 11 4837 5333 6827 +9168 2 2 13 11 4838 6828 5334 +9169 2 2 13 11 128 6024 5468 +9170 2 2 13 11 3707 5945 5312 +9171 2 2 13 11 3886 6187 5754 +9172 2 2 13 11 3887 5755 6188 +9173 2 2 13 11 4170 5544 5314 +9174 2 2 13 11 3836 5102 6478 +9175 2 2 13 11 3837 6479 5103 +9176 2 2 13 11 5102 6878 6478 +9177 2 2 13 11 4111 4815 6381 +9178 2 2 13 11 5103 6479 6879 +9179 2 2 13 11 4164 5732 4968 +9180 2 2 13 11 4118 5394 4811 +9181 2 2 13 11 5227 6117 5802 +9182 2 2 13 11 4989 5540 6813 +9183 2 2 13 11 3821 5340 4947 +9184 2 2 13 11 3907 5921 4680 +9185 2 2 13 11 4089 6900 5356 +9186 2 2 13 11 4100 5890 4717 +9187 2 2 13 11 4529 6850 5061 +9188 2 2 13 11 141 142 5146 +9189 2 2 13 11 293 5043 294 +9190 2 2 13 11 4097 5188 4920 +9191 2 2 13 11 4098 4921 5189 +9192 2 2 13 11 4436 6684 5946 +9193 2 2 13 11 3680 4950 5333 +9194 2 2 13 11 3825 6502 5196 +9195 2 2 13 11 3681 5334 4951 +9196 2 2 13 11 4140 5277 5090 +9197 2 2 13 11 4395 6024 6171 +9198 2 2 13 11 4580 6745 5255 +9199 2 2 13 11 4309 5883 5143 +9200 2 2 13 11 3779 4671 6893 +9201 2 2 13 11 3686 5209 5502 +9202 2 2 13 11 4065 6696 4853 +9203 2 2 13 11 4161 4842 5583 +9204 2 2 13 11 4162 5584 4843 +9205 2 2 13 11 3760 6432 5065 +9206 2 2 13 11 3818 5118 5444 +9207 2 2 13 11 4364 6948 4734 +9208 2 2 13 11 4365 4735 6949 +9209 2 2 13 11 4161 5583 4778 +9210 2 2 13 11 4162 4779 5584 +9211 2 2 13 11 4745 5802 5022 +9212 2 2 13 11 4135 4751 5532 +9213 2 2 13 11 4201 5234 6680 +9214 2 2 13 11 4136 5533 4752 +9215 2 2 13 11 4232 5970 6370 +9216 2 2 13 11 6813 5540 4446 +9217 2 2 13 11 4233 6371 5971 +9218 2 2 13 11 4651 5195 6181 +9219 2 2 13 11 291 5620 4793 +9220 2 2 13 11 3764 4864 5278 +9221 2 2 13 11 4142 6190 5606 +9222 2 2 13 11 279 5048 280 +9223 2 2 13 11 4370 5307 6112 +9224 2 2 13 11 4273 6051 5221 +9225 2 2 13 11 3783 5163 5371 +9226 2 2 13 11 4654 6362 5748 +9227 2 2 13 11 4143 5148 5126 +9228 2 2 13 11 335 5055 336 +9229 2 2 13 11 240 5056 241 +9230 2 2 13 11 3810 4737 6033 +9231 2 2 13 11 4103 6209 5559 +9232 2 2 13 11 3783 5371 6881 +9233 2 2 13 11 4307 4972 5457 +9234 2 2 13 11 4308 5458 4973 +9235 2 2 13 11 3825 5610 6502 +9236 2 2 13 11 4201 6680 5903 +9237 2 2 13 11 3680 6298 6035 +9238 2 2 13 11 3681 6036 6299 +9239 2 2 13 11 4015 5199 4917 +9240 2 2 13 11 4043 5739 4799 +9241 2 2 13 11 4304 6048 6274 +9242 2 2 13 11 4016 4918 5200 +9243 2 2 13 11 4338 5467 5180 +9244 2 2 13 11 4014 6739 5287 +9245 2 2 13 11 277 5626 4797 +9246 2 2 13 11 4107 6794 5043 +9247 2 2 13 11 4250 5758 5692 +9248 2 2 13 11 4522 5417 6100 +9249 2 2 13 11 3753 4768 6851 +9250 2 2 13 11 4251 5694 5759 +9251 2 2 13 11 4523 6102 5418 +9252 2 2 13 11 4454 4824 6776 +9253 2 2 13 11 3803 6169 4780 +9254 2 2 13 11 4280 5359 5411 +9255 2 2 13 11 4281 5412 5360 +9256 2 2 13 11 144 145 5455 +9257 2 2 13 11 3730 5450 5603 +9258 2 2 13 11 4193 6344 5766 +9259 2 2 13 11 4575 5715 6571 +9260 2 2 13 11 3941 5647 5366 +9261 2 2 13 11 3942 5367 5648 +9262 2 2 13 11 4004 4916 5273 +9263 2 2 13 11 4027 6560 4758 +9264 2 2 13 11 148 149 5268 +9265 2 2 13 11 4198 6641 5695 +9266 2 2 13 11 3986 6573 5060 +9267 2 2 13 11 3723 5871 4787 +9268 2 2 13 11 4292 5531 5231 +9269 2 2 13 11 3842 4770 5991 +9270 2 2 13 11 4280 5411 6156 +9271 2 2 13 11 4281 6157 5412 +9272 2 2 13 11 4030 5090 5277 +9273 2 2 13 11 3892 5832 6534 +9274 2 2 13 11 3893 6535 5833 +9275 2 2 13 11 4111 4774 6222 +9276 2 2 13 11 4703 4731 6091 +9277 2 2 13 11 4704 6092 4732 +9278 2 2 13 11 4090 6107 4712 +9279 2 2 13 11 4063 6100 5417 +9280 2 2 13 11 4064 5418 6102 +9281 2 2 13 11 4250 5322 5263 +9282 2 2 13 11 4251 5264 5323 +9283 2 2 13 11 4185 4692 5963 +9284 2 2 13 11 4137 5393 5079 +9285 2 2 13 11 4579 5139 6728 +9286 2 2 13 11 4667 5754 6187 +9287 2 2 13 11 4668 6188 5755 +9288 2 2 13 11 307 4830 5622 +9289 2 2 13 11 4169 5231 5531 +9290 2 2 13 11 3650 4899 5229 +9291 2 2 13 11 4637 6555 6323 +9292 2 2 13 11 4458 6640 6724 +9293 2 2 13 11 4378 4683 5972 +9294 2 2 13 11 3770 5042 5357 +9295 2 2 13 11 160 5583 4842 +9296 2 2 13 11 61 4843 5584 +9297 2 2 13 11 164 4909 5369 +9298 2 2 13 11 57 5370 4910 +9299 2 2 13 11 3907 5908 4682 +9300 2 2 13 11 4374 5628 5634 +9301 2 2 13 11 4375 5635 5629 +9302 2 2 13 11 4010 4958 5488 +9303 2 2 13 11 4108 5797 4681 +9304 2 2 13 11 5611 6735 3784 +9305 2 2 13 11 3699 6810 5289 +9306 2 2 13 11 4623 5359 6074 +9307 2 2 13 11 4624 6075 5360 +9308 2 2 13 11 4029 4942 5285 +9309 2 2 13 11 4661 5876 6337 +9310 2 2 13 11 3967 5819 4768 +9311 2 2 13 11 6178 6792 3703 +9312 2 2 13 11 3780 5480 4863 +9313 2 2 13 11 6179 3704 6793 +9314 2 2 13 11 4212 6349 5845 +9315 2 2 13 11 3755 5817 4715 +9316 2 2 13 11 4172 5752 4711 +9317 2 2 13 11 4621 5004 5854 +9318 2 2 13 11 4385 5317 5585 +9319 2 2 13 11 4386 5586 5318 +9320 2 2 13 11 106 6542 4726 +9321 2 2 13 11 4086 5454 5154 +9322 2 2 13 11 4529 5892 5023 +9323 2 2 13 11 4485 5644 5552 +9324 2 2 13 11 4004 6511 4916 +9325 2 2 13 11 4777 5695 6641 +9326 2 2 13 11 4081 4917 5199 +9327 2 2 13 11 4082 5200 4918 +9328 2 2 13 11 3936 4787 5582 +9329 2 2 13 11 3714 4722 5862 +9330 2 2 13 11 3715 5863 4723 +9331 2 2 13 11 4008 5926 5166 +9332 2 2 13 11 3665 5721 4958 +9333 2 2 13 11 3701 4762 5563 +9334 2 2 13 11 3906 4803 5523 +9335 2 2 13 11 3937 4729 6145 +9336 2 2 13 11 3722 5552 5644 +9337 2 2 13 11 4428 6213 6715 +9338 2 2 13 11 4960 6682 6727 +9339 2 2 13 11 4083 4787 6021 +9340 2 2 13 11 4625 5413 5974 +9341 2 2 13 11 3974 6072 6816 +9342 2 2 13 11 4832 6286 5149 +9343 2 2 13 11 3984 4894 5319 +9344 2 2 13 11 4098 4946 5279 +9345 2 2 13 11 4150 4724 6711 +9346 2 2 13 11 4725 6284 5001 +9347 2 2 13 11 3874 6272 5238 +9348 2 2 13 11 3876 5239 6273 +9349 2 2 13 11 3742 5549 4798 +9350 2 2 13 11 5221 6051 6232 +9351 2 2 13 11 4191 6047 4689 +9352 2 2 13 11 4496 5004 6782 +9353 2 2 13 11 4407 4911 6520 +9354 2 2 13 11 4408 6521 4912 +9355 2 2 13 11 4006 6222 4774 +9356 2 2 13 11 4231 4942 5197 +9357 2 2 13 11 4658 5254 6841 +9358 2 2 13 11 4441 6272 4784 +9359 2 2 13 11 4442 4785 6273 +9360 2 2 13 11 4094 6941 4851 +9361 2 2 13 11 69 5708 4850 +9362 2 2 13 11 4404 6703 5843 +9363 2 2 13 11 4199 5858 4694 +9364 2 2 13 11 4427 6682 4960 +9365 2 2 13 11 3921 6344 4738 +9366 2 2 13 11 3742 5854 5004 +9367 2 2 13 11 4909 6722 5369 +9368 2 2 13 11 4910 5370 6723 +9369 2 2 13 11 4605 6156 5411 +9370 2 2 13 11 4606 5412 6157 +9371 2 2 13 11 3677 4758 6267 +9372 2 2 13 11 4025 4768 5778 +9373 2 2 13 11 4615 5988 5978 +9374 2 2 13 11 4415 5728 6464 +9375 2 2 13 11 3865 4952 6232 +9376 2 2 13 11 4280 6074 5359 +9377 2 2 13 11 4720 6171 5380 +9378 2 2 13 11 4281 5360 6075 +9379 2 2 13 11 5261 5717 6361 +9380 2 2 13 11 4400 4908 6406 +9381 2 2 13 11 4470 5303 6135 +9382 2 2 13 11 4198 5891 4736 +9383 2 2 13 11 4536 5739 5928 +9384 2 2 13 11 3664 6597 4848 +9385 2 2 13 11 3719 5415 4978 +9386 2 2 13 11 3720 4979 5416 +9387 2 2 13 11 4035 6700 4858 +9388 2 2 13 11 4435 4848 6597 +9389 2 2 13 11 3733 4774 5714 +9390 2 2 13 11 3694 5779 4891 +9391 2 2 13 11 4103 5466 4940 +9392 2 2 13 11 313 5097 314 +9393 2 2 13 11 262 5098 263 +9394 2 2 13 11 166 167 5077 +9395 2 2 13 11 54 55 5078 +9396 2 2 13 11 3970 5655 4780 +9397 2 2 13 11 4128 5852 4771 +9398 2 2 13 11 4129 4772 5853 +9399 2 2 13 11 4344 5958 5084 +9400 2 2 13 11 3783 6881 5703 +9401 2 2 13 11 306 6014 4830 +9402 2 2 13 11 4487 4913 6777 +9403 2 2 13 11 3881 6461 5152 +9404 2 2 13 11 4520 5312 5945 +9405 2 2 13 11 321 5363 6056 +9406 2 2 13 11 255 6057 5364 +9407 2 2 13 11 3911 4771 5852 +9408 2 2 13 11 3912 5853 4772 +9409 2 2 13 11 3727 4804 5508 +9410 2 2 13 11 4044 5235 5006 +9411 2 2 13 11 4199 4694 5744 +9412 2 2 13 11 4045 5007 5236 +9413 2 2 13 11 4718 4988 5786 +9414 2 2 13 11 3926 6126 4739 +9415 2 2 13 11 3840 5659 4718 +9416 2 2 13 11 4209 4903 5275 +9417 2 2 13 11 3676 5485 5050 +9418 2 2 13 11 4099 5508 4804 +9419 2 2 13 11 3816 5475 6353 +9420 2 2 13 11 3817 6354 5476 +9421 2 2 13 11 3920 4717 5890 +9422 2 2 13 11 3866 5084 5958 +9423 2 2 13 11 4007 4761 5592 +9424 2 2 13 11 3954 6836 6738 +9425 2 2 13 11 5121 6143 6308 +9426 2 2 13 11 4321 5564 5688 +9427 2 2 13 11 3695 5359 5756 +9428 2 2 13 11 3900 6015 5984 +9429 2 2 13 11 3696 5757 5360 +9430 2 2 13 11 4150 5187 5154 +9431 2 2 13 11 3948 6484 4746 +9432 2 2 13 11 4478 6746 4822 +9433 2 2 13 11 3932 6466 4789 +9434 2 2 13 11 3901 5572 4754 +9435 2 2 13 11 3659 5185 5005 +9436 2 2 13 11 4161 4778 5897 +9437 2 2 13 11 4162 5898 4779 +9438 2 2 13 11 4097 5304 4982 +9439 2 2 13 11 4074 4880 5469 +9440 2 2 13 11 4433 5366 5647 +9441 2 2 13 11 4384 5279 4946 +9442 2 2 13 11 4434 5648 5367 +9443 2 2 13 11 4150 5052 5187 +9444 2 2 13 11 4027 5241 5745 +9445 2 2 13 11 4276 6358 4805 +9446 2 2 13 11 4627 5975 5554 +9447 2 2 13 11 4053 6286 5915 +9448 2 2 13 11 4628 5555 5976 +9449 2 2 13 11 4277 4806 6359 +9450 2 2 13 11 4237 5864 5055 +9451 2 2 13 11 4238 5056 5865 +9452 2 2 13 11 4156 4751 5955 +9453 2 2 13 11 4157 5956 4752 +9454 2 2 13 11 4569 6052 5563 +9455 2 2 13 11 3691 4901 5542 +9456 2 2 13 11 4213 6332 6175 +9457 2 2 13 11 4260 5563 6052 +9458 2 2 13 11 6833 4125 5483 +9459 2 2 13 11 4811 5287 6739 +9460 2 2 13 11 4594 5330 6278 +9461 2 2 13 11 4184 4766 5709 +9462 2 2 13 11 4073 6639 4824 +9463 2 2 13 11 150 4982 6350 +9464 2 2 13 11 4141 6185 5770 +9465 2 2 13 11 3927 5903 4714 +9466 2 2 13 11 4586 5152 6461 +9467 2 2 13 11 3784 6735 5325 +9468 2 2 13 11 4260 4740 6082 +9469 2 2 13 11 323 4897 5404 +9470 2 2 13 11 253 5405 4898 +9471 2 2 13 11 3662 6786 5719 +9472 2 2 13 11 3663 5720 6787 +9473 2 2 13 11 4460 5218 6184 +9474 2 2 13 11 3664 4848 5448 +9475 2 2 13 11 4054 5407 6242 +9476 2 2 13 11 6670 6260 3947 +9477 2 2 13 11 4184 5973 4766 +9478 2 2 13 11 3972 6776 4824 +9479 2 2 13 11 3797 5035 6114 +9480 2 2 13 11 3798 6115 5036 +9481 2 2 13 11 4627 6096 5975 +9482 2 2 13 11 4628 5976 6097 +9483 2 2 13 11 274 5156 5559 +9484 2 2 13 11 3771 5538 4802 +9485 2 2 13 11 4497 6779 4796 +9486 2 2 13 11 4113 4816 5681 +9487 2 2 13 11 4169 5700 5231 +9488 2 2 13 11 4125 5310 5048 +9489 2 2 13 11 3987 5065 6259 +9490 2 2 13 11 3735 5718 4931 +9491 2 2 13 11 4293 4863 5480 +9492 2 2 13 11 4200 6122 5091 +9493 2 2 13 11 4781 5922 5706 +9494 2 2 13 11 4192 5050 5485 +9495 2 2 13 11 4222 5335 5190 +9496 2 2 13 11 5109 5964 6734 +9497 2 2 13 11 3752 5244 4913 +9498 2 2 13 11 4015 4917 6372 +9499 2 2 13 11 4092 4891 5358 +9500 2 2 13 11 3754 5469 4880 +9501 2 2 13 11 4016 6373 4918 +9502 2 2 13 11 3700 4906 5346 +9503 2 2 13 11 4519 4798 6783 +9504 2 2 13 11 3728 5451 6450 +9505 2 2 13 11 4228 5229 4983 +9506 2 2 13 11 3677 5255 6745 +9507 2 2 13 11 4574 6683 5665 +9508 2 2 13 11 4903 6790 6027 +9509 2 2 13 11 4729 5892 3709 +9510 2 2 13 11 4152 5512 5726 +9511 2 2 13 11 85 6538 5288 +9512 2 2 13 11 4227 4906 5987 +9513 2 2 13 11 4107 5419 6881 +9514 2 2 13 11 3948 5702 5579 +9515 2 2 13 11 3695 5411 5359 +9516 2 2 13 11 4123 5706 5922 +9517 2 2 13 11 3696 5360 5412 +9518 2 2 13 11 3717 6228 6201 +9519 2 2 13 11 3957 6763 6850 +9520 2 2 13 11 4357 6455 5067 +9521 2 2 13 11 3697 4746 6901 +9522 2 2 13 11 297 5286 4949 +9523 2 2 13 11 4095 5265 5431 +9524 2 2 13 11 4096 5432 5266 +9525 2 2 13 11 103 5980 6340 +9526 2 2 13 11 4198 4730 5891 +9527 2 2 13 11 4631 5523 6336 +9528 2 2 13 11 4403 4985 6690 +9529 2 2 13 11 73 5386 4959 +9530 2 2 13 11 4316 6008 5568 +9531 2 2 13 11 4097 5777 4849 +9532 2 2 13 11 3769 4791 5428 +9533 2 2 13 11 3770 5429 4792 +9534 2 2 13 11 3882 4823 6405 +9535 2 2 13 11 4907 6260 6670 +9536 2 2 13 11 4600 5568 6008 +9537 2 2 13 11 4101 5599 4889 +9538 2 2 13 11 4558 6946 5941 +9539 2 2 13 11 4070 6303 5129 +9540 2 2 13 11 4118 4811 6739 +9541 2 2 13 11 4071 5130 6304 +9542 2 2 13 11 3651 4981 5882 +9543 2 2 13 11 3678 6376 4822 +9544 2 2 13 11 4022 5330 4985 +9545 2 2 13 11 3756 5482 4795 +9546 2 2 13 11 78 5373 5143 +9547 2 2 13 11 4102 4807 6136 +9548 2 2 13 11 3911 6070 4771 +9549 2 2 13 11 156 157 5486 +9550 2 2 13 11 64 65 5487 +9551 2 2 13 11 3912 4772 6071 +9552 2 2 13 11 4232 5210 5536 +9553 2 2 13 11 4233 5537 5211 +9554 2 2 13 11 4234 4781 6089 +9555 2 2 13 11 4083 6483 4865 +9556 2 2 13 11 4380 6232 4952 +9557 2 2 13 11 3724 6337 5876 +9558 2 2 13 11 4182 4745 6215 +9559 2 2 13 11 4330 5544 5124 +9560 2 2 13 11 4179 6420 4782 +9561 2 2 13 11 3902 5684 4722 +9562 2 2 13 11 3903 4723 5685 +9563 2 2 13 11 3677 6745 5241 +9564 2 2 13 11 4568 5845 6349 +9565 2 2 13 11 4081 6194 4917 +9566 2 2 13 11 4082 4918 6195 +9567 2 2 13 11 6792 5141 3703 +9568 2 2 13 11 6793 3704 5142 +9569 2 2 13 11 4231 4780 6169 +9570 2 2 13 11 4236 5928 4995 +9571 2 2 13 11 3666 6520 4911 +9572 2 2 13 11 3667 4912 6521 +9573 2 2 13 11 4026 5924 4775 +9574 2 2 13 11 3731 5489 4860 +9575 2 2 13 11 115 4811 5394 +9576 2 2 13 11 3891 6184 5218 +9577 2 2 13 11 4197 4900 5305 +9578 2 2 13 11 3732 4861 5490 +9579 2 2 13 11 4911 6288 5207 +9580 2 2 13 11 4912 5208 6289 +9581 2 2 13 11 3985 6629 4880 +9582 2 2 13 11 4581 5778 6094 +9583 2 2 13 11 152 4849 5777 +9584 2 2 13 11 6688 4501 5587 +9585 2 2 13 11 4050 5333 4950 +9586 2 2 13 11 4051 4951 5334 +9587 2 2 13 11 4895 6210 5930 +9588 2 2 13 11 4896 5931 6211 +9589 2 2 13 11 4302 6109 5376 +9590 2 2 13 11 4326 6405 4823 +9591 2 2 13 11 4303 5377 6111 +9592 2 2 13 11 3840 4718 5786 +9593 2 2 13 11 4234 6206 4781 +9594 2 2 13 11 3860 4940 5466 +9595 2 2 13 11 4085 5016 5374 +9596 2 2 13 11 4445 5196 6363 +9597 2 2 13 11 320 5363 321 +9598 2 2 13 11 255 5364 256 +9599 2 2 13 11 4141 5770 5192 +9600 2 2 13 11 4357 5067 5799 +9601 2 2 13 11 4095 6944 5322 +9602 2 2 13 11 4096 5323 6945 +9603 2 2 13 11 6842 4478 4822 +9604 2 2 13 11 4874 5173 6030 +9605 2 2 13 11 4875 6031 5174 +9606 2 2 13 11 4500 5851 5254 +9607 2 2 13 11 3830 5585 5317 +9608 2 2 13 11 3768 6693 4808 +9609 2 2 13 11 3831 5318 5586 +9610 2 2 13 11 3920 6456 4717 +9611 2 2 13 11 4282 6576 4826 +9612 2 2 13 11 4107 5116 6794 +9613 2 2 13 11 3833 5368 5808 +9614 2 2 13 11 3999 5675 4817 +9615 2 2 13 11 4829 6688 5587 +9616 2 2 13 11 4505 6268 6166 +9617 2 2 13 11 4000 4818 5676 +9618 2 2 13 11 3938 4744 6177 +9619 2 2 13 11 3907 4859 5908 +9620 2 2 13 11 3674 5895 5798 +9621 2 2 13 11 4204 5554 5975 +9622 2 2 13 11 4205 5976 5555 +9623 2 2 13 11 3751 6089 4781 +9624 2 2 13 11 3899 5889 4719 +9625 2 2 13 11 4588 6242 5407 +9626 2 2 13 11 3851 6650 5240 +9627 2 2 13 11 3981 6571 5715 +9628 2 2 13 11 4561 5038 5771 +9629 2 2 13 11 3846 5395 5838 +9630 2 2 13 11 85 86 6538 +9631 2 2 13 11 4153 6673 5372 +9632 2 2 13 11 3769 5812 5029 +9633 2 2 13 11 4046 6811 6614 +9634 2 2 13 11 4047 6615 6812 +9635 2 2 13 11 4346 5069 5242 +9636 2 2 13 11 3853 5379 5733 +9637 2 2 13 11 3746 6300 4926 +9638 2 2 13 11 3747 4927 6301 +9639 2 2 13 11 4717 6450 5451 +9640 2 2 13 11 3749 4801 5501 +9641 2 2 13 11 3768 4808 5656 +9642 2 2 13 11 4098 4850 5708 +9643 2 2 13 11 3905 5844 5120 +9644 2 2 13 11 3872 4826 5600 +9645 2 2 13 11 94 95 5383 +9646 2 2 13 11 3905 5978 5988 +9647 2 2 13 11 4351 5424 5113 +9648 2 2 13 11 4052 5935 5324 +9649 2 2 13 11 4352 5114 5425 +9650 2 2 13 11 3888 6116 6039 +9651 2 2 13 11 3966 5925 4808 +9652 2 2 13 11 5475 6476 6353 +9653 2 2 13 11 5476 6354 6477 +9654 2 2 13 11 4111 6222 4815 +9655 2 2 13 11 4346 5109 6734 +9656 2 2 13 11 3799 5292 5493 +9657 2 2 13 11 4099 4819 5869 +9658 2 2 13 11 4177 5365 6295 +9659 2 2 13 11 4100 5870 4820 +9660 2 2 13 11 4872 5705 6472 +9661 2 2 13 11 4194 5805 5937 +9662 2 2 13 11 4570 5241 6745 +9663 2 2 13 11 4532 6765 5859 +9664 2 2 13 11 3976 4965 6871 +9665 2 2 13 11 3977 6872 4966 +9666 2 2 13 11 3971 5393 4977 +9667 2 2 13 11 3802 6841 5254 +9668 2 2 13 11 4063 6288 5313 +9669 2 2 13 11 4064 5316 6289 +9670 2 2 13 11 4773 4994 6543 +9671 2 2 13 11 4055 4926 5352 +9672 2 2 13 11 4056 5353 4927 +9673 2 2 13 11 4997 5541 6936 +9674 2 2 13 11 4967 6833 5483 +9675 2 2 13 11 4131 4767 5715 +9676 2 2 13 11 4020 6770 5295 +9677 2 2 13 11 4021 5296 6771 +9678 2 2 13 11 4070 4938 5509 +9679 2 2 13 11 4071 5510 4939 +9680 2 2 13 11 4061 4892 5754 +9681 2 2 13 11 4062 5755 4893 +9682 2 2 13 11 3662 4809 6368 +9683 2 2 13 11 3663 6369 4810 +9684 2 2 13 11 4293 6308 6143 +9685 2 2 13 11 3771 4802 6952 +9686 2 2 13 11 3910 5506 5243 +9687 2 2 13 11 4589 5733 5379 +9688 2 2 13 11 6400 4729 3709 +9689 2 2 13 11 4185 4954 5361 +9690 2 2 13 11 4285 5493 5292 +9691 2 2 13 11 3794 6393 5431 +9692 2 2 13 11 3795 5432 6394 +9693 2 2 13 11 3981 5715 4767 +9694 2 2 13 11 3751 4781 5706 +9695 2 2 13 11 4253 6296 5140 +9696 2 2 13 11 3983 6561 6248 +9697 2 2 13 11 4008 6806 5926 +9698 2 2 13 11 99 100 6166 +9699 2 2 13 11 4214 6676 4867 +9700 2 2 13 11 4186 6896 4775 +9701 2 2 13 11 4380 5726 5512 +9702 2 2 13 11 4501 6629 5089 +9703 2 2 13 11 3767 4852 5915 +9704 2 2 13 11 4037 5645 6617 +9705 2 2 13 11 4038 6618 5646 +9706 2 2 13 11 4150 5284 5052 +9707 2 2 13 11 3678 4754 6376 +9708 2 2 13 11 4215 4849 6664 +9709 2 2 13 11 4216 6665 4850 +9710 2 2 13 11 4009 6607 5095 +9711 2 2 13 11 4094 4937 6941 +9712 2 2 13 11 3881 5681 4816 +9713 2 2 13 11 3913 6041 4716 +9714 2 2 13 11 4282 4789 6768 +9715 2 2 13 11 3742 6536 4840 +9716 2 2 13 11 4302 5109 5489 +9717 2 2 13 11 4303 5490 5110 +9718 2 2 13 11 4249 6728 5139 +9719 2 2 13 11 4665 5184 5768 +9720 2 2 13 11 274 5559 275 +9721 2 2 13 11 4340 4911 5651 +9722 2 2 13 11 4447 5808 5368 +9723 2 2 13 11 3727 6262 4804 +9724 2 2 13 11 4341 5652 4912 +9725 2 2 13 11 4686 5937 5805 +9726 2 2 13 11 3799 5396 6833 +9727 2 2 13 11 4329 5120 5844 +9728 2 2 13 11 4919 6881 5419 +9729 2 2 13 11 4332 6451 5481 +9730 2 2 13 11 3899 4769 5742 +9731 2 2 13 11 3947 6260 4862 +9732 2 2 13 11 3953 5987 4906 +9733 2 2 13 11 3725 5247 6280 +9734 2 2 13 11 5249 6844 6145 +9735 2 2 13 11 4074 5321 4928 +9736 2 2 13 11 4297 6401 4908 +9737 2 2 13 11 3938 6177 4864 +9738 2 2 13 11 4455 6278 5386 +9739 2 2 13 11 4099 5857 4819 +9740 2 2 13 11 147 148 6381 +9741 2 2 13 11 4524 6836 4833 +9742 2 2 13 11 4193 5217 5402 +9743 2 2 13 11 4059 6165 4798 +9744 2 2 13 11 4518 5372 6537 +9745 2 2 13 11 4612 6015 4943 +9746 2 2 13 11 4473 4877 6764 +9747 2 2 13 11 4100 4820 5890 +9748 2 2 13 11 3789 5712 4813 +9749 2 2 13 11 3790 4814 5713 +9750 2 2 13 11 3821 4919 5419 +9751 2 2 13 11 4963 5644 6436 +9752 2 2 13 11 4501 6688 6629 +9753 2 2 13 11 4497 5632 6951 +9754 2 2 13 11 3654 5045 5210 +9755 2 2 13 11 3679 4769 6069 +9756 2 2 13 11 145 6324 5455 +9757 2 2 13 11 3653 5211 5046 +9758 2 2 13 11 3936 6021 4787 +9759 2 2 13 11 4215 6210 5188 +9760 2 2 13 11 4216 5189 6211 +9761 2 2 13 11 4126 4925 5390 +9762 2 2 13 11 4105 5093 5272 +9763 2 2 13 11 322 6056 4897 +9764 2 2 13 11 254 4898 6057 +9765 2 2 13 11 4041 5251 4990 +9766 2 2 13 11 4042 4991 5252 +9767 2 2 13 11 3782 5088 5276 +9768 2 2 13 11 3756 5462 4851 +9769 2 2 13 11 4884 5452 6236 +9770 2 2 13 11 4885 6237 5453 +9771 2 2 13 11 3806 5689 5155 +9772 2 2 13 11 4391 5718 5765 +9773 2 2 13 11 3824 4821 6285 +9774 2 2 13 11 4075 6894 4988 +9775 2 2 13 11 3983 6710 4886 +9776 2 2 13 11 4179 4782 6705 +9777 2 2 13 11 4203 5908 4859 +9778 2 2 13 11 3962 6264 4971 +9779 2 2 13 11 4309 6177 5883 +9780 2 2 13 11 3841 5516 6139 +9781 2 2 13 11 4259 5030 5402 +9782 2 2 13 11 4101 4948 5599 +9783 2 2 13 11 4632 6198 5117 +9784 2 2 13 11 4282 5680 4789 +9785 2 2 13 11 4644 6820 6221 +9786 2 2 13 11 4784 5690 6678 +9787 2 2 13 11 4785 6679 5691 +9788 2 2 13 11 4215 5930 6210 +9789 2 2 13 11 4216 6211 5931 +9790 2 2 13 11 4413 5716 6280 +9791 2 2 13 11 71 6375 4946 +9792 2 2 13 11 4423 4982 5304 +9793 2 2 13 11 4385 5212 6028 +9794 2 2 13 11 4386 6029 5213 +9795 2 2 13 11 4532 5859 5215 +9796 2 2 13 11 4533 5216 5860 +9797 2 2 13 11 4135 5690 4751 +9798 2 2 13 11 4136 4752 5691 +9799 2 2 13 11 3660 6127 4755 +9800 2 2 13 11 4537 5579 5702 +9801 2 2 13 11 3826 4953 5497 +9802 2 2 13 11 4320 5513 5952 +9803 2 2 13 11 3773 6585 5855 +9804 2 2 13 11 4298 6079 5077 +9805 2 2 13 11 4299 5078 6080 +9806 2 2 13 11 4587 6309 5824 +9807 2 2 13 11 4119 6182 4860 +9808 2 2 13 11 4120 4861 6183 +9809 2 2 13 11 3923 4796 6342 +9810 2 2 13 11 4094 4851 5462 +9811 2 2 13 11 4225 4884 6236 +9812 2 2 13 11 4226 6237 4885 +9813 2 2 13 11 3679 6059 4769 +9814 2 2 13 11 3943 5384 5038 +9815 2 2 13 11 3972 4824 6639 +9816 2 2 13 11 4294 6262 6199 +9817 2 2 13 11 4470 5716 6691 +9818 2 2 13 11 4013 4829 6600 +9819 2 2 13 11 4234 4871 5459 +9820 2 2 13 11 4084 5610 5015 +9821 2 2 13 11 4115 5945 4862 +9822 2 2 13 11 4098 5708 4946 +9823 2 2 13 11 3933 5922 4781 +9824 2 2 13 11 4053 5813 5149 +9825 2 2 13 11 3941 5975 6096 +9826 2 2 13 11 3942 6097 5976 +9827 2 2 13 11 4259 6011 5030 +9828 2 2 13 11 3774 6160 4825 +9829 2 2 13 11 4345 5249 6145 +9830 2 2 13 11 4031 6205 4839 +9831 2 2 13 11 5215 5859 6457 +9832 2 2 13 11 5216 6458 5860 +9833 2 2 13 11 3987 6259 4759 +9834 2 2 13 11 4458 6330 5792 +9835 2 2 13 11 4124 5448 4848 +9836 2 2 13 11 4037 5536 5210 +9837 2 2 13 11 4038 5211 5537 +9838 2 2 13 11 4134 6953 5600 +9839 2 2 13 11 3788 6768 5302 +9840 2 2 13 11 4014 6543 4994 +9841 2 2 13 11 4645 6858 6699 +9842 2 2 13 11 3783 6181 5163 +9843 2 2 13 11 3991 5632 4870 +9844 2 2 13 11 4007 6351 4761 +9845 2 2 13 11 3932 4871 5888 +9846 2 2 13 11 4270 5301 5905 +9847 2 2 13 11 4542 6340 5980 +9848 2 2 13 11 4211 6893 5674 +9849 2 2 13 11 4693 5798 5895 +9850 2 2 13 11 3960 5177 5341 +9851 2 2 13 11 4050 4749 6839 +9852 2 2 13 11 3961 5342 5178 +9853 2 2 13 11 4051 6840 4750 +9854 2 2 13 11 4075 6616 4936 +9855 2 2 13 11 3701 5673 4846 +9856 2 2 13 11 3987 6782 5004 +9857 2 2 13 11 4104 5143 5373 +9858 2 2 13 11 3910 4755 6741 +9859 2 2 13 11 3826 6151 4953 +9860 2 2 13 11 329 5686 330 +9861 2 2 13 11 246 5687 247 +9862 2 2 13 11 4426 5430 6687 +9863 2 2 13 11 4111 6001 5025 +9864 2 2 13 11 3687 5725 5235 +9865 2 2 13 11 3824 6214 6728 +9866 2 2 13 11 3755 4866 5817 +9867 2 2 13 11 3801 5124 5544 +9868 2 2 13 11 3972 6639 4854 +9869 2 2 13 11 4250 5692 5265 +9870 2 2 13 11 4251 5266 5694 +9871 2 2 13 11 4207 5634 5628 +9872 2 2 13 11 4208 5629 5635 +9873 2 2 13 11 4192 6292 4881 +9874 2 2 13 11 3693 5390 5473 +9875 2 2 13 11 3963 5222 6854 +9876 2 2 13 11 4582 6254 5246 +9877 2 2 13 11 3779 4786 5711 +9878 2 2 13 11 4395 5468 6024 +9879 2 2 13 11 3758 5308 5818 +9880 2 2 13 11 4101 4889 5761 +9881 2 2 13 11 124 4777 6407 +9882 2 2 13 11 3671 5300 5040 +9883 2 2 13 11 3799 6833 5707 +9884 2 2 13 11 3804 5981 5536 +9885 2 2 13 11 4465 5939 5157 +9886 2 2 13 11 4466 5158 5940 +9887 2 2 13 11 3805 5537 5982 +9888 2 2 13 11 3861 4833 6152 +9889 2 2 13 11 4423 6350 4982 +9890 2 2 13 11 4006 4815 6222 +9891 2 2 13 11 4615 4955 5988 +9892 2 2 13 11 78 79 5373 +9893 2 2 13 11 4048 6028 4741 +9894 2 2 13 11 4049 4742 6029 +9895 2 2 13 11 6874 6506 4323 +9896 2 2 13 11 6875 4324 6507 +9897 2 2 13 11 4135 6678 5690 +9898 2 2 13 11 4136 5691 6679 +9899 2 2 13 11 4040 5854 4840 +9900 2 2 13 11 4974 6426 6019 +9901 2 2 13 11 4975 6020 6427 +9902 2 2 13 11 6472 5705 4358 +9903 2 2 13 11 4143 6846 4961 +9904 2 2 13 11 4908 6868 6412 +9905 2 2 13 11 3963 6854 6129 +9906 2 2 13 11 4634 4935 5934 +9907 2 2 13 11 4461 5232 6313 +9908 2 2 13 11 4134 5255 6762 +9909 2 2 13 11 4759 5309 6782 +9910 2 2 13 11 4048 4950 6035 +9911 2 2 13 11 4049 6036 4951 +9912 2 2 13 11 4144 5113 5424 +9913 2 2 13 11 4145 5425 5114 +9914 2 2 13 11 4537 6175 6332 +9915 2 2 13 11 4753 5108 5969 +9916 2 2 13 11 3829 5591 5279 +9917 2 2 13 11 3733 6939 4800 +9918 2 2 13 11 3990 6199 5039 +9919 2 2 13 11 3953 5464 4913 +9920 2 2 13 11 4730 6212 5891 +9921 2 2 13 11 4121 5055 5864 +9922 2 2 13 11 4122 5865 5056 +9923 2 2 13 11 4282 4826 6228 +9924 2 2 13 11 3946 5240 5799 +9925 2 2 13 11 3707 5814 4862 +9926 2 2 13 11 3933 4781 6206 +9927 2 2 13 11 4385 5585 5532 +9928 2 2 13 11 4386 5533 5586 +9929 2 2 13 11 3832 5496 4929 +9930 2 2 13 11 4097 4982 5777 +9931 2 2 13 11 3811 5402 5217 +9932 2 2 13 11 3710 6136 4807 +9933 2 2 13 11 4248 5179 5374 +9934 2 2 13 11 3929 5891 6212 +9935 2 2 13 11 4046 6614 4817 +9936 2 2 13 11 4968 5732 6751 +9937 2 2 13 11 5091 6122 5884 +9938 2 2 13 11 4144 5424 6766 +9939 2 2 13 11 4145 6767 5425 +9940 2 2 13 11 4047 4818 6615 +9941 2 2 13 11 152 6664 4849 +9942 2 2 13 11 69 4850 6665 +9943 2 2 13 11 86 87 5607 +9944 2 2 13 11 4068 6611 5069 +9945 2 2 13 11 4328 6116 5841 +9946 2 2 13 11 3927 4783 5968 +9947 2 2 13 11 4073 5496 5259 +9948 2 2 13 11 4114 5152 5979 +9949 2 2 13 11 3950 4873 5829 +9950 2 2 13 11 4248 5804 5339 +9951 2 2 13 11 4255 5447 4944 +9952 2 2 13 11 4699 5682 6752 +9953 2 2 13 11 4657 4940 5999 +9954 2 2 13 11 4700 6753 5683 +9955 2 2 13 11 3799 5493 6161 +9956 2 2 13 11 4040 4840 5745 +9957 2 2 13 11 3828 5304 5590 +9958 2 2 13 11 4262 5527 5471 +9959 2 2 13 11 4263 5472 5528 +9960 2 2 13 11 3978 4841 5723 +9961 2 2 13 11 4521 5380 5245 +9962 2 2 13 11 4033 6903 4868 +9963 2 2 13 11 4034 4869 6904 +9964 2 2 13 11 3938 4864 5836 +9965 2 2 13 11 4177 6295 5787 +9966 2 2 13 11 4713 6854 5222 +9967 2 2 13 11 4366 5107 6784 +9968 2 2 13 11 4108 5345 4980 +9969 2 2 13 11 4075 5044 6894 +9970 2 2 13 11 4327 6130 5593 +9971 2 2 13 11 4267 6829 5867 +9972 2 2 13 11 6868 3759 6412 +9973 2 2 13 11 280 5048 5310 +9974 2 2 13 11 4262 5471 5136 +9975 2 2 13 11 4263 5137 5472 +9976 2 2 13 11 123 6407 6569 +9977 2 2 13 11 4288 5243 5506 +9978 2 2 13 11 4347 6852 5110 +9979 2 2 13 11 3752 5827 4992 +9980 2 2 13 11 4557 5095 6607 +9981 2 2 13 11 147 4815 6435 +9982 2 2 13 11 4469 6351 5244 +9983 2 2 13 11 4088 5429 6575 +9984 2 2 13 11 6813 3675 5649 +9985 2 2 13 11 4119 5810 5072 +9986 2 2 13 11 4120 5073 5811 +9987 2 2 13 11 3845 5548 6224 +9988 2 2 13 11 4645 6699 5821 +9989 2 2 13 11 4253 6103 4857 +9990 2 2 13 11 3707 6221 6820 +9991 2 2 13 11 4812 5830 6747 +9992 2 2 13 11 4924 6807 6158 +9993 2 2 13 11 5110 6852 5965 +9994 2 2 13 11 6807 4001 6158 +9995 2 2 13 11 4001 5791 5003 +9996 2 2 13 11 3773 5080 5503 +9997 2 2 13 11 4099 4804 5857 +9998 2 2 13 11 4178 5234 5381 +9999 2 2 13 11 4175 5660 5384 +10000 2 2 13 11 4144 5590 4920 +10001 2 2 13 11 3924 4895 5930 +10002 2 2 13 11 4145 4921 5591 +10003 2 2 13 11 3925 5931 4896 +10004 2 2 13 11 4335 5356 5217 +10005 2 2 13 11 4137 4977 5393 +10006 2 2 13 11 4085 5374 5179 +10007 2 2 13 11 4631 6336 5507 +10008 2 2 13 11 3737 5612 4917 +10009 2 2 13 11 3738 4918 5613 +10010 2 2 13 11 3859 6892 4903 +10011 2 2 13 11 4384 4946 6375 +10012 2 2 13 11 4069 4987 5932 +10013 2 2 13 11 4478 6842 4976 +10014 2 2 13 11 4294 4804 6262 +10015 2 2 13 11 3722 5547 5091 +10016 2 2 13 11 4075 6226 5044 +10017 2 2 13 11 4010 5134 6837 +10018 2 2 13 11 4087 5872 5428 +10019 2 2 13 11 317 5182 318 +10020 2 2 13 11 258 5183 259 +10021 2 2 13 11 3878 5763 4932 +10022 2 2 13 11 3784 5875 4783 +10023 2 2 13 11 4309 4864 6177 +10024 2 2 13 11 3895 6493 6935 +10025 2 2 13 11 3907 6063 4859 +10026 2 2 13 11 298 4949 6352 +10027 2 2 13 11 3780 5033 5480 +10028 2 2 13 11 4273 6526 4887 +10029 2 2 13 11 3731 4860 6182 +10030 2 2 13 11 4914 6192 6164 +10031 2 2 13 11 3732 6183 4861 +10032 2 2 13 11 3927 6315 4801 +10033 2 2 13 11 3777 5781 5731 +10034 2 2 13 11 4161 6306 4842 +10035 2 2 13 11 4162 4843 6307 +10036 2 2 13 11 4108 4980 5658 +10037 2 2 13 11 4142 5300 6190 +10038 2 2 13 11 3765 5136 5471 +10039 2 2 13 11 3766 5472 5137 +10040 2 2 13 11 3799 6161 5396 +10041 2 2 13 11 4474 4956 6919 +10042 2 2 13 11 4102 6502 4807 +10043 2 2 13 11 3786 6019 6426 +10044 2 2 13 11 3787 6427 6020 +10045 2 2 13 11 4494 5397 5000 +10046 2 2 13 11 3973 6261 4835 +10047 2 2 13 11 4694 6900 6613 +10048 2 2 13 11 4036 4984 5408 +10049 2 2 13 11 155 156 5441 +10050 2 2 13 11 4789 5302 6768 +10051 2 2 13 11 65 66 5442 +10052 2 2 13 11 3918 4857 6103 +10053 2 2 13 11 4037 4933 5536 +10054 2 2 13 11 4214 5198 5329 +10055 2 2 13 11 4038 5537 4934 +10056 2 2 13 11 4336 5924 6360 +10057 2 2 13 11 4237 5055 5909 +10058 2 2 13 11 4238 5910 5056 +10059 2 2 13 11 3976 5580 6074 +10060 2 2 13 11 3977 6075 5581 +10061 2 2 13 11 4121 5031 6549 +10062 2 2 13 11 4122 6550 5032 +10063 2 2 13 11 5081 5454 6227 +10064 2 2 13 11 3816 5846 5475 +10065 2 2 13 11 3817 5476 5847 +10066 2 2 13 11 5429 6791 6575 +10067 2 2 13 11 4135 5532 5585 +10068 2 2 13 11 4136 5586 5533 +10069 2 2 13 11 4075 5053 6226 +10070 2 2 13 11 4234 4847 5888 +10071 2 2 13 11 4398 6476 4969 +10072 2 2 13 11 4399 4970 6477 +10073 2 2 13 11 4322 6285 4821 +10074 2 2 13 11 4514 5770 6185 +10075 2 2 13 11 4350 5929 6162 +10076 2 2 13 11 4193 5402 5030 +10077 2 2 13 11 4349 6600 5587 +10078 2 2 13 11 89 90 6374 +10079 2 2 13 11 4480 5071 6012 +10080 2 2 13 11 4794 6687 5430 +10081 2 2 13 11 4030 5277 5159 +10082 2 2 13 11 4043 6572 4995 +10083 2 2 13 11 3797 6114 5434 +10084 2 2 13 11 3798 5435 6115 +10085 2 2 13 11 3733 4839 6215 +10086 2 2 13 11 4357 5799 5240 +10087 2 2 13 11 5069 6611 5242 +10088 2 2 13 11 4019 6322 5379 +10089 2 2 13 11 4381 5038 5384 +10090 2 2 13 11 3659 6772 5478 +10091 2 2 13 11 4387 6499 4844 +10092 2 2 13 11 129 130 5225 +10093 2 2 13 11 4601 6240 6083 +10094 2 2 13 11 4117 5348 5085 +10095 2 2 13 11 4146 5497 4953 +10096 2 2 13 11 3916 5511 5197 +10097 2 2 13 11 4177 5787 5562 +10098 2 2 13 11 3755 6517 4866 +10099 2 2 13 11 4184 5817 4866 +10100 2 2 13 11 4199 5744 6499 +10101 2 2 13 11 3734 4900 6356 +10102 2 2 13 11 3779 6726 4786 +10103 2 2 13 11 4177 5430 5365 +10104 2 2 13 11 3939 5315 6112 +10105 2 2 13 11 4418 6023 5291 +10106 2 2 13 11 4147 5256 5609 +10107 2 2 13 11 3749 5507 6336 +10108 2 2 13 11 4110 4833 6495 +10109 2 2 13 11 132 5986 5596 +10110 2 2 13 11 4156 4969 6476 +10111 2 2 13 11 4157 6477 4970 +10112 2 2 13 11 4424 5818 5308 +10113 2 2 13 11 4325 5513 6224 +10114 2 2 13 11 4819 6749 6694 +10115 2 2 13 11 4820 6695 6750 +10116 2 2 13 11 4154 5575 6713 +10117 2 2 13 11 4112 6494 4834 +10118 2 2 13 11 3739 4886 6755 +10119 2 2 13 11 4492 5731 5781 +10120 2 2 13 11 4618 6867 6437 +10121 2 2 13 11 3879 5326 5193 +10122 2 2 13 11 4619 6438 6869 +10123 2 2 13 11 4253 5696 6296 +10124 2 2 13 11 3718 6313 5232 +10125 2 2 13 11 4688 5149 5813 +10126 2 2 13 11 3707 4862 5945 +10127 2 2 13 11 4121 6549 5055 +10128 2 2 13 11 4122 5056 6550 +10129 2 2 13 11 3922 5492 6662 +10130 2 2 13 11 4566 6478 6251 +10131 2 2 13 11 4567 6252 6479 +10132 2 2 13 11 4892 6506 6874 +10133 2 2 13 11 4893 6875 6507 +10134 2 2 13 11 4767 6707 5017 +10135 2 2 13 11 4007 5244 6351 +10136 2 2 13 11 3982 5643 5081 +10137 2 2 13 11 3823 4967 5483 +10138 2 2 13 11 4406 5935 4981 +10139 2 2 13 11 4788 6662 5492 +10140 2 2 13 11 4180 4931 5718 +10141 2 2 13 11 4985 5330 6690 +10142 2 2 13 11 4188 4932 5763 +10143 2 2 13 11 4235 4924 6158 +10144 2 2 13 11 3967 4976 6842 +10145 2 2 13 11 3861 5540 4922 +10146 2 2 13 11 3700 5261 5927 +10147 2 2 13 11 4410 6323 6555 +10148 2 2 13 11 4420 5339 5804 +10149 2 2 13 11 3849 5599 4948 +10150 2 2 13 11 4275 5911 6580 +10151 2 2 13 11 4170 5314 5701 +10152 2 2 13 11 4437 5074 6743 +10153 2 2 13 11 4141 5479 5127 +10154 2 2 13 11 4577 5012 5529 +10155 2 2 13 11 4578 5530 5013 +10156 2 2 13 11 3856 6940 4879 +10157 2 2 13 11 4105 6053 5093 +10158 2 2 13 11 4026 5526 6838 +10159 2 2 13 11 4117 5088 5688 +10160 2 2 13 11 4090 5633 4935 +10161 2 2 13 11 4009 4852 6607 +10162 2 2 13 11 4173 5457 4972 +10163 2 2 13 11 4174 4973 5458 +10164 2 2 13 11 3963 5732 5222 +10165 2 2 13 11 4658 4981 5935 +10166 2 2 13 11 4989 6813 5649 +10167 2 2 13 11 4323 6506 5129 +10168 2 2 13 11 4324 5130 6507 +10169 2 2 13 11 4297 4908 6412 +10170 2 2 13 11 4234 5888 4871 +10171 2 2 13 11 4316 4971 6264 +10172 2 2 13 11 3931 6164 6192 +10173 2 2 13 11 4053 5915 4852 +10174 2 2 13 11 4076 6436 5495 +10175 2 2 13 11 3759 6744 4870 +10176 2 2 13 11 3955 6305 5422 +10177 2 2 13 11 4206 6853 6789 +10178 2 2 13 11 4495 4952 6652 +10179 2 2 13 11 4460 6352 4949 +10180 2 2 13 11 3771 6764 6817 +10181 2 2 13 11 4152 6573 4890 +10182 2 2 13 11 3749 6336 4803 +10183 2 2 13 11 4126 5825 5503 +10184 2 2 13 11 3973 6329 4879 +10185 2 2 13 11 4360 5735 5455 +10186 2 2 13 11 4005 6658 4904 +10187 2 2 13 11 4517 6589 5151 +10188 2 2 13 11 4513 6382 6276 +10189 2 2 13 11 3826 5374 5016 +10190 2 2 13 11 4192 4881 6017 +10191 2 2 13 11 3791 6284 5187 +10192 2 2 13 11 4114 5979 5329 +10193 2 2 13 11 3713 5332 5834 +10194 2 2 13 11 4326 4823 6253 +10195 2 2 13 11 4228 5518 6025 +10196 2 2 13 11 4407 5651 4911 +10197 2 2 13 11 4408 4912 5652 +10198 2 2 13 11 3775 5105 5327 +10199 2 2 13 11 3776 5328 5106 +10200 2 2 13 11 3867 5789 4983 +10201 2 2 13 11 4589 5379 6322 +10202 2 2 13 11 3651 5899 4831 +10203 2 2 13 11 4553 6087 5525 +10204 2 2 13 11 4168 5477 6697 +10205 2 2 13 11 4011 4949 6174 +10206 2 2 13 11 4327 5902 6947 +10207 2 2 13 11 4161 4874 6306 +10208 2 2 13 11 4162 6307 4875 +10209 2 2 13 11 3789 5878 5445 +10210 2 2 13 11 3790 5446 5879 +10211 2 2 13 11 4382 4866 6517 +10212 2 2 13 11 4182 6215 4839 +10213 2 2 13 11 3852 4935 5633 +10214 2 2 13 11 4574 5665 6612 +10215 2 2 13 11 4128 5010 5697 +10216 2 2 13 11 4129 5698 5011 +10217 2 2 13 11 3652 6747 5830 +10218 2 2 13 11 4200 5091 5547 +10219 2 2 13 11 4223 4867 6016 +10220 2 2 13 11 3931 5151 6589 +10221 2 2 13 11 4087 5449 5872 +10222 2 2 13 11 4109 5351 5014 +10223 2 2 13 11 4218 4805 6759 +10224 2 2 13 11 4188 5884 6612 +10225 2 2 13 11 4219 6760 4806 +10226 2 2 13 11 4446 5872 5449 +10227 2 2 13 11 4112 5357 5042 +10228 2 2 13 11 4623 6074 5580 +10229 2 2 13 11 4624 5581 6075 +10230 2 2 13 11 4505 4956 6410 +10231 2 2 13 11 4210 5081 5643 +10232 2 2 13 11 3877 6141 5361 +10233 2 2 13 11 4362 4882 6040 +10234 2 2 13 11 3954 4943 6714 +10235 2 2 13 11 168 5031 6524 +10236 2 2 13 11 53 6525 5032 +10237 2 2 13 11 4462 5466 5156 +10238 2 2 13 11 3769 6655 5812 +10239 2 2 13 11 4074 6801 5321 +10240 2 2 13 11 163 164 5369 +10241 2 2 13 11 57 58 5370 +10242 2 2 13 11 3767 5915 5049 +10243 2 2 13 11 4110 6495 4902 +10244 2 2 13 11 4381 5384 5660 +10245 2 2 13 11 3993 6419 6491 +10246 2 2 13 11 4314 5341 5177 +10247 2 2 13 11 4315 5178 5342 +10248 2 2 13 11 5163 6181 6902 +10249 2 2 13 11 3746 4874 6030 +10250 2 2 13 11 3747 6031 4875 +10251 2 2 13 11 3989 4930 5641 +10252 2 2 13 11 3985 6544 5089 +10253 2 2 13 11 3918 6121 4857 +10254 2 2 13 11 4294 6338 4804 +10255 2 2 13 11 3956 6919 4956 +10256 2 2 13 11 3854 6506 4892 +10257 2 2 13 11 3855 4893 6507 +10258 2 2 13 11 4829 5587 6600 +10259 2 2 13 11 4066 5219 6583 +10260 2 2 13 11 4160 6176 5337 +10261 2 2 13 11 3669 6032 6774 +10262 2 2 13 11 4067 6584 5220 +10263 2 2 13 11 4184 4866 6013 +10264 2 2 13 11 3765 5471 5203 +10265 2 2 13 11 4368 5039 5460 +10266 2 2 13 11 3766 5204 5472 +10267 2 2 13 11 4418 5291 5999 +10268 2 2 13 11 3743 5999 5291 +10269 2 2 13 11 4377 6825 4906 +10270 2 2 13 11 4663 5793 5012 +10271 2 2 13 11 4664 5013 5794 +10272 2 2 13 11 3973 4835 6329 +10273 2 2 13 11 3727 5460 5039 +10274 2 2 13 11 4116 5525 6087 +10275 2 2 13 11 4112 4905 6494 +10276 2 2 13 11 4362 5876 4882 +10277 2 2 13 11 4231 5197 5511 +10278 2 2 13 11 5478 6772 6930 +10279 2 2 13 11 4405 4901 6556 +10280 2 2 13 11 4517 6347 5250 +10281 2 2 13 11 4225 5746 5409 +10282 2 2 13 11 4226 5410 5747 +10283 2 2 13 11 3954 4902 6495 +10284 2 2 13 11 4384 4959 5753 +10285 2 2 13 11 304 6220 4960 +10286 2 2 13 11 4321 6208 5176 +10287 2 2 13 11 4287 6329 4835 +10288 2 2 13 11 4040 5491 5138 +10289 2 2 13 11 4984 5389 6563 +10290 2 2 13 11 4416 5361 6141 +10291 2 2 13 11 4312 5957 4883 +10292 2 2 13 11 4121 6524 5031 +10293 2 2 13 11 4122 5032 6525 +10294 2 2 13 11 4322 5121 6073 +10295 2 2 13 11 4103 5156 5466 +10296 2 2 13 11 4913 5244 6777 +10297 2 2 13 11 3658 5901 6016 +10298 2 2 13 11 4132 5896 5052 +10299 2 2 13 11 4795 6491 6419 +10300 2 2 13 11 4252 4858 5689 +10301 2 2 13 11 3811 5217 5356 +10302 2 2 13 11 4201 5381 5234 +10303 2 2 13 11 4891 6128 5358 +10304 2 2 13 11 4127 4915 5800 +10305 2 2 13 11 4276 4837 6249 +10306 2 2 13 11 4277 6250 4838 +10307 2 2 13 11 3866 5824 6309 +10308 2 2 13 11 3870 6153 5414 +10309 2 2 13 11 3686 5502 5063 +10310 2 2 13 11 3802 4963 6841 +10311 2 2 13 11 4360 6498 5022 +10312 2 2 13 11 3957 6717 4955 +10313 2 2 13 11 4203 4859 6294 +10314 2 2 13 11 4148 5093 5439 +10315 2 2 13 11 4915 6201 4331 +10316 2 2 13 11 3764 5941 4864 +10317 2 2 13 11 4322 5500 6748 +10318 2 2 13 11 3957 6494 4905 +10319 2 2 13 11 5254 5851 6800 +10320 2 2 13 11 3791 5001 6284 +10321 2 2 13 11 4788 6508 6708 +10322 2 2 13 11 4203 6294 6121 +10323 2 2 13 11 4204 4974 6019 +10324 2 2 13 11 4205 6020 4975 +10325 2 2 13 11 4493 5562 5787 +10326 2 2 13 11 3959 6138 5627 +10327 2 2 13 11 4688 6582 5194 +10328 2 2 13 11 4063 5207 6288 +10329 2 2 13 11 4064 6289 5208 +10330 2 2 13 11 4534 5414 6153 +10331 2 2 13 11 299 5550 300 +10332 2 2 13 11 3722 5091 5552 +10333 2 2 13 11 4268 5902 5593 +10334 2 2 13 11 3847 6191 5539 +10335 2 2 13 11 73 74 5386 +10336 2 2 13 11 5400 5864 6864 +10337 2 2 13 11 5401 6865 5865 +10338 2 2 13 11 4499 6112 5315 +10339 2 2 13 11 4429 6056 5363 +10340 2 2 13 11 4430 5364 6057 +10341 2 2 13 11 3781 6017 4881 +10342 2 2 13 11 4286 5820 6314 +10343 2 2 13 11 4246 4930 6159 +10344 2 2 13 11 304 4960 6452 +10345 2 2 13 11 3954 6738 4943 +10346 2 2 13 11 285 4971 6154 +10347 2 2 13 11 3657 5171 5973 +10348 2 2 13 11 3808 5783 5281 +10349 2 2 13 11 4055 4842 6306 +10350 2 2 13 11 4056 6307 4843 +10351 2 2 13 11 4239 5529 5012 +10352 2 2 13 11 4240 5013 5530 +10353 2 2 13 11 4230 6192 4914 +10354 2 2 13 11 4554 6769 5385 +10355 2 2 13 11 3973 4879 6310 +10356 2 2 13 11 4020 4909 6770 +10357 2 2 13 11 4021 6771 4910 +10358 2 2 13 11 3694 4878 5779 +10359 2 2 13 11 4361 5598 4922 +10360 2 2 13 11 4209 5768 4903 +10361 2 2 13 11 70 4946 5708 +10362 2 2 13 11 3904 4867 5947 +10363 2 2 13 11 4165 4948 5611 +10364 2 2 13 11 4429 5343 6627 +10365 2 2 13 11 4430 6628 5344 +10366 2 2 13 11 5484 6708 6677 +10367 2 2 13 11 3780 4863 5995 +10368 2 2 13 11 3657 5564 5171 +10369 2 2 13 11 269 6090 5017 +10370 2 2 13 11 81 5761 4889 +10371 2 2 13 11 3834 5439 5093 +10372 2 2 13 11 4135 5585 6678 +10373 2 2 13 11 4136 6679 5586 +10374 2 2 13 11 3768 6624 5272 +10375 2 2 13 11 4060 5380 6171 +10376 2 2 13 11 4469 5795 4994 +10377 2 2 13 11 4298 6770 4909 +10378 2 2 13 11 4299 4910 6771 +10379 2 2 13 11 3741 4936 5905 +10380 2 2 13 11 4037 6617 4933 +10381 2 2 13 11 4038 4934 6618 +10382 2 2 13 11 4481 6660 5474 +10383 2 2 13 11 3989 6159 4930 +10384 2 2 13 11 4113 5190 5335 +10385 2 2 13 11 4669 6418 6548 +10386 2 2 13 11 4687 6829 6127 +10387 2 2 13 11 4114 5329 5198 +10388 2 2 13 11 3781 4857 6294 +10389 2 2 13 11 3676 5521 6500 +10390 2 2 13 11 335 5909 5055 +10391 2 2 13 11 241 5056 5910 +10392 2 2 13 11 3955 6000 6305 +10393 2 2 13 11 4448 6714 4943 +10394 2 2 13 11 296 5286 297 +10395 2 2 13 11 3670 6333 4854 +10396 2 2 13 11 4017 6062 5566 +10397 2 2 13 11 4018 5567 6064 +10398 2 2 13 11 4181 5193 5326 +10399 2 2 13 11 3730 6470 5184 +10400 2 2 13 11 4587 5824 6562 +10401 2 2 13 11 4121 5077 6524 +10402 2 2 13 11 4122 6525 5078 +10403 2 2 13 11 4218 5471 5527 +10404 2 2 13 11 4219 5528 5472 +10405 2 2 13 11 4295 6002 5655 +10406 2 2 13 11 3822 6176 5545 +10407 2 2 13 11 3829 4985 6458 +10408 2 2 13 11 4029 6429 4942 +10409 2 2 13 11 4626 5302 6466 +10410 2 2 13 11 4543 6025 5518 +10411 2 2 13 11 4917 5612 6372 +10412 2 2 13 11 5118 6672 5444 +10413 2 2 13 11 4918 6373 5613 +10414 2 2 13 11 4579 5917 5139 +10415 2 2 13 11 4373 6656 5561 +10416 2 2 13 11 3950 6783 6165 +10417 2 2 13 11 3992 4872 6472 +10418 2 2 13 11 4234 6089 4847 +10419 2 2 13 11 4415 5834 5332 +10420 2 2 13 11 4865 6483 5255 +10421 2 2 13 11 4398 4969 5756 +10422 2 2 13 11 3966 4831 6462 +10423 2 2 13 11 4399 5757 4970 +10424 2 2 13 11 4146 4958 5721 +10425 2 2 13 11 3947 5058 6670 +10426 2 2 13 11 4168 6697 5782 +10427 2 2 13 11 4382 6587 4866 +10428 2 2 13 11 4101 5761 5094 +10429 2 2 13 11 3792 4895 5639 +10430 2 2 13 11 3793 5640 4896 +10431 2 2 13 11 4172 5502 5209 +10432 2 2 13 11 4117 5320 5348 +10433 2 2 13 11 105 106 5543 +10434 2 2 13 11 3760 5181 6428 +10435 2 2 13 11 4853 6696 6709 +10436 2 2 13 11 3862 6832 5023 +10437 2 2 13 11 4394 5927 5261 +10438 2 2 13 11 3957 4955 6763 +10439 2 2 13 11 4074 5492 6801 +10440 2 2 13 11 4223 6126 5228 +10441 2 2 13 11 3746 4884 6300 +10442 2 2 13 11 3747 6301 4885 +10443 2 2 13 11 4083 6021 6483 +10444 2 2 13 11 4618 6437 5740 +10445 2 2 13 11 3844 5848 4945 +10446 2 2 13 11 4619 5741 6438 +10447 2 2 13 11 4370 6027 6223 +10448 2 2 13 11 4441 5238 6272 +10449 2 2 13 11 4330 6090 5314 +10450 2 2 13 11 4442 6273 5239 +10451 2 2 13 11 4230 4914 6263 +10452 2 2 13 11 4258 5455 5735 +10453 2 2 13 11 4517 6606 6347 +10454 2 2 13 11 4245 5551 5145 +10455 2 2 13 11 4003 6790 5768 +10456 2 2 13 11 3737 4917 6194 +10457 2 2 13 11 3738 6195 4918 +10458 2 2 13 11 4154 5050 5575 +10459 2 2 13 11 3743 5291 6713 +10460 2 2 13 11 3833 5661 5845 +10461 2 2 13 11 3689 5983 4999 +10462 2 2 13 11 3751 4847 6089 +10463 2 2 13 11 3875 4961 6730 +10464 2 2 13 11 4180 5925 4931 +10465 2 2 13 11 3958 4904 6809 +10466 2 2 13 11 4028 5560 6884 +10467 2 2 13 11 4010 4900 5807 +10468 2 2 13 11 3775 5327 5601 +10469 2 2 13 11 3776 5602 5328 +10470 2 2 13 11 3812 5400 6864 +10471 2 2 13 11 3813 6865 5401 +10472 2 2 13 11 4329 5281 5783 +10473 2 2 13 11 6651 4915 4331 +10474 2 2 13 11 3970 5104 5655 +10475 2 2 13 11 337 6549 5031 +10476 2 2 13 11 239 5032 6550 +10477 2 2 13 11 158 5111 6388 +10478 2 2 13 11 63 6389 5112 +10479 2 2 13 11 3682 6694 6749 +10480 2 2 13 11 4055 6306 4874 +10481 2 2 13 11 3683 6750 6695 +10482 2 2 13 11 4056 4875 6307 +10483 2 2 13 11 4070 5129 5452 +10484 2 2 13 11 4071 5453 5130 +10485 2 2 13 11 293 6245 5043 +10486 2 2 13 11 4158 4943 6738 +10487 2 2 13 11 4307 6942 4972 +10488 2 2 13 11 4308 4973 6943 +10489 2 2 13 11 4637 5542 6555 +10490 2 2 13 11 4449 4955 6717 +10491 2 2 13 11 4904 6658 5830 +10492 2 2 13 11 4008 5705 5000 +10493 2 2 13 11 4094 5571 4937 +10494 2 2 13 11 5180 5467 6509 +10495 2 2 13 11 5129 6506 5452 +10496 2 2 13 11 4155 5783 5135 +10497 2 2 13 11 5130 5453 6507 +10498 2 2 13 11 3829 6552 4985 +10499 2 2 13 11 4146 4953 6319 +10500 2 2 13 11 3953 4906 6825 +10501 2 2 13 11 4228 4983 5789 +10502 2 2 13 11 4845 6223 6027 +10503 2 2 13 11 3827 5202 6414 +10504 2 2 13 11 3678 6746 4924 +10505 2 2 13 11 280 5310 281 +10506 2 2 13 11 313 5822 5097 +10507 2 2 13 11 263 5098 5823 +10508 2 2 13 11 4857 6121 6294 +10509 2 2 13 11 279 6269 5048 +10510 2 2 13 11 4025 6712 5176 +10511 2 2 13 11 4666 6593 5866 +10512 2 2 13 11 4165 5949 4948 +10513 2 2 13 11 3800 5214 6880 +10514 2 2 13 11 4118 6739 4992 +10515 2 2 13 11 4297 4878 6335 +10516 2 2 13 11 4283 5601 5327 +10517 2 2 13 11 4264 6259 5065 +10518 2 2 13 11 4312 4883 6068 +10519 2 2 13 11 4284 5328 5602 +10520 2 2 13 11 4153 5493 5423 +10521 2 2 13 11 4109 5123 5767 +10522 2 2 13 11 4221 4863 6377 +10523 2 2 13 11 3781 6294 4859 +10524 2 2 13 11 137 6857 6420 +10525 2 2 13 11 4396 5409 5746 +10526 2 2 13 11 4397 5747 5410 +10527 2 2 13 11 4012 6073 5121 +10528 2 2 13 11 4579 6728 6214 +10529 2 2 13 11 140 5693 5030 +10530 2 2 13 11 3811 5858 4941 +10531 2 2 13 11 4739 6016 5901 +10532 2 2 13 11 4604 5799 5067 +10533 2 2 13 11 4425 6448 5671 +10534 2 2 13 11 4159 6763 4955 +10535 2 2 13 11 4029 5059 5837 +10536 2 2 13 11 4457 6205 5297 +10537 2 2 13 11 4903 5768 6790 +10538 2 2 13 11 4031 5297 6205 +10539 2 2 13 11 3878 4932 6082 +10540 2 2 13 11 3971 4846 6417 +10541 2 2 13 11 3810 6512 5290 +10542 2 2 13 11 3966 4931 5925 +10543 2 2 13 11 5830 6658 4417 +10544 2 2 13 11 332 5966 5020 +10545 2 2 13 11 244 5021 5967 +10546 2 2 13 11 4236 6041 4937 +10547 2 2 13 11 4260 4932 5665 +10548 2 2 13 11 4043 4995 5928 +10549 2 2 13 11 4897 6627 5992 +10550 2 2 13 11 4898 5993 6628 +10551 2 2 13 11 3959 6580 4825 +10552 2 2 13 11 4586 5901 5979 +10553 2 2 13 11 4033 5010 6903 +10554 2 2 13 11 4034 6904 5011 +10555 2 2 13 11 4119 4933 6172 +10556 2 2 13 11 3705 5037 6197 +10557 2 2 13 11 4120 6173 4934 +10558 2 2 13 11 4727 6230 6144 +10559 2 2 13 11 4655 5627 6138 +10560 2 2 13 11 166 5077 6079 +10561 2 2 13 11 55 6080 5078 +10562 2 2 13 11 3796 5154 5454 +10563 2 2 13 11 3657 5382 6349 +10564 2 2 13 11 3979 5859 6765 +10565 2 2 13 11 3999 6217 5160 +10566 2 2 13 11 4000 5161 6218 +10567 2 2 13 11 4368 5460 6331 +10568 2 2 13 11 4115 4862 6260 +10569 2 2 13 11 97 6410 4956 +10570 2 2 13 11 3978 5723 4998 +10571 2 2 13 11 4338 5180 6231 +10572 2 2 13 11 271 5347 272 +10573 2 2 13 11 3849 4948 5949 +10574 2 2 13 11 69 70 5708 +10575 2 2 13 11 4022 5753 4959 +10576 2 2 13 11 4187 5703 4919 +10577 2 2 13 11 5192 5770 6225 +10578 2 2 13 11 4381 6421 5524 +10579 2 2 13 11 4336 5260 5924 +10580 2 2 13 11 138 6011 5101 +10581 2 2 13 11 3842 5991 6654 +10582 2 2 13 11 3830 5697 5010 +10583 2 2 13 11 314 5097 6049 +10584 2 2 13 11 262 6050 5098 +10585 2 2 13 11 3831 5011 5698 +10586 2 2 13 11 146 5131 6324 +10587 2 2 13 11 5579 6332 6891 +10588 2 2 13 11 3870 6234 5198 +10589 2 2 13 11 4494 6191 5397 +10590 2 2 13 11 3701 5665 6683 +10591 2 2 13 11 4206 6160 4873 +10592 2 2 13 11 4403 6458 4985 +10593 2 2 13 11 4137 6094 4977 +10594 2 2 13 11 4221 5995 4863 +10595 2 2 13 11 3996 5238 5509 +10596 2 2 13 11 3752 4992 5795 +10597 2 2 13 11 3997 5510 5239 +10598 2 2 13 11 3818 6189 5573 +10599 2 2 13 11 4480 6619 5751 +10600 2 2 13 11 3966 6314 4931 +10601 2 2 13 11 4512 4928 6588 +10602 2 2 13 11 4641 6681 6078 +10603 2 2 13 11 3684 6396 6006 +10604 2 2 13 11 4206 5806 6853 +10605 2 2 13 11 3685 6007 6397 +10606 2 2 13 11 4373 6480 6656 +10607 2 2 13 11 4188 5552 5091 +10608 2 2 13 11 3819 6708 5484 +10609 2 2 13 11 4111 6381 5268 +10610 2 2 13 11 3781 4859 6017 +10611 2 2 13 11 4577 5566 6062 +10612 2 2 13 11 4578 6064 5567 +10613 2 2 13 11 4679 6500 5521 +10614 2 2 13 11 4142 5606 5957 +10615 2 2 13 11 4583 6493 5717 +10616 2 2 13 11 3774 4873 6160 +10617 2 2 13 11 3777 4968 5781 +10618 2 2 13 11 4186 5125 5642 +10619 2 2 13 11 4115 5781 6751 +10620 2 2 13 11 3669 5936 4923 +10621 2 2 13 11 288 5362 289 +10622 2 2 13 11 3913 6282 6219 +10623 2 2 13 11 295 5116 5989 +10624 2 2 13 11 4197 5807 4900 +10625 2 2 13 11 3691 6689 4901 +10626 2 2 13 11 4561 6774 5354 +10627 2 2 13 11 4418 6619 6023 +10628 2 2 13 11 4478 4976 5791 +10629 2 2 13 11 3892 5594 6948 +10630 2 2 13 11 3893 6949 5595 +10631 2 2 13 11 319 5554 320 +10632 2 2 13 11 256 5555 257 +10633 2 2 13 11 3780 5658 4980 +10634 2 2 13 11 4032 4964 6443 +10635 2 2 13 11 3972 4854 6602 +10636 2 2 13 11 4252 6702 4858 +10637 2 2 13 11 332 5020 6908 +10638 2 2 13 11 244 6909 5021 +10639 2 2 13 11 4141 5192 5760 +10640 2 2 13 11 4677 4886 6572 +10641 2 2 13 11 4349 5786 4988 +10642 2 2 13 11 4334 6026 5336 +10643 2 2 13 11 4155 5332 5729 +10644 2 2 13 11 4362 4888 6802 +10645 2 2 13 11 3651 6831 4981 +10646 2 2 13 11 3803 6155 5285 +10647 2 2 13 11 4571 6142 4894 +10648 2 2 13 11 282 5372 283 +10649 2 2 13 11 4569 5563 6938 +10650 2 2 13 11 3693 5825 5390 +10651 2 2 13 11 4325 6885 4883 +10652 2 2 13 11 4015 6372 5136 +10653 2 2 13 11 4016 5137 6373 +10654 2 2 13 11 3693 4944 6330 +10655 2 2 13 11 3926 5608 6610 +10656 2 2 13 11 5428 5872 6655 +10657 2 2 13 11 3826 5497 5804 +10658 2 2 13 11 3847 5397 6191 +10659 2 2 13 11 5460 6814 6331 +10660 2 2 13 11 4126 5503 5080 +10661 2 2 13 11 4244 5840 5637 +10662 2 2 13 11 3771 6817 5090 +10663 2 2 13 11 4178 6490 5614 +10664 2 2 13 11 3657 5320 5564 +10665 2 2 13 11 295 6794 5116 +10666 2 2 13 11 3828 6001 5304 +10667 2 2 13 11 4728 6569 6407 +10668 2 2 13 11 112 113 5336 +10669 2 2 13 11 4409 5596 5986 +10670 2 2 13 11 4517 5250 6630 +10671 2 2 13 11 4296 4998 5723 +10672 2 2 13 11 4223 5947 4867 +10673 2 2 13 11 3954 6714 4902 +10674 2 2 13 11 3737 5953 4868 +10675 2 2 13 11 3655 4902 6716 +10676 2 2 13 11 3738 4869 5954 +10677 2 2 13 11 4204 5975 4974 +10678 2 2 13 11 4205 4975 5976 +10679 2 2 13 11 269 5017 6707 +10680 2 2 13 11 3827 5672 5186 +10681 2 2 13 11 4529 5023 6832 +10682 2 2 13 11 4151 5084 6309 +10683 2 2 13 11 3867 5917 5789 +10684 2 2 13 11 3689 5079 5983 +10685 2 2 13 11 3914 6144 6230 +10686 2 2 13 11 3985 4954 6544 +10687 2 2 13 11 151 5777 4982 +10688 2 2 13 11 4805 6358 6759 +10689 2 2 13 11 4806 6760 6359 +10690 2 2 13 11 4512 6933 4954 +10691 2 2 13 11 3658 5979 5901 +10692 2 2 13 11 5155 5689 6700 +10693 2 2 13 11 3843 5230 5748 +10694 2 2 13 11 4437 6743 6101 +10695 2 2 13 11 4452 5796 6765 +10696 2 2 13 11 4225 6316 4926 +10697 2 2 13 11 4226 4927 6317 +10698 2 2 13 11 4085 5179 5938 +10699 2 2 13 11 4149 6200 5002 +10700 2 2 13 11 4185 6544 4954 +10701 2 2 13 11 3754 5331 5469 +10702 2 2 13 11 4225 6300 4884 +10703 2 2 13 11 4226 4885 6301 +10704 2 2 13 11 123 124 6407 +10705 2 2 13 11 4270 5905 6043 +10706 2 2 13 11 4460 4949 6895 +10707 2 2 13 11 4173 4972 5686 +10708 2 2 13 11 4174 5687 4973 +10709 2 2 13 11 4706 5184 6470 +10710 2 2 13 11 3771 5090 5538 +10711 2 2 13 11 4133 5517 6555 +10712 2 2 13 11 3957 4905 6717 +10713 2 2 13 11 4060 5245 5380 +10714 2 2 13 11 112 5336 6026 +10715 2 2 13 11 4088 6575 5521 +10716 2 2 13 11 4410 6123 5426 +10717 2 2 13 11 3900 6083 6240 +10718 2 2 13 11 4152 5726 5060 +10719 2 2 13 11 3818 5444 6189 +10720 2 2 13 11 4538 5756 4969 +10721 2 2 13 11 4539 4970 5757 +10722 2 2 13 11 4614 6530 5577 +10723 2 2 13 11 4344 5346 5672 +10724 2 2 13 11 3803 6002 6155 +10725 2 2 13 11 4279 5195 5814 +10726 2 2 13 11 3828 6457 5025 +10727 2 2 13 11 4245 5570 5551 +10728 2 2 13 11 3752 6578 5827 +10729 2 2 13 11 4259 6270 5101 +10730 2 2 13 11 4063 5417 5207 +10731 2 2 13 11 4064 5208 5418 +10732 2 2 13 11 4607 6298 6009 +10733 2 2 13 11 4608 6010 6299 +10734 2 2 13 11 4423 5304 6001 +10735 2 2 13 11 4373 5662 5082 +10736 2 2 13 11 3940 6709 6696 +10737 2 2 13 11 4359 5043 6245 +10738 2 2 13 11 3789 6325 5878 +10739 2 2 13 11 3790 5879 6326 +10740 2 2 13 11 4877 6817 6764 +10741 2 2 13 11 4218 5203 5471 +10742 2 2 13 11 4219 5472 5204 +10743 2 2 13 11 4374 5634 5257 +10744 2 2 13 11 4375 5258 5635 +10745 2 2 13 11 6627 3964 5992 +10746 2 2 13 11 3894 5577 6530 +10747 2 2 13 11 6628 5993 3965 +10748 2 2 13 11 3674 4988 6894 +10749 2 2 13 11 4143 5504 6846 +10750 2 2 13 11 4564 6810 6378 +10751 2 2 13 11 4968 6751 5781 +10752 2 2 13 11 4193 5030 5693 +10753 2 2 13 11 285 6663 4971 +10754 2 2 13 11 3697 6101 4957 +10755 2 2 13 11 4488 6386 5719 +10756 2 2 13 11 4489 5720 6387 +10757 2 2 13 11 3806 6265 6044 +10758 2 2 13 11 4366 5048 6269 +10759 2 2 13 11 3823 6128 4967 +10760 2 2 13 11 3865 6122 4952 +10761 2 2 13 11 3814 5221 5512 +10762 2 2 13 11 3771 6952 5228 +10763 2 2 13 11 320 5554 5363 +10764 2 2 13 11 256 5364 5555 +10765 2 2 13 11 4579 5789 5917 +10766 2 2 13 11 82 5094 5761 +10767 2 2 13 11 4575 5874 6012 +10768 2 2 13 11 4212 5348 5320 +10769 2 2 13 11 4161 5897 5173 +10770 2 2 13 11 4162 5174 5898 +10771 2 2 13 11 3694 6335 4878 +10772 2 2 13 11 4255 5551 5447 +10773 2 2 13 11 4079 5684 6598 +10774 2 2 13 11 4080 6599 5685 +10775 2 2 13 11 3993 6491 4957 +10776 2 2 13 11 3882 6405 5709 +10777 2 2 13 11 4248 5374 5804 +10778 2 2 13 11 3971 4977 6130 +10779 2 2 13 11 4480 6849 6619 +10780 2 2 13 11 4332 4986 5679 +10781 2 2 13 11 4143 5126 5818 +10782 2 2 13 11 4147 5609 5861 +10783 2 2 13 11 3868 5952 5513 +10784 2 2 13 11 4428 5259 5496 +10785 2 2 13 11 3731 5918 5008 +10786 2 2 13 11 3732 5009 5919 +10787 2 2 13 11 3762 5740 5313 +10788 2 2 13 11 3763 5316 5741 +10789 2 2 13 11 4569 6938 5223 +10790 2 2 13 11 4660 5524 6421 +10791 2 2 13 11 4582 5839 6740 +10792 2 2 13 11 4084 6231 5180 +10793 2 2 13 11 4338 5692 5758 +10794 2 2 13 11 4339 5759 5694 +10795 2 2 13 11 3905 5120 5978 +10796 2 2 13 11 3917 5392 6233 +10797 2 2 13 11 4654 5748 5230 +10798 2 2 13 11 4285 5423 5493 +10799 2 2 13 11 3825 5015 5610 +10800 2 2 13 11 3699 5642 5125 +10801 2 2 13 11 4328 5556 6116 +10802 2 2 13 11 4002 4989 6239 +10803 2 2 13 11 4189 5707 4967 +10804 2 2 13 11 4295 5655 5104 +10805 2 2 13 11 323 5404 324 +10806 2 2 13 11 252 5405 253 +10807 2 2 13 11 3930 5150 6078 +10808 2 2 13 11 3941 4974 5975 +10809 2 2 13 11 3942 5976 4975 +10810 2 2 13 11 4492 6568 4907 +10811 2 2 13 11 4199 4941 5858 +10812 2 2 13 11 127 128 5468 +10813 2 2 13 11 4400 6868 4908 +10814 2 2 13 11 4440 6708 6508 +10815 2 2 13 11 4496 5115 5549 +10816 2 2 13 11 4839 6205 5062 +10817 2 2 13 11 167 168 6524 +10818 2 2 13 11 53 54 6525 +10819 2 2 13 11 4575 6012 5071 +10820 2 2 13 11 3880 5494 6357 +10821 2 2 13 11 101 102 5385 +10822 2 2 13 11 3986 5443 5311 +10823 2 2 13 11 330 4972 6942 +10824 2 2 13 11 246 6943 4973 +10825 2 2 13 11 4144 5215 5590 +10826 2 2 13 11 5017 6090 6594 +10827 2 2 13 11 4145 5591 5216 +10828 2 2 13 11 4260 6082 4932 +10829 2 2 13 11 3915 4984 6563 +10830 2 2 13 11 148 5268 6381 +10831 2 2 13 11 316 5157 6004 +10832 2 2 13 11 260 6005 5158 +10833 2 2 13 11 3761 5433 5839 +10834 2 2 13 11 4679 5521 6575 +10835 2 2 13 11 84 6799 5667 +10836 2 2 13 11 4196 5395 6409 +10837 2 2 13 11 4225 4926 6300 +10838 2 2 13 11 4226 6301 4927 +10839 2 2 13 11 3758 6910 4894 +10840 2 2 13 11 3875 5638 5148 +10841 2 2 13 11 3989 4923 6159 +10842 2 2 13 11 3867 4983 6464 +10843 2 2 13 11 4119 5072 6182 +10844 2 2 13 11 4568 6349 5382 +10845 2 2 13 11 4120 6183 5073 +10846 2 2 13 11 4029 5837 5147 +10847 2 2 13 11 4141 5127 6185 +10848 2 2 13 11 3981 5124 6571 +10849 2 2 13 11 3874 4969 5955 +10850 2 2 13 11 3876 5956 4970 +10851 2 2 13 11 4138 5588 5168 +10852 2 2 13 11 4139 5169 5589 +10853 2 2 13 11 1 6268 98 +10854 2 2 13 11 90 91 5617 +10855 2 2 13 11 3693 5996 5825 +10856 2 2 13 11 4150 5154 6788 +10857 2 2 13 11 151 152 5777 +10858 2 2 13 11 3679 5054 6059 +10859 2 2 13 11 4481 5474 6905 +10860 2 2 13 11 4389 6388 5111 +10861 2 2 13 11 4390 5112 6389 +10862 2 2 13 11 4119 6172 5810 +10863 2 2 13 11 4120 5811 6173 +10864 2 2 13 11 4949 5286 6174 +10865 2 2 13 11 3740 6143 5121 +10866 2 2 13 11 3782 5688 5088 +10867 2 2 13 11 4188 6612 4932 +10868 2 2 13 11 4406 5597 5439 +10869 2 2 13 11 4614 5464 6530 +10870 2 2 13 11 3711 6630 5250 +10871 2 2 13 11 4557 5592 5095 +10872 2 2 13 11 130 131 6266 +10873 2 2 13 11 4612 6155 6002 +10874 2 2 13 11 3686 5063 5803 +10875 2 2 13 11 3812 6864 4965 +10876 2 2 13 11 3813 4966 6865 +10877 2 2 13 11 4570 5745 5241 +10878 2 2 13 11 4255 5145 5551 +10879 2 2 13 11 4265 5992 5712 +10880 2 2 13 11 4266 5713 5993 +10881 2 2 13 11 4420 5804 5497 +10882 2 2 13 11 4597 6216 6921 +10883 2 2 13 11 3860 5948 5071 +10884 2 2 13 11 3698 5067 6455 +10885 2 2 13 11 4402 5025 6457 +10886 2 2 13 11 4642 5788 6816 +10887 2 2 13 11 4513 5504 6382 +10888 2 2 13 11 3861 4922 6497 +10889 2 2 13 11 4183 5871 5608 +10890 2 2 13 11 3821 4947 6146 +10891 2 2 13 11 6594 6090 4330 +10892 2 2 13 11 4305 6437 5008 +10893 2 2 13 11 4306 5009 6438 +10894 2 2 13 11 86 5607 6538 +10895 2 2 13 11 4313 5641 5246 +10896 2 2 13 11 4048 5317 6028 +10897 2 2 13 11 4049 6029 5318 +10898 2 2 13 11 3934 6795 4978 +10899 2 2 13 11 3935 4979 6796 +10900 2 2 13 11 4186 5838 5125 +10901 2 2 13 11 4155 6577 5728 +10902 2 2 13 11 4459 6487 6559 +10903 2 2 13 11 4227 5186 5672 +10904 2 2 13 11 4024 5290 6119 +10905 2 2 13 11 4569 6108 6052 +10906 2 2 13 11 4023 4936 6616 +10907 2 2 13 11 4414 5934 4935 +10908 2 2 13 11 4262 5612 6070 +10909 2 2 13 11 4263 6071 5613 +10910 2 2 13 11 4778 6924 5897 +10911 2 2 13 11 4779 5898 6925 +10912 2 2 13 11 4137 5079 6095 +10913 2 2 13 11 4158 6738 5057 +10914 2 2 13 11 4402 5714 5025 +10915 2 2 13 11 3803 4942 6169 +10916 2 2 13 11 4655 6798 4987 +10917 2 2 13 11 3804 5006 5893 +10918 2 2 13 11 3926 5237 5608 +10919 2 2 13 11 3805 5894 5007 +10920 2 2 13 11 284 6673 6663 +10921 2 2 13 11 4239 5012 5793 +10922 2 2 13 11 4053 5149 6286 +10923 2 2 13 11 4240 5794 5013 +10924 2 2 13 11 4195 5621 6402 +10925 2 2 13 11 138 139 6011 +10926 2 2 13 11 4132 4957 6491 +10927 2 2 13 11 4108 5658 5355 +10928 2 2 13 11 89 6374 5167 +10929 2 2 13 11 4283 5832 6131 +10930 2 2 13 11 4284 6132 5833 +10931 2 2 13 11 4022 4985 5753 +10932 2 2 13 11 4249 6808 4914 +10933 2 2 13 11 4321 5171 5564 +10934 2 2 13 11 4406 4981 6831 +10935 2 2 13 11 4159 5061 6763 +10936 2 2 13 11 114 115 5394 +10937 2 2 13 11 3706 5598 6595 +10938 2 2 13 11 4334 6935 4993 +10939 2 2 13 11 3668 5060 5726 +10940 2 2 13 11 4519 5829 5066 +10941 2 2 13 11 4164 5034 6239 +10942 2 2 13 11 4168 5782 6562 +10943 2 2 13 11 4296 6416 4998 +10944 2 2 13 11 4448 4943 6015 +10945 2 2 13 11 4385 6028 5317 +10946 2 2 13 11 4386 5318 6029 +10947 2 2 13 11 4076 5882 4981 +10948 2 2 13 11 4176 5041 5661 +10949 2 2 13 11 4243 5677 5376 +10950 2 2 13 11 4118 4992 5827 +10951 2 2 13 11 4244 5377 5678 +10952 2 2 13 11 4091 4999 5983 +10953 2 2 13 11 4363 6414 5202 +10954 2 2 13 11 4380 5512 5221 +10955 2 2 13 11 4181 5866 6593 +10956 2 2 13 11 3900 5984 5144 +10957 2 2 13 11 4010 5807 5134 +10958 2 2 13 11 4124 5148 5638 +10959 2 2 13 11 4537 6332 5579 +10960 2 2 13 11 4400 5185 6838 +10961 2 2 13 11 135 136 5474 +10962 2 2 13 11 4014 5287 6543 +10963 2 2 13 11 4715 5709 6405 +10964 2 2 13 11 4377 6530 5464 +10965 2 2 13 11 3833 5808 5145 +10966 2 2 13 11 3874 5955 5690 +10967 2 2 13 11 3876 5691 5956 +10968 2 2 13 11 4527 5086 5953 +10969 2 2 13 11 4528 5954 5087 +10970 2 2 13 11 3660 6588 5321 +10971 2 2 13 11 3794 5431 5265 +10972 2 2 13 11 3795 5266 5432 +10973 2 2 13 11 4305 5008 5918 +10974 2 2 13 11 4701 6610 5608 +10975 2 2 13 11 4156 5955 4969 +10976 2 2 13 11 4306 5919 5009 +10977 2 2 13 11 4157 4970 5956 +10978 2 2 13 11 4327 5593 5902 +10979 2 2 13 11 4231 6169 4942 +10980 2 2 13 11 3843 6398 5230 +10981 2 2 13 11 4449 5988 4955 +10982 2 2 13 11 4400 6406 5005 +10983 2 2 13 11 4477 4945 6042 +10984 2 2 13 11 4463 6571 5124 +10985 2 2 13 11 3728 6012 5874 +10986 2 2 13 11 4765 4971 6663 +10987 2 2 13 11 145 146 6324 +10988 2 2 13 11 5051 6780 6274 +10989 2 2 13 11 4445 6363 5297 +10990 2 2 13 11 3792 6210 4895 +10991 2 2 13 11 3793 4896 6211 +10992 2 2 13 11 4418 5999 4940 +10993 2 2 13 11 136 137 6420 +10994 2 2 13 11 4318 6730 4961 +10995 2 2 13 11 3944 6727 6682 +10996 2 2 13 11 3978 5051 6274 +10997 2 2 13 11 3888 6039 4986 +10998 2 2 13 11 4334 4993 6026 +10999 2 2 13 11 3791 5896 5456 +11000 2 2 13 11 4340 6288 4911 +11001 2 2 13 11 4341 4912 6289 +11002 2 2 13 11 4302 5376 5677 +11003 2 2 13 11 4303 5678 5377 +11004 2 2 13 11 3901 5223 6938 +11005 2 2 13 11 3836 5624 5298 +11006 2 2 13 11 3837 5299 5625 +11007 2 2 13 11 4241 6217 5027 +11008 2 2 13 11 4242 5028 6218 +11009 2 2 13 11 4585 6357 5494 +11010 2 2 13 11 1 99 6268 +11011 2 2 13 11 3825 6922 5015 +11012 2 2 13 11 4615 6044 6265 +11013 2 2 13 11 168 6897 5031 +11014 2 2 13 11 53 5032 6898 +11015 2 2 13 11 83 84 5667 +11016 2 2 13 11 4897 6056 6627 +11017 2 2 13 11 4898 6628 6057 +11018 2 2 13 11 4763 6596 4997 +11019 2 2 13 11 4762 6938 5563 +11020 2 2 13 11 4305 5313 5740 +11021 2 2 13 11 4010 6837 4958 +11022 2 2 13 11 4164 5649 5222 +11023 2 2 13 11 4306 5741 5316 +11024 2 2 13 11 4459 6559 5762 +11025 2 2 13 11 3884 5467 5758 +11026 2 2 13 11 4137 6095 6736 +11027 2 2 13 11 4296 5978 5120 +11028 2 2 13 11 3702 5666 6421 +11029 2 2 13 11 337 5031 6897 +11030 2 2 13 11 239 6898 5032 +11031 2 2 13 11 4504 6233 5392 +11032 2 2 13 11 4163 5164 6235 +11033 2 2 13 11 290 5620 291 +11034 2 2 13 11 4101 6735 4948 +11035 2 2 13 11 4376 5848 5520 +11036 2 2 13 11 128 129 6024 +11037 2 2 13 11 3770 5357 6791 +11038 2 2 13 11 4427 4960 6220 +11039 2 2 13 11 106 107 6542 +11040 2 2 13 11 4217 5311 5443 +11041 2 2 13 11 4903 6892 5275 +11042 2 2 13 11 4389 5815 5486 +11043 2 2 13 11 4390 5487 5816 +11044 2 2 13 11 3968 5008 6437 +11045 2 2 13 11 3969 6438 5009 +11046 2 2 13 11 3832 5447 5551 +11047 2 2 13 11 325 6532 5168 +11048 2 2 13 11 251 5169 6533 +11049 2 2 13 11 3919 5857 6338 +11050 2 2 13 11 3650 5002 6200 +11051 2 2 13 11 3741 5905 5301 +11052 2 2 13 11 4830 6207 5622 +11053 2 2 13 11 4376 5267 5848 +11054 2 2 13 11 3830 5010 6386 +11055 2 2 13 11 3831 6387 5011 +11056 2 2 13 11 4011 6895 4949 +11057 2 2 13 11 3816 5457 5846 +11058 2 2 13 11 3817 5847 5458 +11059 2 2 13 11 4103 5559 5156 +11060 2 2 13 11 4498 6613 5519 +11061 2 2 13 11 4534 5727 5414 +11062 2 2 13 11 4259 4941 6270 +11063 2 2 13 11 4316 6154 4971 +11064 2 2 13 11 4383 5839 5433 +11065 2 2 13 11 4743 5667 6799 +11066 2 2 13 11 3846 5828 5337 +11067 2 2 13 11 4209 5037 6034 +11068 2 2 13 11 276 5626 277 +11069 2 2 13 11 4058 5080 5855 +11070 2 2 13 11 3716 5365 5430 +11071 2 2 13 11 4253 6318 5005 +11072 2 2 13 11 4253 5005 6103 +11073 2 2 13 11 4304 6274 6780 +11074 2 2 13 11 4249 4914 6164 +11075 2 2 13 11 4213 5064 5861 +11076 2 2 13 11 4241 5298 5624 +11077 2 2 13 11 3870 5414 6093 +11078 2 2 13 11 4242 5625 5299 +11079 2 2 13 11 4289 5293 5849 +11080 2 2 13 11 4290 5850 5294 +11081 2 2 13 11 4851 6219 5482 +11082 2 2 13 11 4380 4952 6229 +11083 2 2 13 11 3797 6759 6358 +11084 2 2 13 11 3748 5000 6785 +11085 2 2 13 11 3798 6359 6760 +11086 2 2 13 11 3992 6472 5047 +11087 2 2 13 11 4350 6500 5929 +11088 2 2 13 11 4620 6277 6398 +11089 2 2 13 11 4747 6908 5020 +11090 2 2 13 11 4748 5021 6909 +11091 2 2 13 11 4355 6251 6478 +11092 2 2 13 11 4356 6479 6252 +11093 2 2 13 11 3889 6459 4990 +11094 2 2 13 11 3890 4991 6460 +11095 2 2 13 11 4741 6028 5212 +11096 2 2 13 11 4742 5213 6029 +11097 2 2 13 11 4506 5249 5545 +11098 2 2 13 11 4041 5849 5293 +11099 2 2 13 11 4042 5294 5850 +11100 2 2 13 11 4170 5515 6125 +11101 2 2 13 11 3828 5025 6001 +11102 2 2 13 11 4231 5511 6084 +11103 2 2 13 11 4541 6543 5287 +11104 2 2 13 11 4186 5153 6896 +11105 2 2 13 11 4441 5509 5238 +11106 2 2 13 11 4270 6146 4947 +11107 2 2 13 11 4442 5239 5510 +11108 2 2 13 11 4607 5852 6098 +11109 2 2 13 11 4608 6099 5853 +11110 2 2 13 11 3713 4998 6416 +11111 2 2 13 11 3868 5606 6531 +11112 2 2 13 11 3937 6844 5140 +11113 2 2 13 11 3794 5224 5628 +11114 2 2 13 11 4154 6023 5172 +11115 2 2 13 11 3795 5629 5226 +11116 2 2 13 11 300 5550 6729 +11117 2 2 13 11 131 132 5596 +11118 2 2 13 11 4953 6151 6674 +11119 2 2 13 11 4275 5627 6088 +11120 2 2 13 11 3897 5072 5810 +11121 2 2 13 11 4751 5690 5955 +11122 2 2 13 11 4752 5956 5691 +11123 2 2 13 11 3898 5811 5073 +11124 2 2 13 11 133 4962 5986 +11125 2 2 13 11 294 6794 295 +11126 2 2 13 11 4804 6338 5857 +11127 2 2 13 11 4421 5465 6053 +11128 2 2 13 11 4601 5165 6240 +11129 2 2 13 11 336 6549 337 +11130 2 2 13 11 239 6550 240 +11131 2 2 13 11 3978 6247 5051 +11132 2 2 13 11 3844 5520 5848 +11133 2 2 13 11 4033 5086 6855 +11134 2 2 13 11 4758 6560 5122 +11135 2 2 13 11 4034 6856 5087 +11136 2 2 13 11 4566 5914 5624 +11137 2 2 13 11 4567 5625 5916 +11138 2 2 13 11 3752 4913 6578 +11139 2 2 13 11 4170 6125 5544 +11140 2 2 13 11 3994 5001 6018 +11141 2 2 13 11 3862 5775 6832 +11142 2 2 13 11 4694 6613 6889 +11143 2 2 13 11 3840 5089 5963 +11144 2 2 13 11 4093 5901 6644 +11145 2 2 13 11 4338 5758 5467 +11146 2 2 13 11 4239 5772 6054 +11147 2 2 13 11 4821 6384 6622 +11148 2 2 13 11 4679 5929 6500 +11149 2 2 13 11 4240 6055 5773 +11150 2 2 13 11 3729 6732 6918 +11151 2 2 13 11 4847 6562 5782 +11152 2 2 13 11 4583 5717 5427 +11153 2 2 13 11 4834 6832 5775 +11154 2 2 13 11 3791 5052 5896 +11155 2 2 13 11 3782 4976 6208 +11156 2 2 13 11 4147 6737 5302 +11157 2 2 13 11 4061 6792 5018 +11158 2 2 13 11 4062 5019 6793 +11159 2 2 13 11 4117 5564 5320 +11160 2 2 13 11 3692 5058 5873 +11161 2 2 13 11 3729 6918 5900 +11162 2 2 13 11 81 82 5761 +11163 2 2 13 11 4169 6124 5514 +11164 2 2 13 11 3753 4977 6094 +11165 2 2 13 11 4030 6447 5063 +11166 2 2 13 11 4068 5069 5750 +11167 2 2 13 11 4684 6598 5684 +11168 2 2 13 11 4685 5685 6599 +11169 2 2 13 11 4066 5557 6634 +11170 2 2 13 11 4039 6162 5023 +11171 2 2 13 11 4209 6197 5037 +11172 2 2 13 11 4067 6635 5558 +11173 2 2 13 11 4152 5060 6573 +11174 2 2 13 11 4295 5104 6404 +11175 2 2 13 11 5420 6742 6467 +11176 2 2 13 11 4195 6402 5990 +11177 2 2 13 11 5171 6907 5973 +11178 2 2 13 11 3822 5545 5249 +11179 2 2 13 11 4580 5255 6483 +11180 2 2 13 11 4128 6098 5852 +11181 2 2 13 11 4129 5853 6099 +11182 2 2 13 11 4368 6699 5039 +11183 2 2 13 11 4411 5663 6391 +11184 2 2 13 11 4116 5378 5525 +11185 2 2 13 11 4412 6392 5664 +11186 2 2 13 11 102 103 6340 +11187 2 2 13 11 4169 5531 6124 +11188 2 2 13 11 4437 6891 5074 +11189 2 2 13 11 4264 5065 6432 +11190 2 2 13 11 4024 6720 4983 +11191 2 2 13 11 4295 5144 5984 +11192 2 2 13 11 3869 6339 5338 +11193 2 2 13 11 295 5989 296 +11194 2 2 13 11 4482 5606 6190 +11195 2 2 13 11 3719 4978 6685 +11196 2 2 13 11 3720 6686 4979 +11197 2 2 13 11 4853 6709 5209 +11198 2 2 13 11 3694 5904 5068 +11199 2 2 13 11 4229 5893 5006 +11200 2 2 13 11 140 141 5693 +11201 2 2 13 11 4230 5007 5894 +11202 2 2 13 11 316 6004 317 +11203 2 2 13 11 259 6005 260 +11204 2 2 13 11 4109 5767 5351 +11205 2 2 13 11 4175 5384 6805 +11206 2 2 13 11 4506 5140 6844 +11207 2 2 13 11 4485 5552 5763 +11208 2 2 13 11 4555 4990 6424 +11209 2 2 13 11 4556 6425 4991 +11210 2 2 13 11 3664 5297 6363 +11211 2 2 13 11 4200 5548 6522 +11212 2 2 13 11 4440 5469 5331 +11213 2 2 13 11 4353 5475 5846 +11214 2 2 13 11 4354 5847 5476 +11215 2 2 13 11 4542 6620 6340 +11216 2 2 13 11 4128 6903 5010 +11217 2 2 13 11 4129 5011 6904 +11218 2 2 13 11 4141 5760 5479 +11219 2 2 13 11 4436 5167 6684 +11220 2 2 13 11 3820 5022 5802 +11221 2 2 13 11 4760 6775 6597 +11222 2 2 13 11 4660 6421 5666 +11223 2 2 13 11 3661 4996 6703 +11224 2 2 13 11 4225 6236 5746 +11225 2 2 13 11 4226 5747 6237 +11226 2 2 13 11 4110 5029 5812 +11227 2 2 13 11 3853 5733 5345 +11228 2 2 13 11 4186 5642 5153 +11229 2 2 13 11 4288 5506 5867 +11230 2 2 13 11 4392 5411 6453 +11231 2 2 13 11 4393 6454 5412 +11232 2 2 13 11 4520 6751 5732 +11233 2 2 13 11 4179 6705 5100 +11234 2 2 13 11 3951 6034 5037 +11235 2 2 13 11 4784 6272 5690 +11236 2 2 13 11 4785 5691 6273 +11237 2 2 13 11 4044 5109 6365 +11238 2 2 13 11 4045 6366 5110 +11239 2 2 13 11 3809 6052 6108 +11240 2 2 13 11 3895 5717 6493 +11241 2 2 13 11 4358 5047 6472 +11242 2 2 13 11 3939 5562 5315 +11243 2 2 13 11 4168 6562 5824 +11244 2 2 13 11 4255 5842 5145 +11245 2 2 13 11 3690 5767 5123 +11246 2 2 13 11 3680 6009 6298 +11247 2 2 13 11 3681 6299 6010 +11248 2 2 13 11 4302 5964 5109 +11249 2 2 13 11 4303 5110 5965 +11250 2 2 13 11 152 153 6664 +11251 2 2 13 11 68 69 6665 +11252 2 2 13 11 3845 4997 6936 +11253 2 2 13 11 160 161 5583 +11254 2 2 13 11 60 61 5584 +11255 2 2 13 11 3659 5005 6318 +11256 2 2 13 11 4409 6106 5596 +11257 2 2 13 11 4123 6528 5706 +11258 2 2 13 11 3808 5135 5783 +11259 2 2 13 11 4307 5020 5966 +11260 2 2 13 11 4308 5967 5021 +11261 2 2 13 11 3850 5609 5256 +11262 2 2 13 11 4835 6261 5119 +11263 2 2 13 11 4189 4967 6128 +11264 2 2 13 11 4422 5456 5896 +11265 2 2 13 11 3679 6196 5054 +11266 2 2 13 11 4291 5051 6247 +11267 2 2 13 11 4602 6391 5663 +11268 2 2 13 11 4603 5664 6392 +11269 2 2 13 11 268 6090 269 +11270 2 2 13 11 111 6026 4993 +11271 2 2 13 11 4559 6085 5849 +11272 2 2 13 11 4245 5145 5808 +11273 2 2 13 11 4560 5850 6086 +11274 2 2 13 11 4416 6670 5058 +11275 2 2 13 11 4866 6587 6013 +11276 2 2 13 11 4483 5139 5917 +11277 2 2 13 11 4601 6083 5913 +11278 2 2 13 11 4131 5071 5948 +11279 2 2 13 11 4011 5163 6902 +11280 2 2 13 11 93 94 6853 +11281 2 2 13 11 4436 6434 5167 +11282 2 2 13 11 3993 4957 6743 +11283 2 2 13 11 132 133 5986 +11284 2 2 13 11 3797 6583 5219 +11285 2 2 13 11 3798 5220 6584 +11286 2 2 13 11 4300 5486 5815 +11287 2 2 13 11 4301 5816 5487 +11288 2 2 13 11 4663 6878 5102 +11289 2 2 13 11 4664 5103 6879 +11290 2 2 13 11 3949 5044 6226 +11291 2 2 13 11 4184 5382 5973 +11292 2 2 13 11 4538 5238 6926 +11293 2 2 13 11 4539 6927 5239 +11294 2 2 13 11 4592 6114 5035 +11295 2 2 13 11 4593 5036 6115 +11296 2 2 13 11 4283 6131 5601 +11297 2 2 13 11 4284 5602 6132 +11298 2 2 13 11 3960 5035 6249 +11299 2 2 13 11 3961 6250 5036 +11300 2 2 13 11 4185 5963 5089 +11301 2 2 13 11 4493 5315 5562 +11302 2 2 13 11 4808 5925 5656 +11303 2 2 13 11 3936 5491 6440 +11304 2 2 13 11 3828 5590 5215 +11305 2 2 13 11 3829 5216 5591 +11306 2 2 13 11 3988 6622 6384 +11307 2 2 13 11 3834 6053 5465 +11308 2 2 13 11 4491 6890 6302 +11309 2 2 13 11 141 5146 5693 +11310 2 2 13 11 4259 5101 6011 +11311 2 2 13 11 286 5568 287 +11312 2 2 13 11 3762 6037 5027 +11313 2 2 13 11 4076 4963 6436 +11314 2 2 13 11 3763 5028 6038 +11315 2 2 13 11 3710 5764 6136 +11316 2 2 13 11 4132 6334 5896 +11317 2 2 13 11 285 6154 286 +11318 2 2 13 11 4186 5260 5838 +11319 2 2 13 11 4320 5952 5603 +11320 2 2 13 11 4006 5022 6498 +11321 2 2 13 11 4273 6683 6051 +11322 2 2 13 11 4809 6148 6368 +11323 2 2 13 11 4810 6369 6150 +11324 2 2 13 11 4207 5628 5224 +11325 2 2 13 11 4208 5226 5629 +11326 2 2 13 11 4798 6165 6783 +11327 2 2 13 11 4014 4992 6739 +11328 2 2 13 11 4830 6014 6647 +11329 2 2 13 11 127 5468 6931 +11330 2 2 13 11 4288 5147 5837 +11331 2 2 13 11 4361 6238 5243 +11332 2 2 13 11 4307 5457 6631 +11333 2 2 13 11 4308 6632 5458 +11334 2 2 13 11 4274 5750 5913 +11335 2 2 13 11 4837 6827 6249 +11336 2 2 13 11 4838 6250 6828 +11337 2 2 13 11 4054 4996 6719 +11338 2 2 13 11 4667 6187 5132 +11339 2 2 13 11 4795 6334 6491 +11340 2 2 13 11 4668 5133 6188 +11341 2 2 13 11 4782 6420 6857 +11342 2 2 13 11 3652 6223 6747 +11343 2 2 13 11 4267 6127 6829 +11344 2 2 13 11 4285 6297 5108 +11345 2 2 13 11 3827 6390 5202 +11346 2 2 13 11 4241 5624 5914 +11347 2 2 13 11 4242 5916 5625 +11348 2 2 13 11 3945 6587 5194 +11349 2 2 13 11 3726 5969 5108 +11350 2 2 13 11 4467 5177 6827 +11351 2 2 13 11 4468 6828 5178 +11352 2 2 13 11 4445 5297 6418 +11353 2 2 13 11 4431 6722 5282 +11354 2 2 13 11 3910 5243 6238 +11355 2 2 13 11 4432 5283 6723 +11356 2 2 13 11 4148 5439 5597 +11357 2 2 13 11 4193 5693 5146 +11358 2 2 13 11 4278 6196 6824 +11359 2 2 13 11 4346 6365 5109 +11360 2 2 13 11 4302 5489 6109 +11361 2 2 13 11 4303 6111 5490 +11362 2 2 13 11 4347 5110 6366 +11363 2 2 13 11 4788 5492 6508 +11364 2 2 13 11 303 6220 304 +11365 2 2 13 11 88 5167 6434 +11366 2 2 13 11 331 5966 332 +11367 2 2 13 11 244 5967 245 +11368 2 2 13 11 4641 6078 5725 +11369 2 2 13 11 3843 5748 6409 +11370 2 2 13 11 4314 5177 6426 +11371 2 2 13 11 4315 6427 5178 +11372 2 2 13 11 3945 6013 6587 +11373 2 2 13 11 4113 6315 5190 +11374 2 2 13 11 4183 5608 5237 +11375 2 2 13 11 4200 6522 6652 +11376 2 2 13 11 3814 5420 6467 +11377 2 2 13 11 4203 5068 5904 +11378 2 2 13 11 3832 5551 5570 +11379 2 2 13 11 4025 5522 6907 +11380 2 2 13 11 4179 6523 5119 +11381 2 2 13 11 4417 5230 6398 +11382 2 2 13 11 332 6908 333 +11383 2 2 13 11 243 6909 244 +11384 2 2 13 11 4351 5113 5942 +11385 2 2 13 11 4352 5943 5114 +11386 2 2 13 11 4373 5082 6480 +11387 2 2 13 11 3778 5760 5192 +11388 2 2 13 11 4482 6531 5606 +11389 2 2 13 11 4928 5321 6588 +11390 2 2 13 11 3758 5818 5126 +11391 2 2 13 11 283 6673 284 +11392 2 2 13 11 4438 6035 6298 +11393 2 2 13 11 4439 6299 6036 +11394 2 2 13 11 324 6532 325 +11395 2 2 13 11 251 6533 252 +11396 2 2 13 11 4580 6483 6021 +11397 2 2 13 11 4350 6162 6292 +11398 2 2 13 11 294 5043 6794 +11399 2 2 13 11 4171 6059 5054 +11400 2 2 13 11 4661 5499 6826 +11401 2 2 13 11 4289 5349 5869 +11402 2 2 13 11 4290 5870 5350 +11403 2 2 13 11 4191 6431 5118 +11404 2 2 13 11 3711 5179 5856 +11405 2 2 13 11 4289 5849 6085 +11406 2 2 13 11 4290 6086 5850 +11407 2 2 13 11 4697 6701 4984 +11408 2 2 13 11 3807 5069 6734 +11409 2 2 13 11 3990 5039 6699 +11410 2 2 13 11 3768 5272 6693 +11411 2 2 13 11 3954 6495 6836 +11412 2 2 13 11 4059 6684 5167 +11413 2 2 13 11 3834 5093 6053 +11414 2 2 13 11 153 154 5668 +11415 2 2 13 11 67 68 5669 +11416 2 2 13 11 3850 5074 6891 +11417 2 2 13 11 108 109 5604 +11418 2 2 13 11 4614 5827 6578 +11419 2 2 13 11 3818 5573 6896 +11420 2 2 13 11 3927 5190 6315 +11421 2 2 13 11 4154 5291 6023 +11422 2 2 13 11 4401 5621 5569 +11423 2 2 13 11 307 5622 308 +11424 2 2 13 11 3804 5893 5981 +11425 2 2 13 11 4383 5092 6379 +11426 2 2 13 11 3805 5982 5894 +11427 2 2 13 11 272 5347 6147 +11428 2 2 13 11 4374 6393 5628 +11429 2 2 13 11 4375 5629 6394 +11430 2 2 13 11 3671 5040 6084 +11431 2 2 13 11 4196 6362 5125 +11432 2 2 13 11 4188 5091 5884 +11433 2 2 13 11 304 6452 305 +11434 2 2 13 11 4879 6329 6724 +11435 2 2 13 11 4323 6368 6148 +11436 2 2 13 11 4324 6150 6369 +11437 2 2 13 11 3939 5730 5562 +11438 2 2 13 11 4224 6886 6039 +11439 2 2 13 11 4340 5298 6037 +11440 2 2 13 11 4341 6038 5299 +11441 2 2 13 11 4236 5961 5928 +11442 2 2 13 11 3668 5541 5990 +11443 2 2 13 11 4986 6039 6886 +11444 2 2 13 11 4832 6668 6286 +11445 2 2 13 11 3682 6749 5160 +11446 2 2 13 11 4570 6440 5491 +11447 2 2 13 11 3683 5161 6750 +11448 2 2 13 11 3698 6455 5912 +11449 2 2 13 11 4724 5470 6711 +11450 2 2 13 11 4099 5869 5349 +11451 2 2 13 11 4100 5350 5870 +11452 2 2 13 11 4569 5223 6108 +11453 2 2 13 11 4346 6734 5069 +11454 2 2 13 11 4025 5778 5522 +11455 2 2 13 11 4314 6426 4974 +11456 2 2 13 11 4315 4975 6427 +11457 2 2 13 11 3684 5257 5634 +11458 2 2 13 11 3685 5635 5258 +11459 2 2 13 11 3731 5008 6109 +11460 2 2 13 11 4513 6276 5519 +11461 2 2 13 11 3732 6111 5009 +11462 2 2 13 11 4003 5768 5184 +11463 2 2 13 11 3774 5911 5122 +11464 2 2 13 11 4087 5270 6603 +11465 2 2 13 11 5608 5871 6887 +11466 2 2 13 11 281 5310 6537 +11467 2 2 13 11 3835 5724 5191 +11468 2 2 13 11 3819 5484 5736 +11469 2 2 13 11 146 6435 5131 +11470 2 2 13 11 3957 6850 6494 +11471 2 2 13 11 4197 5305 5836 +11472 2 2 13 11 3694 5068 6335 +11473 2 2 13 11 4031 6418 5297 +11474 2 2 13 11 3825 5196 6488 +11475 2 2 13 11 4672 6503 5045 +11476 2 2 13 11 3982 5081 6227 +11477 2 2 13 11 4673 5046 6504 +11478 2 2 13 11 4454 6776 5780 +11479 2 2 13 11 4035 5994 5070 +11480 2 2 13 11 4566 5624 6478 +11481 2 2 13 11 4567 6479 5625 +11482 2 2 13 11 3727 5039 6262 +11483 2 2 13 11 4258 6590 5997 +11484 2 2 13 11 3684 5634 6396 +11485 2 2 13 11 4054 6719 5407 +11486 2 2 13 11 3685 6397 5635 +11487 2 2 13 11 3705 6451 5790 +11488 2 2 13 11 3996 6926 5238 +11489 2 2 13 11 3997 5239 6927 +11490 2 2 13 11 4274 5913 6083 +11491 2 2 13 11 4675 6671 5300 +11492 2 2 13 11 138 5101 6857 +11493 2 2 13 11 4526 5596 6106 +11494 2 2 13 11 4591 6136 5764 +11495 2 2 13 11 4192 5485 6292 +11496 2 2 13 11 4583 5706 6528 +11497 2 2 13 11 4536 5928 5961 +11498 2 2 13 11 4369 6821 5387 +11499 2 2 13 11 4371 5388 6822 +11500 2 2 13 11 4456 6727 6072 +11501 2 2 13 11 3672 6279 5026 +11502 2 2 13 11 4544 5679 6886 +11503 2 2 13 11 4819 6694 5869 +11504 2 2 13 11 4820 5870 6695 +11505 2 2 13 11 4179 5474 6420 +11506 2 2 13 11 4644 5218 5776 +11507 2 2 13 11 4627 5182 6096 +11508 2 2 13 11 4278 5054 6196 +11509 2 2 13 11 4628 6097 5183 +11510 2 2 13 11 4132 6491 6334 +11511 2 2 13 11 4547 5981 5893 +11512 2 2 13 11 4548 5894 5982 +11513 2 2 13 11 122 6569 6608 +11514 2 2 13 11 4431 5282 6924 +11515 2 2 13 11 4432 6925 5283 +11516 2 2 13 11 4730 6931 5468 +11517 2 2 13 11 4498 5351 5767 +11518 2 2 13 11 4130 5895 5233 +11519 2 2 13 11 3978 4998 6247 +11520 2 2 13 11 125 126 5695 +11521 2 2 13 11 4607 6009 5461 +11522 2 2 13 11 4608 5463 6010 +11523 2 2 13 11 4527 5953 6194 +11524 2 2 13 11 4528 6195 5954 +11525 2 2 13 11 3960 6827 5177 +11526 2 2 13 11 3961 5178 6828 +11527 2 2 13 11 271 6873 5347 +11528 2 2 13 11 4028 5186 5809 +11529 2 2 13 11 3900 5144 6083 +11530 2 2 13 11 4894 6142 5075 +11531 2 2 13 11 3726 5108 6297 +11532 2 2 13 11 4620 5307 6277 +11533 2 2 13 11 336 5055 6549 +11534 2 2 13 11 240 6550 5056 +11535 2 2 13 11 4195 5569 5621 +11536 2 2 13 11 4463 5124 6797 +11537 2 2 13 11 4756 5636 6867 +11538 2 2 13 11 4757 6869 5637 +11539 2 2 13 11 4586 5979 5152 +11540 2 2 13 11 4775 6896 5573 +11541 2 2 13 11 3809 6108 5076 +11542 2 2 13 11 3826 5804 5374 +11543 2 2 13 11 4204 5363 5554 +11544 2 2 13 11 4205 5555 5364 +11545 2 2 13 11 4069 6773 4987 +11546 2 2 13 11 3682 5160 5914 +11547 2 2 13 11 3683 5916 5161 +11548 2 2 13 11 4488 5719 6786 +11549 2 2 13 11 4489 6787 5720 +11550 2 2 13 11 4179 5100 6523 +11551 2 2 13 11 311 5663 312 +11552 2 2 13 11 264 5664 265 +11553 2 2 13 11 4355 5251 6251 +11554 2 2 13 11 4356 6252 5252 +11555 2 2 13 11 3826 5016 6151 +11556 2 2 13 11 3958 5082 6883 +11557 2 2 13 11 3978 6274 5026 +11558 2 2 13 11 4002 6239 5034 +11559 2 2 13 11 4457 5062 6205 +11560 2 2 13 11 3655 6716 5165 +11561 2 2 13 11 4011 5776 5218 +11562 2 2 13 11 4193 5766 5217 +11563 2 2 13 11 3968 5636 5376 +11564 2 2 13 11 3969 5377 5637 +11565 2 2 13 11 288 6564 5362 +11566 2 2 13 11 4181 5737 5193 +11567 2 2 13 11 4217 5443 5998 +11568 2 2 13 11 3968 6867 5636 +11569 2 2 13 11 3969 5637 6869 +11570 2 2 13 11 4275 5974 5911 +11571 2 2 13 11 4269 5163 6174 +11572 2 2 13 11 4568 5368 5845 +11573 2 2 13 11 282 6537 5372 +11574 2 2 13 11 4487 6777 5880 +11575 2 2 13 11 4287 6724 6329 +11576 2 2 13 11 4402 6457 5859 +11577 2 2 13 11 4403 5860 6458 +11578 2 2 13 11 3801 6797 5124 +11579 2 2 13 11 4766 6907 5522 +11580 2 2 13 11 4345 6400 5994 +11581 2 2 13 11 4584 5407 6719 +11582 2 2 13 11 4271 6203 5647 +11583 2 2 13 11 4272 5648 6204 +11584 2 2 13 11 4274 5269 5750 +11585 2 2 13 11 3689 4999 6448 +11586 2 2 13 11 3981 5017 6594 +11587 2 2 13 11 4262 5136 6372 +11588 2 2 13 11 4263 6373 5137 +11589 2 2 13 11 3863 5173 5897 +11590 2 2 13 11 3864 5898 5174 +11591 2 2 13 11 4282 6228 5680 +11592 2 2 13 11 4269 5989 5116 +11593 2 2 13 11 4104 5373 6698 +11594 2 2 13 11 4194 5262 5805 +11595 2 2 13 11 4986 6886 5679 +11596 2 2 13 11 4396 5018 6178 +11597 2 2 13 11 4397 6179 5019 +11598 2 2 13 11 4278 6093 5054 +11599 2 2 13 11 4585 6433 5650 +11600 2 2 13 11 4357 5240 6650 +11601 2 2 13 11 3930 6078 6681 +11602 2 2 13 11 4033 6855 5719 +11603 2 2 13 11 4034 5720 6856 +11604 2 2 13 11 3937 6145 6844 +11605 2 2 13 11 4337 5607 5946 +11606 2 2 13 11 4859 6063 6017 +11607 2 2 13 11 3806 5155 6265 +11608 2 2 13 11 3848 5519 6276 +11609 2 2 13 11 4344 5084 6311 +11610 2 2 13 11 4475 5160 6749 +11611 2 2 13 11 4476 6750 5161 +11612 2 2 13 11 4291 6512 5051 +11613 2 2 13 11 167 6524 5077 +11614 2 2 13 11 54 5078 6525 +11615 2 2 13 11 4194 5170 6450 +11616 2 2 13 11 4147 5861 6737 +11617 2 2 13 11 4823 6736 6095 +11618 2 2 13 11 4248 5856 5179 +11619 2 2 13 11 4214 6153 5198 +11620 2 2 13 11 4360 5455 6324 +11621 2 2 13 11 4559 5849 6459 +11622 2 2 13 11 4560 6460 5850 +11623 2 2 13 11 3725 5704 5247 +11624 2 2 13 11 4292 6207 5214 +11625 2 2 13 11 4297 6335 5068 +11626 2 2 13 11 4727 6463 6385 +11627 2 2 13 11 3692 6733 5058 +11628 2 2 13 11 4163 5764 5164 +11629 2 2 13 11 3794 5265 5692 +11630 2 2 13 11 3889 5514 6459 +11631 2 2 13 11 3890 6460 5515 +11632 2 2 13 11 3795 5694 5266 +11633 2 2 13 11 4486 6880 5214 +11634 2 2 13 11 4707 6824 6196 +11635 2 2 13 11 3866 6309 5084 +11636 2 2 13 11 4344 5672 6202 +11637 2 2 13 11 3843 6409 6687 +11638 2 2 13 11 4004 5075 6142 +11639 2 2 13 11 4192 6017 6063 +11640 2 2 13 11 3869 5338 6225 +11641 2 2 13 11 4261 5576 5704 +11642 2 2 13 11 3960 6249 6827 +11643 2 2 13 11 3961 6828 6250 +11644 2 2 13 11 4011 6174 5163 +11645 2 2 13 11 4483 6577 5831 +11646 2 2 13 11 4809 5719 6855 +11647 2 2 13 11 4810 6856 5720 +11648 2 2 13 11 269 6707 270 +11649 2 2 13 11 3980 5881 6319 +11650 2 2 13 11 3654 6133 5045 +11651 2 2 13 11 3653 5046 6134 +11652 2 2 13 11 3691 5234 6689 +11653 2 2 13 11 3970 5040 6671 +11654 2 2 13 11 143 144 5907 +11655 2 2 13 11 4759 5912 6455 +11656 2 2 13 11 3655 5165 6118 +11657 2 2 13 11 4604 6163 5505 +11658 2 2 13 11 4224 5191 5724 +11659 2 2 13 11 4239 6054 5529 +11660 2 2 13 11 4325 5548 5547 +11661 2 2 13 11 4240 5530 6055 +11662 2 2 13 11 4830 6647 6207 +11663 2 2 13 11 3906 6490 5381 +11664 2 2 13 11 4522 6645 5072 +11665 2 2 13 11 3994 6018 5175 +11666 2 2 13 11 4523 5073 6646 +11667 2 2 13 11 4041 6251 5251 +11668 2 2 13 11 4042 5252 6252 +11669 2 2 13 11 4558 5134 6946 +11670 2 2 13 11 4147 5699 5256 +11671 2 2 13 11 4028 6692 5049 +11672 2 2 13 11 4027 5066 6560 +11673 2 2 13 11 4424 6276 6382 +11674 2 2 13 11 4545 5812 6655 +11675 2 2 13 11 3993 6743 5074 +11676 2 2 13 11 4274 6083 5144 +11677 2 2 13 11 4547 6803 5150 +11678 2 2 13 11 4115 6751 5945 +11679 2 2 13 11 4227 5672 5346 +11680 2 2 13 11 4548 5151 6804 +11681 2 2 13 11 3739 6042 5175 +11682 2 2 13 11 4518 6537 5310 +11683 2 2 13 11 4203 6121 5068 +11684 2 2 13 11 3708 5117 6198 +11685 2 2 13 11 135 5474 6660 +11686 2 2 13 11 4534 6718 5727 +11687 2 2 13 11 3888 5841 6116 +11688 2 2 13 11 4836 5780 6776 +11689 2 2 13 11 4369 6243 5885 +11690 2 2 13 11 4371 5886 6244 +11691 2 2 13 11 4252 6279 5392 +11692 2 2 13 11 4054 6242 5253 +11693 2 2 13 11 5150 6803 6078 +11694 2 2 13 11 4164 5222 5732 +11695 2 2 13 11 3909 5100 6705 +11696 2 2 13 11 163 5369 6327 +11697 2 2 13 11 58 6328 5370 +11698 2 2 13 11 4253 5140 6318 +11699 2 2 13 11 3689 6095 5079 +11700 2 2 13 11 3933 6834 5922 +11701 2 2 13 11 4185 5089 6544 +11702 2 2 13 11 4545 6152 5812 +11703 2 2 13 11 4448 5165 6716 +11704 2 2 13 11 3791 6413 5001 +11705 2 2 13 11 4068 5750 5269 +11706 2 2 13 11 4381 6860 5038 +11707 2 2 13 11 4155 5728 5332 +11708 2 2 13 11 4572 6634 5557 +11709 2 2 13 11 4573 5558 6635 +11710 2 2 13 11 74 6380 5386 +11711 2 2 13 11 4467 5333 6839 +11712 2 2 13 11 3840 5786 5587 +11713 2 2 13 11 4468 6840 5334 +11714 2 2 13 11 4260 5665 5563 +11715 2 2 13 11 4445 6488 5196 +11716 2 2 13 11 4616 6167 5336 +11717 2 2 13 11 4643 5355 5658 +11718 2 2 13 11 92 93 5806 +11719 2 2 13 11 3662 5129 6303 +11720 2 2 13 11 3663 6304 5130 +11721 2 2 13 11 103 104 5980 +11722 2 2 13 11 4185 5361 5654 +11723 2 2 13 11 4812 6747 6565 +11724 2 2 13 11 4527 5132 6187 +11725 2 2 13 11 4528 6188 5133 +11726 2 2 13 11 4417 6398 6277 +11727 2 2 13 11 3974 5214 6207 +11728 2 2 13 11 4479 6286 6668 +11729 2 2 13 11 4701 6659 6610 +11730 2 2 13 11 4180 5718 5546 +11731 2 2 13 11 4210 6447 5159 +11732 2 2 13 11 3697 5284 6711 +11733 2 2 13 11 3825 6488 5796 +11734 2 2 13 11 4241 5914 5160 +11735 2 2 13 11 4242 5161 5916 +11736 2 2 13 11 4317 6539 5063 +11737 2 2 13 11 4271 6096 5182 +11738 2 2 13 11 4272 5183 6097 +11739 2 2 13 11 4410 5426 6323 +11740 2 2 13 11 4222 5190 5968 +11741 2 2 13 11 3990 6699 6858 +11742 2 2 13 11 4265 5168 6532 +11743 2 2 13 11 4266 6533 5169 +11744 2 2 13 11 3927 5968 5190 +11745 2 2 13 11 4215 6664 5668 +11746 2 2 13 11 4216 5669 6665 +11747 2 2 13 11 3797 5434 6583 +11748 2 2 13 11 3798 6584 5435 +11749 2 2 13 11 3665 6185 5127 +11750 2 2 13 11 4300 5387 6821 +11751 2 2 13 11 4301 6822 5388 +11752 2 2 13 11 4512 6588 5950 +11753 2 2 13 11 4942 6429 5197 +11754 2 2 13 11 4271 5157 5939 +11755 2 2 13 11 4272 5940 5158 +11756 2 2 13 11 4559 6459 5514 +11757 2 2 13 11 4560 5515 6460 +11758 2 2 13 11 4124 5638 5448 +11759 2 2 13 11 4738 6344 5146 +11760 2 2 13 11 3662 6368 5129 +11761 2 2 13 11 3663 5130 6369 +11762 2 2 13 11 4457 5448 5638 +11763 2 2 13 11 4416 5058 6733 +11764 2 2 13 11 4326 6561 5128 +11765 2 2 13 11 3952 5172 6023 +11766 2 2 13 11 4431 6327 5369 +11767 2 2 13 11 4432 5370 6328 +11768 2 2 13 11 4258 5735 6590 +11769 2 2 13 11 4423 5268 6350 +11770 2 2 13 11 4455 5386 6380 +11771 2 2 13 11 4227 5809 5186 +11772 2 2 13 11 4576 5495 6706 +11773 2 2 13 11 4061 5141 6792 +11774 2 2 13 11 4062 6793 5142 +11775 2 2 13 11 3797 6358 5035 +11776 2 2 13 11 3798 5036 6359 +11777 2 2 13 11 4297 5068 6401 +11778 2 2 13 11 4265 5712 5445 +11779 2 2 13 11 4266 5446 5713 +11780 2 2 13 11 4243 5376 5636 +11781 2 2 13 11 4244 5637 5377 +11782 2 2 13 11 4013 6672 6431 +11783 2 2 13 11 4531 6654 5991 +11784 2 2 13 11 4494 6275 5769 +11785 2 2 13 11 4349 5587 5786 +11786 2 2 13 11 4179 5119 6905 +11787 2 2 13 11 4194 6450 6456 +11788 2 2 13 11 3713 5729 5332 +11789 2 2 13 11 3814 5512 6137 +11790 2 2 13 11 4378 5972 5565 +11791 2 2 13 11 4655 6919 6798 +11792 2 2 13 11 4271 5939 6203 +11793 2 2 13 11 4272 6204 5940 +11794 2 2 13 11 4292 5622 6207 +11795 2 2 13 11 4330 5124 6594 +11796 2 2 13 11 4268 5572 5902 +11797 2 2 13 11 4020 6345 5282 +11798 2 2 13 11 4021 5283 6346 +11799 2 2 13 11 3974 6207 6647 +11800 2 2 13 11 4322 6748 5121 +11801 2 2 13 11 4728 6608 6569 +11802 2 2 13 11 4640 5281 5844 +11803 2 2 13 11 4428 6715 5259 +11804 2 2 13 11 4512 5950 5657 +11805 2 2 13 11 3652 5307 6223 +11806 2 2 13 11 312 5663 5822 +11807 2 2 13 11 264 5823 5664 +11808 2 2 13 11 3810 5051 6512 +11809 2 2 13 11 3982 6227 6876 +11810 2 2 13 11 4319 6385 5191 +11811 2 2 13 11 4271 6004 5157 +11812 2 2 13 11 4272 5158 6005 +11813 2 2 13 11 3838 5387 5815 +11814 2 2 13 11 3839 5816 5388 +11815 2 2 13 11 76 77 5883 +11816 2 2 13 11 4055 6648 5111 +11817 2 2 13 11 4056 5112 6649 +11818 2 2 13 11 3650 5229 6025 +11819 2 2 13 11 121 6608 5047 +11820 2 2 13 11 4171 5414 5727 +11821 2 2 13 11 4932 6612 5665 +11822 2 2 13 11 4221 6377 5193 +11823 2 2 13 11 3773 5119 6523 +11824 2 2 13 11 4307 5966 6942 +11825 2 2 13 11 317 6004 5182 +11826 2 2 13 11 4308 6943 5967 +11827 2 2 13 11 259 5183 6005 +11828 2 2 13 11 4416 6141 6670 +11829 2 2 13 11 4030 5063 6539 +11830 2 2 13 11 4887 6496 6417 +11831 2 2 13 11 3810 6780 5051 +11832 2 2 13 11 4405 6225 5338 +11833 2 2 13 11 3670 6715 5095 +11834 2 2 13 11 109 6581 5604 +11835 2 2 13 11 4436 5946 5607 +11836 2 2 13 11 4907 6670 6141 +11837 2 2 13 11 5104 6950 6404 +11838 2 2 13 11 4427 5378 6383 +11839 2 2 13 11 4166 5942 5639 +11840 2 2 13 11 4167 5640 5943 +11841 2 2 13 11 4727 5232 6230 +11842 2 2 13 11 3937 5140 6296 +11843 2 2 13 11 3808 6852 5135 +11844 2 2 13 11 4191 5289 6047 +11845 2 2 13 11 4411 5822 5663 +11846 2 2 13 11 4412 5664 5823 +11847 2 2 13 11 4088 5805 5262 +11848 2 2 13 11 4006 6498 5131 +11849 2 2 13 11 4521 6640 5792 +11850 2 2 13 11 312 5822 313 +11851 2 2 13 11 263 5823 264 +11852 2 2 13 11 149 6350 5268 +11853 2 2 13 11 4443 6227 5454 +11854 2 2 13 11 4674 6319 5881 +11855 2 2 13 11 4024 6119 6720 +11856 2 2 13 11 4669 5796 6488 +11857 2 2 13 11 2 123 6569 +11858 2 2 13 11 4309 5143 6513 +11859 2 2 13 11 4151 5427 5717 +11860 2 2 13 11 3729 5813 6732 +11861 2 2 13 11 4472 5357 5775 +11862 2 2 13 11 4347 5135 6852 +11863 2 2 13 11 4420 5722 5339 +11864 2 2 13 11 4261 5704 6257 +11865 2 2 13 11 4926 6316 5352 +11866 2 2 13 11 4927 5353 6317 +11867 2 2 13 11 4249 5139 6808 +11868 2 2 13 11 4250 5263 6370 +11869 2 2 13 11 3823 5358 6128 +11870 2 2 13 11 4251 6371 5264 +11871 2 2 13 11 5118 6431 6672 +11872 2 2 13 11 4428 6514 6213 +11873 2 2 13 11 4500 6950 5104 +11874 2 2 13 11 3846 5838 5260 +11875 2 2 13 11 3871 5565 5972 +11876 2 2 13 11 4339 5938 5250 +11877 2 2 13 11 3971 6417 6496 +11878 2 2 13 11 4447 5900 5808 +11879 2 2 13 11 4200 5547 5548 +11880 2 2 13 11 4074 5469 6508 +11881 2 2 13 11 3981 6594 5124 +11882 2 2 13 11 3878 6706 5495 +11883 2 2 13 11 4116 6383 5378 +11884 2 2 13 11 3982 6876 5743 +11885 2 2 13 11 4114 5198 6234 +11886 2 2 13 11 4152 6137 5512 +11887 2 2 13 11 3758 5126 6910 +11888 2 2 13 11 126 6931 5695 +11889 2 2 13 11 4456 6452 6727 +11890 2 2 13 11 4392 5282 6345 +11891 2 2 13 11 4393 6346 5283 +11892 2 2 13 11 4036 5408 6066 +11893 2 2 13 11 146 147 6435 +11894 2 2 13 11 3983 5128 6561 +11895 2 2 13 11 3818 6896 5153 +11896 2 2 13 11 4213 6175 5274 +11897 2 2 13 11 4159 6265 5155 +11898 2 2 13 11 4574 6051 6683 +11899 2 2 13 11 4588 5407 5958 +11900 2 2 13 11 2 6569 122 +11901 2 2 13 11 5511 6843 6084 +11902 2 2 13 11 101 5385 6769 +11903 2 2 13 11 4077 6168 5280 +11904 2 2 13 11 3701 5563 5665 +11905 2 2 13 11 4296 5723 6756 +11906 2 2 13 11 4387 6585 5100 +11907 2 2 13 11 4338 6231 5692 +11908 2 2 13 11 4228 6025 5229 +11909 2 2 13 11 4345 5994 5248 +11910 2 2 13 11 4017 5097 6546 +11911 2 2 13 11 4298 5295 6770 +11912 2 2 13 11 4299 6771 5296 +11913 2 2 13 11 4018 6547 5098 +11914 2 2 13 11 4296 6756 6044 +11915 2 2 13 11 5040 5300 6671 +11916 2 2 13 11 4212 5320 6349 +11917 2 2 13 11 4510 6030 5173 +11918 2 2 13 11 4511 5174 6031 +11919 2 2 13 11 4960 6727 6452 +11920 2 2 13 11 4089 5519 6613 +11921 2 2 13 11 4695 5441 6060 +11922 2 2 13 11 4696 6061 5442 +11923 2 2 13 11 4358 5166 6140 +11924 2 2 13 11 4692 5659 5963 +11925 2 2 13 11 4194 5937 5170 +11926 2 2 13 11 3974 6816 5214 +11927 2 2 13 11 3699 5125 6362 +11928 2 2 13 11 3772 6718 5752 +11929 2 2 13 11 4261 5877 6721 +11930 2 2 13 11 4355 6341 5251 +11931 2 2 13 11 4356 5252 6343 +11932 2 2 13 11 4753 5969 6623 +11933 2 2 13 11 284 6663 285 +11934 2 2 13 11 4279 6181 5195 +11935 2 2 13 11 3849 6323 5426 +11936 2 2 13 11 4472 6791 5357 +11937 2 2 13 11 3688 6808 5139 +11938 2 2 13 11 4072 6675 5076 +11939 2 2 13 11 3913 6941 6041 +11940 2 2 13 11 3792 5188 6210 +11941 2 2 13 11 3793 6211 5189 +11942 2 2 13 11 3835 5191 6385 +11943 2 2 13 11 4247 5175 6018 +11944 2 2 13 11 3850 6545 5074 +11945 2 2 13 11 4160 5337 5828 +11946 2 2 13 11 4485 6436 5644 +11947 2 2 13 11 4218 6759 5219 +11948 2 2 13 11 4219 5220 6760 +11949 2 2 13 11 4826 6576 5600 +11950 2 2 13 11 3931 6192 5151 +11951 2 2 13 11 3867 6464 5728 +11952 2 2 13 11 3788 6737 5064 +11953 2 2 13 11 121 122 6608 +11954 2 2 13 11 4086 5187 6284 +11955 2 2 13 11 4213 5609 6332 +11956 2 2 13 11 3870 5198 6153 +11957 2 2 13 11 4429 6862 5343 +11958 2 2 13 11 4430 5344 6863 +11959 2 2 13 11 4460 6895 5218 +11960 2 2 13 11 3740 5121 6748 +11961 2 2 13 11 4035 5248 5994 +11962 2 2 13 11 4140 5090 6817 +11963 2 2 13 11 3914 5398 6144 +11964 2 2 13 11 4344 6311 5346 +11965 2 2 13 11 4435 6597 6775 +11966 2 2 13 11 4329 5844 5281 +11967 2 2 13 11 4937 6041 6941 +11968 2 2 13 11 3930 6235 5164 +11969 2 2 13 11 4363 5253 6242 +11970 2 2 13 11 4336 5478 5828 +11971 2 2 13 11 3945 5194 6778 +11972 2 2 13 11 4300 5815 5387 +11973 2 2 13 11 4301 5388 5816 +11974 2 2 13 11 4271 5182 6004 +11975 2 2 13 11 4272 6005 5183 +11976 2 2 13 11 3710 5180 6509 +11977 2 2 13 11 3737 6194 5953 +11978 2 2 13 11 3823 6784 5107 +11979 2 2 13 11 3738 5954 6195 +11980 2 2 13 11 4422 5482 6219 +11981 2 2 13 11 4625 6271 5413 +11982 2 2 13 11 4370 6223 5307 +11983 2 2 13 11 4597 6911 5500 +11984 2 2 13 11 4323 5129 6368 +11985 2 2 13 11 4324 6369 5130 +11986 2 2 13 11 3719 6685 5212 +11987 2 2 13 11 3720 5213 6686 +11988 2 2 13 11 3920 5262 6456 +11989 2 2 13 11 3872 5413 6271 +11990 2 2 13 11 3911 5527 6070 +11991 2 2 13 11 3912 6071 5528 +11992 2 2 13 11 5097 6637 6049 +11993 2 2 13 11 5098 6050 6638 +11994 2 2 13 11 3789 5445 5712 +11995 2 2 13 11 3790 5713 5446 +11996 2 2 13 11 334 5909 335 +11997 2 2 13 11 241 5910 242 +11998 2 2 13 11 4596 6473 5406 +11999 2 2 13 11 4765 6663 6673 +12000 2 2 13 11 4463 5451 5874 +12001 2 2 13 11 137 138 6857 +12002 2 2 13 11 4599 5653 6110 +12003 2 2 13 11 4384 6552 5279 +12004 2 2 13 11 3796 6788 5154 +12005 2 2 13 11 287 5568 6564 +12006 2 2 13 11 4113 5501 6315 +12007 2 2 13 11 4551 5749 5436 +12008 2 2 13 11 3735 5820 6293 +12009 2 2 13 11 4232 5536 5981 +12010 2 2 13 11 4233 5982 5537 +12011 2 2 13 11 4490 6884 5560 +12012 2 2 13 11 3992 6641 5271 +12013 2 2 13 11 4486 5788 5508 +12014 2 2 13 11 3744 5251 6341 +12015 2 2 13 11 3745 6343 5252 +12016 2 2 13 11 4332 5679 5826 +12017 2 2 13 11 4649 6944 5105 +12018 2 2 13 11 4650 5106 6945 +12019 2 2 13 11 4093 6428 5181 +12020 2 2 13 11 4202 6163 5325 +12021 2 2 13 11 4897 5992 5404 +12022 2 2 13 11 4898 5405 5993 +12023 2 2 13 11 4446 5540 6415 +12024 2 2 13 11 4346 5242 6653 +12025 2 2 13 11 4063 5313 6100 +12026 2 2 13 11 3771 5228 6764 +12027 2 2 13 11 4064 6102 5316 +12028 2 2 13 11 4419 5841 5481 +12029 2 2 13 11 3814 6137 5420 +12030 2 2 13 11 92 5806 6906 +12031 2 2 13 11 3743 5436 5749 +12032 2 2 13 11 4736 5780 6899 +12033 2 2 13 11 4389 5111 6648 +12034 2 2 13 11 4390 6649 5112 +12035 2 2 13 11 3779 6893 5553 +12036 2 2 13 11 3697 6711 5470 +12037 2 2 13 11 3968 6437 6867 +12038 2 2 13 11 4176 5661 5842 +12039 2 2 13 11 3969 6869 6438 +12040 2 2 13 11 4286 5574 5670 +12041 2 2 13 11 4360 6324 5131 +12042 2 2 13 11 79 6605 5373 +12043 2 2 13 11 4261 6257 5877 +12044 2 2 13 11 4649 5199 6133 +12045 2 2 13 11 4650 6134 5200 +12046 2 2 13 11 4305 5918 6100 +12047 2 2 13 11 4448 6240 5165 +12048 2 2 13 11 4306 6102 5919 +12049 2 2 13 11 4782 6857 5101 +12050 2 2 13 11 4710 6789 6853 +12051 2 2 13 11 3814 6467 6526 +12052 2 2 13 11 3670 5259 6715 +12053 2 2 13 11 4079 5434 6114 +12054 2 2 13 11 4080 6115 5435 +12055 2 2 13 11 104 105 6348 +12056 2 2 13 11 3841 5546 5959 +12057 2 2 13 11 4133 5338 6339 +12058 2 2 13 11 4269 5286 5989 +12059 2 2 13 11 3735 6293 5765 +12060 2 2 13 11 4224 6039 5191 +12061 2 2 13 11 4789 6466 5302 +12062 2 2 13 11 4245 5808 5900 +12063 2 2 13 11 144 5455 5907 +12064 2 2 13 11 4369 6422 6821 +12065 2 2 13 11 4371 6822 6423 +12066 2 2 13 11 4790 6732 5813 +12067 2 2 13 11 4254 5670 5574 +12068 2 2 13 11 4012 5121 6308 +12069 2 2 13 11 4126 5390 5825 +12070 2 2 13 11 4255 5473 5842 +12071 2 2 13 11 4339 5250 6347 +12072 2 2 13 11 4379 6271 6818 +12073 2 2 13 11 4173 5615 5846 +12074 2 2 13 11 4174 5847 5616 +12075 2 2 13 11 4549 6058 6937 +12076 2 2 13 11 4011 5218 6895 +12077 2 2 13 11 4360 5131 6498 +12078 2 2 13 11 4522 6100 5918 +12079 2 2 13 11 4523 5919 6102 +12080 2 2 13 11 4459 6623 5969 +12081 2 2 13 11 4586 6644 5901 +12082 2 2 13 11 4380 5221 6232 +12083 2 2 13 11 3691 5734 6680 +12084 2 2 13 11 4644 6221 5674 +12085 2 2 13 11 4553 6729 5550 +12086 2 2 13 11 4001 6807 5791 +12087 2 2 13 11 4420 5497 5721 +12088 2 2 13 11 4321 6712 5171 +12089 2 2 13 11 5105 6944 5327 +12090 2 2 13 11 5106 5328 6945 +12091 2 2 13 11 4564 5736 5484 +12092 2 2 13 11 4104 6513 5143 +12093 2 2 13 11 4484 5962 6000 +12094 2 2 13 11 4709 6164 6815 +12095 2 2 13 11 4516 6604 5150 +12096 2 2 13 11 4517 5151 6606 +12097 2 2 13 11 4190 6661 5666 +12098 2 2 13 11 4076 5495 5882 +12099 2 2 13 11 296 5989 5286 +12100 2 2 13 11 4028 6884 5186 +12101 2 2 13 11 4429 6627 6056 +12102 2 2 13 11 4430 6057 6628 +12103 2 2 13 11 3888 5481 5841 +12104 2 2 13 11 4121 5864 5400 +12105 2 2 13 11 4122 5401 5865 +12106 2 2 13 11 3835 6385 6463 +12107 2 2 13 11 3827 5186 6390 +12108 2 2 13 11 4464 5373 6605 +12109 2 2 13 11 3716 6516 5365 +12110 2 2 13 11 4146 5721 5497 +12111 2 2 13 11 4683 5306 5972 +12112 2 2 13 11 4059 5115 6684 +12113 2 2 13 11 4335 6485 5117 +12114 2 2 13 11 3879 5193 6377 +12115 2 2 13 11 129 5225 6024 +12116 2 2 13 11 4490 5202 6390 +12117 2 2 13 11 119 6140 5166 +12118 2 2 13 11 4211 6221 5312 +12119 2 2 13 11 3649 5408 6701 +12120 2 2 13 11 4812 6565 5306 +12121 2 2 13 11 4020 5282 6722 +12122 2 2 13 11 4021 6723 5283 +12123 2 2 13 11 4480 5170 6849 +12124 2 2 13 11 3777 5731 6558 +12125 2 2 13 11 3728 5874 5451 +12126 2 2 13 11 4486 5214 6816 +12127 2 2 13 11 4296 5120 6416 +12128 2 2 13 11 3866 5958 5407 +12129 2 2 13 11 3833 5845 5368 +12130 2 2 13 11 4711 5752 6718 +12131 2 2 13 11 111 112 6026 +12132 2 2 13 11 4599 6110 6143 +12133 2 2 13 11 4247 6241 5175 +12134 2 2 13 11 3739 5175 6241 +12135 2 2 13 11 3727 5508 5788 +12136 2 2 13 11 4166 5594 5942 +12137 2 2 13 11 4167 5943 5595 +12138 2 2 13 11 4376 6066 5408 +12139 2 2 13 11 4887 6526 6467 +12140 2 2 13 11 165 166 6079 +12141 2 2 13 11 55 56 6080 +12142 2 2 13 11 4694 6889 5744 +12143 2 2 13 11 4241 5160 6217 +12144 2 2 13 11 4160 5828 5478 +12145 2 2 13 11 4242 6218 5161 +12146 2 2 13 11 3712 6404 6950 +12147 2 2 13 11 4640 6570 6449 +12148 2 2 13 11 4030 5159 6447 +12149 2 2 13 11 3842 6654 5771 +12150 2 2 13 11 3725 5716 6135 +12151 2 2 13 11 3723 5274 6175 +12152 2 2 13 11 3740 5500 6911 +12153 2 2 13 11 3850 5256 6545 +12154 2 2 13 11 4334 5336 6167 +12155 2 2 13 11 4211 5312 6129 +12156 2 2 13 11 4248 5339 5977 +12157 2 2 13 11 4293 6143 6110 +12158 2 2 13 11 4989 5649 6239 +12159 2 2 13 11 3728 6450 5170 +12160 2 2 13 11 4017 6637 5097 +12161 2 2 13 11 4018 5098 6638 +12162 2 2 13 11 4291 6119 5290 +12163 2 2 13 11 3861 6415 5540 +12164 2 2 13 11 4433 6054 5772 +12165 2 2 13 11 4434 5773 6055 +12166 2 2 13 11 4137 6736 6094 +12167 2 2 13 11 4274 5144 6442 +12168 2 2 13 11 3979 6548 6104 +12169 2 2 13 11 4176 5842 5473 +12170 2 2 13 11 4532 6006 6765 +12171 2 2 13 11 305 6014 306 +12172 2 2 13 11 4035 5155 6700 +12173 2 2 13 11 4686 5805 5521 +12174 2 2 13 11 4102 5196 6502 +12175 2 2 13 11 130 6266 5225 +12176 2 2 13 11 4426 6408 5430 +12177 2 2 13 11 4581 5522 5778 +12178 2 2 13 11 4614 5577 5827 +12179 2 2 13 11 4506 6772 5140 +12180 2 2 13 11 4050 6839 5333 +12181 2 2 13 11 4051 5334 6840 +12182 2 2 13 11 4450 5479 5760 +12183 2 2 13 11 4622 6342 5292 +12184 2 2 13 11 4348 6144 5398 +12185 2 2 13 11 4447 6778 5194 +12186 2 2 13 11 4401 5951 5621 +12187 2 2 13 11 4571 5765 6293 +12188 2 2 13 11 3824 5518 6214 +12189 2 2 13 11 4305 6100 5313 +12190 2 2 13 11 4306 5316 6102 +12191 2 2 13 11 3700 5346 6311 +12192 2 2 13 11 3661 6703 5699 +12193 2 2 13 11 4550 5197 6429 +12194 2 2 13 11 4011 6902 5776 +12195 2 2 13 11 4295 6404 5144 +12196 2 2 13 11 4128 5697 6098 +12197 2 2 13 11 4129 6099 5698 +12198 2 2 13 11 4452 6006 6396 +12199 2 2 13 11 4453 6397 6007 +12200 2 2 13 11 4450 6920 5326 +12201 2 2 13 11 4314 6518 5341 +12202 2 2 13 11 4315 5342 6519 +12203 2 2 13 11 4026 6838 5185 +12204 2 2 13 11 4617 6293 5820 +12205 2 2 13 11 4600 6564 5568 +12206 2 2 13 11 3874 5690 6272 +12207 2 2 13 11 3876 6273 5691 +12208 2 2 13 11 4310 6000 5962 +12209 2 2 13 11 4405 5192 6225 +12210 2 2 13 11 4181 5326 5866 +12211 2 2 13 11 3796 5159 6725 +12212 2 2 13 11 330 6942 331 +12213 2 2 13 11 245 6943 246 +12214 2 2 13 11 4453 6007 6861 +12215 2 2 13 11 4313 5246 6254 +12216 2 2 13 11 4812 6809 5830 +12217 2 2 13 11 4406 6831 5597 +12218 2 2 13 11 4470 6135 5716 +12219 2 2 13 11 3873 6527 5800 +12220 2 2 13 11 4640 5844 6570 +12221 2 2 13 11 4413 6033 6691 +12222 2 2 13 11 4872 6731 6785 +12223 2 2 13 11 4498 6889 6613 +12224 2 2 13 11 3884 6604 5467 +12225 2 2 13 11 4575 6571 5874 +12226 2 2 13 11 3716 5430 6408 +12227 2 2 13 11 4085 6287 5226 +12228 2 2 13 11 4079 6598 5434 +12229 2 2 13 11 4080 5435 6599 +12230 2 2 13 11 3879 6110 5653 +12231 2 2 13 11 4674 6356 5488 +12232 2 2 13 11 4461 6230 5232 +12233 2 2 13 11 5045 6503 5210 +12234 2 2 13 11 3844 6022 5671 +12235 2 2 13 11 5046 5211 6504 +12236 2 2 13 11 4760 5516 6775 +12237 2 2 13 11 4425 5671 6022 +12238 2 2 13 11 3688 6263 6808 +12239 2 2 13 11 4106 6047 5289 +12240 2 2 13 11 4473 6764 5228 +12241 2 2 13 11 4334 5738 6081 +12242 2 2 13 11 4294 5270 6338 +12243 2 2 13 11 4787 5871 5582 +12244 2 2 13 11 4190 5784 6661 +12245 2 2 13 11 4391 5546 5718 +12246 2 2 13 11 314 6049 315 +12247 2 2 13 11 261 6050 262 +12248 2 2 13 11 3880 5826 5679 +12249 2 2 13 11 321 6056 322 +12250 2 2 13 11 254 6057 255 +12251 2 2 13 11 4077 6280 5247 +12252 2 2 13 11 3991 6951 5632 +12253 2 2 13 11 4190 5619 5784 +12254 2 2 13 11 4682 5908 5904 +12255 2 2 13 11 3946 6411 5240 +12256 2 2 13 11 4453 6861 6674 +12257 2 2 13 11 4872 5271 6731 +12258 2 2 13 11 4037 5210 6503 +12259 2 2 13 11 4173 5846 5457 +12260 2 2 13 11 4174 5458 5847 +12261 2 2 13 11 4038 6504 5211 +12262 2 2 13 11 95 6621 5383 +12263 2 2 13 11 3877 5657 6364 +12264 2 2 13 11 4541 5926 6806 +12265 2 2 13 11 4318 6117 5227 +12266 2 2 13 11 4451 5365 6516 +12267 2 2 13 11 4391 5959 5546 +12268 2 2 13 11 3657 5973 5382 +12269 2 2 13 11 4617 5820 6675 +12270 2 2 13 11 4304 5280 6168 +12271 2 2 13 11 4328 6367 5960 +12272 2 2 13 11 4714 6680 5734 +12273 2 2 13 11 4491 6565 6747 +12274 2 2 13 11 4095 5327 6944 +12275 2 2 13 11 4096 6945 5328 +12276 2 2 13 11 4158 5285 6155 +12277 2 2 13 11 3764 5278 6123 +12278 2 2 13 11 4155 5135 6577 +12279 2 2 13 11 4202 5505 6163 +12280 2 2 13 11 4138 5878 5437 +12281 2 2 13 11 4139 5438 5879 +12282 2 2 13 11 4353 5846 5615 +12283 2 2 13 11 4354 5616 5847 +12284 2 2 13 11 3850 6891 6332 +12285 2 2 13 11 3797 5219 6759 +12286 2 2 13 11 3798 6760 5220 +12287 2 2 13 11 4530 6558 5201 +12288 2 2 13 11 3687 5235 6653 +12289 2 2 13 11 4985 6552 5753 +12290 2 2 13 11 4269 6174 5286 +12291 2 2 13 11 4404 6545 5256 +12292 2 2 13 11 4833 6836 6495 +12293 2 2 13 11 3649 6633 5408 +12294 2 2 13 11 3980 6319 6674 +12295 2 2 13 11 4044 6365 5235 +12296 2 2 13 11 4990 5251 6424 +12297 2 2 13 11 4991 6425 5252 +12298 2 2 13 11 4045 5236 6366 +12299 2 2 13 11 3871 5972 5306 +12300 2 2 13 11 4388 6467 6742 +12301 2 2 13 11 4464 6698 5373 +12302 2 2 13 11 4894 6910 5319 +12303 2 2 13 11 327 6091 328 +12304 2 2 13 11 248 6092 249 +12305 2 2 13 11 4254 5574 6462 +12306 2 2 13 11 4213 5861 5609 +12307 2 2 13 11 3920 5890 6567 +12308 2 2 13 11 4223 6016 6126 +12309 2 2 13 11 4214 5329 6676 +12310 2 2 13 11 119 120 6140 +12311 2 2 13 11 4223 5228 6952 +12312 2 2 13 11 3951 5569 6596 +12313 2 2 13 11 4834 6494 6850 +12314 2 2 13 11 3695 6453 5411 +12315 2 2 13 11 3696 5412 6454 +12316 2 2 13 11 4138 5445 5878 +12317 2 2 13 11 4139 5879 5446 +12318 2 2 13 11 3905 6570 5844 +12319 2 2 13 11 4339 5694 6287 +12320 2 2 13 11 4351 6534 5257 +12321 2 2 13 11 4352 5258 6535 +12322 2 2 13 11 3821 6146 5403 +12323 2 2 13 11 4351 5942 5594 +12324 2 2 13 11 4953 6674 6319 +12325 2 2 13 11 4352 5595 5943 +12326 2 2 13 11 4633 5209 6709 +12327 2 2 13 11 4084 5224 6231 +12328 2 2 13 11 3928 5977 5339 +12329 2 2 13 11 3919 6338 5270 +12330 2 2 13 11 3916 6826 5511 +12331 2 2 13 11 3919 6566 5857 +12332 2 2 13 11 3688 5236 6263 +12333 2 2 13 11 4376 6633 5267 +12334 2 2 13 11 4690 6066 5520 +12335 2 2 13 11 3659 6360 5185 +12336 2 2 13 11 4007 6777 5244 +12337 2 2 13 11 4088 5521 5805 +12338 2 2 13 11 3740 6120 6143 +12339 2 2 13 11 3820 5802 6117 +12340 2 2 13 11 5242 6830 6653 +12341 2 2 13 11 3825 5796 6922 +12342 2 2 13 11 272 6147 273 +12343 2 2 13 11 3800 5349 6085 +12344 2 2 13 11 3801 6086 5350 +12345 2 2 13 11 4795 5482 6334 +12346 2 2 13 11 4559 6124 6085 +12347 2 2 13 11 3838 5352 6316 +12348 2 2 13 11 3839 6317 5353 +12349 2 2 13 11 4506 6844 5249 +12350 2 2 13 11 4378 5565 6669 +12351 2 2 13 11 4474 5383 6621 +12352 2 2 13 11 4588 5958 6202 +12353 2 2 13 11 4188 5763 5552 +12354 2 2 13 11 91 6906 5617 +12355 2 2 13 11 4005 5230 6658 +12356 2 2 13 11 4453 6674 6151 +12357 2 2 13 11 3966 5574 6314 +12358 2 2 13 11 4702 5922 6834 +12359 2 2 13 11 4743 6799 5288 +12360 2 2 13 11 300 6729 301 +12361 2 2 13 11 4184 6013 5382 +12362 2 2 13 11 4403 6690 5881 +12363 2 2 13 11 4178 6689 5234 +12364 2 2 13 11 4256 5212 6685 +12365 2 2 13 11 4257 6686 5213 +12366 2 2 13 11 4203 5904 5908 +12367 2 2 13 11 3829 5279 6552 +12368 2 2 13 11 162 163 6327 +12369 2 2 13 11 58 59 6328 +12370 2 2 13 11 4267 5867 5506 +12371 2 2 13 11 4106 6810 5484 +12372 2 2 13 11 4256 5437 5878 +12373 2 2 13 11 4257 5879 5438 +12374 2 2 13 11 3658 5329 5979 +12375 2 2 13 11 4847 5782 5888 +12376 2 2 13 11 4300 6821 6060 +12377 2 2 13 11 4301 6061 6822 +12378 2 2 13 11 3759 5526 6744 +12379 2 2 13 11 4800 6104 6548 +12380 2 2 13 11 4786 6682 6383 +12381 2 2 13 11 4499 5960 6367 +12382 2 2 13 11 149 150 6350 +12383 2 2 13 11 4644 5776 6820 +12384 2 2 13 11 4914 6808 6263 +12385 2 2 13 11 4133 6339 5517 +12386 2 2 13 11 3838 6243 5387 +12387 2 2 13 11 3839 5388 6244 +12388 2 2 13 11 4367 6191 5769 +12389 2 2 13 11 4118 5827 5577 +12390 2 2 13 11 4237 6871 6864 +12391 2 2 13 11 4238 6865 6872 +12392 2 2 13 11 4252 5392 6702 +12393 2 2 13 11 4232 5981 5970 +12394 2 2 13 11 4233 5971 5982 +12395 2 2 13 11 4183 5582 5871 +12396 2 2 13 11 3786 5343 6019 +12397 2 2 13 11 3787 6020 5344 +12398 2 2 13 11 4516 5467 6604 +12399 2 2 13 11 3883 5621 5951 +12400 2 2 13 11 3838 6316 5409 +12401 2 2 13 11 3839 5410 6317 +12402 2 2 13 11 4194 6456 5262 +12403 2 2 13 11 71 72 6375 +12404 2 2 13 11 4739 6126 6016 +12405 2 2 13 11 3689 6448 5375 +12406 2 2 13 11 4017 6045 6062 +12407 2 2 13 11 4018 6064 6046 +12408 2 2 13 11 4209 5275 6197 +12409 2 2 13 11 4652 5800 6527 +12410 2 2 13 11 3671 6190 5300 +12411 2 2 13 11 4770 5524 6757 +12412 2 2 13 11 4394 5261 6361 +12413 2 2 13 11 4206 6789 6160 +12414 2 2 13 11 4258 5907 5455 +12415 2 2 13 11 5347 6835 6147 +12416 2 2 13 11 4328 5841 5923 +12417 2 2 13 11 4507 5434 6598 +12418 2 2 13 11 4508 6599 5435 +12419 2 2 13 11 5063 6447 5803 +12420 2 2 13 11 4143 5818 6382 +12421 2 2 13 11 74 75 6380 +12422 2 2 13 11 157 158 6388 +12423 2 2 13 11 63 64 6389 +12424 2 2 13 11 4535 5809 5987 +12425 2 2 13 11 4197 5941 6946 +12426 2 2 13 11 4576 5882 5495 +12427 2 2 13 11 4715 5817 5709 +12428 2 2 13 11 3852 6819 6623 +12429 2 2 13 11 4153 6161 5493 +12430 2 2 13 11 4164 6239 5649 +12431 2 2 13 11 3718 5556 5960 +12432 2 2 13 11 4287 5825 5996 +12433 2 2 13 11 4659 5617 6906 +12434 2 2 13 11 3896 6193 5787 +12435 2 2 13 11 4709 6384 5785 +12436 2 2 13 11 4273 5221 6526 +12437 2 2 13 11 4342 6468 6540 +12438 2 2 13 11 97 98 6410 +12439 2 2 13 11 4343 6541 6469 +12440 2 2 13 11 4759 6259 5912 +12441 2 2 13 11 334 6916 5909 +12442 2 2 13 11 242 5910 6917 +12443 2 2 13 11 4653 6170 6951 +12444 2 2 13 11 4763 6657 6596 +12445 2 2 13 11 4274 6442 5269 +12446 2 2 13 11 3711 5856 6441 +12447 2 2 13 11 4560 6086 6125 +12448 2 2 13 11 4337 5240 6411 +12449 2 2 13 11 3658 6676 5329 +12450 2 2 13 11 5159 5277 6725 +12451 2 2 13 11 4691 6883 5662 +12452 2 2 13 11 87 88 6434 +12453 2 2 13 11 4643 5995 6754 +12454 2 2 13 11 4227 5987 5809 +12455 2 2 13 11 4769 6059 5742 +12456 2 2 13 11 5443 6586 5998 +12457 2 2 13 11 4655 6138 6919 +12458 2 2 13 11 4809 6855 6148 +12459 2 2 13 11 4810 6150 6856 +12460 2 2 13 11 4633 5784 5619 +12461 2 2 13 11 292 6245 293 +12462 2 2 13 11 4473 6610 6659 +12463 2 2 13 11 4333 5951 6003 +12464 2 2 13 11 3907 5575 6063 +12465 2 2 13 11 4265 6532 5404 +12466 2 2 13 11 4266 5405 6533 +12467 2 2 13 11 3802 5254 6800 +12468 2 2 13 11 3800 6085 6124 +12469 2 2 13 11 3707 5312 6221 +12470 2 2 13 11 3863 6924 5282 +12471 2 2 13 11 3864 5283 6925 +12472 2 2 13 11 4693 5444 6672 +12473 2 2 13 11 3814 6526 5221 +12474 2 2 13 11 4447 5194 6582 +12475 2 2 13 11 278 6269 279 +12476 2 2 13 11 3923 5920 6609 +12477 2 2 13 11 4484 6636 6470 +12478 2 2 13 11 4313 6433 5641 +12479 2 2 13 11 4142 5957 5498 +12480 2 2 13 11 4184 5709 5817 +12481 2 2 13 11 4276 5461 6009 +12482 2 2 13 11 4277 6010 5463 +12483 2 2 13 11 4300 6060 5441 +12484 2 2 13 11 4301 5442 6061 +12485 2 2 13 11 3910 6741 5506 +12486 2 2 13 11 3784 5325 6163 +12487 2 2 13 11 4321 5176 6712 +12488 2 2 13 11 4495 6936 5541 +12489 2 2 13 11 4297 6412 5920 +12490 2 2 13 11 85 5288 6799 +12491 2 2 13 11 3992 6870 6641 +12492 2 2 13 11 4699 6926 6474 +12493 2 2 13 11 4700 6475 6927 +12494 2 2 13 11 3744 6424 5251 +12495 2 2 13 11 3745 5252 6425 +12496 2 2 13 11 3840 5963 5659 +12497 2 2 13 11 4289 6085 5349 +12498 2 2 13 11 4290 5350 6086 +12499 2 2 13 11 4361 5243 6595 +12500 2 2 13 11 4291 5290 6512 +12501 2 2 13 11 4379 5887 5868 +12502 2 2 13 11 4502 5443 6937 +12503 2 2 13 11 4701 5702 6659 +12504 2 2 13 11 3652 6277 5307 +12505 2 2 13 11 4318 5227 6730 +12506 2 2 13 11 4331 5868 5887 +12507 2 2 13 11 4342 5810 6172 +12508 2 2 13 11 4343 6173 5811 +12509 2 2 13 11 4598 5511 6826 +12510 2 2 13 11 4493 5787 6193 +12511 2 2 13 11 4599 6143 6120 +12512 2 2 13 11 4376 5520 6066 +12513 2 2 13 11 299 6352 5550 +12514 2 2 13 11 4134 6576 5421 +12515 2 2 13 11 3949 6226 6559 +12516 2 2 13 11 3835 5576 6186 +12517 2 2 13 11 4507 6666 5557 +12518 2 2 13 11 4508 5558 6667 +12519 2 2 13 11 4265 5404 5992 +12520 2 2 13 11 4266 5993 5405 +12521 2 2 13 11 4294 6603 5270 +12522 2 2 13 11 3801 6125 6086 +12523 2 2 13 11 3901 5902 5572 +12524 2 2 13 11 4165 6932 5734 +12525 2 2 13 11 4283 5431 6393 +12526 2 2 13 11 4284 6394 5432 +12527 2 2 13 11 4392 6752 5282 +12528 2 2 13 11 4440 5331 6677 +12529 2 2 13 11 4393 5283 6753 +12530 2 2 13 11 4562 6744 5526 +12531 2 2 13 11 4271 5647 6096 +12532 2 2 13 11 4272 6097 5648 +12533 2 2 13 11 3828 5215 6457 +12534 2 2 13 11 3829 6458 5216 +12535 2 2 13 11 4106 6677 5331 +12536 2 2 13 11 4800 6939 6104 +12537 2 2 13 11 4555 6062 6045 +12538 2 2 13 11 4556 6046 6064 +12539 2 2 13 11 4316 5568 6154 +12540 2 2 13 11 3892 6131 5832 +12541 2 2 13 11 3893 5833 6132 +12542 2 2 13 11 4419 5923 5841 +12543 2 2 13 11 79 80 6605 +12544 2 2 13 11 4714 5734 6932 +12545 2 2 13 11 4247 6413 5456 +12546 2 2 13 11 4344 6202 5958 +12547 2 2 13 11 4425 5375 6448 +12548 2 2 13 11 4733 5406 6473 +12549 2 2 13 11 3902 6255 5684 +12550 2 2 13 11 4289 6694 5293 +12551 2 2 13 11 3903 5685 6256 +12552 2 2 13 11 4290 5294 6695 +12553 2 2 13 11 4730 5468 6212 +12554 2 2 13 11 3807 5677 6180 +12555 2 2 13 11 4717 6456 6450 +12556 2 2 13 11 3922 6801 5492 +12557 2 2 13 11 4614 6578 5464 +12558 2 2 13 11 4105 5272 6624 +12559 2 2 13 11 4547 5970 5981 +12560 2 2 13 11 3712 5269 6442 +12561 2 2 13 11 4548 5982 5971 +12562 2 2 13 11 95 96 6621 +12563 2 2 13 11 3731 6109 5489 +12564 2 2 13 11 3732 5490 6111 +12565 2 2 13 11 328 6091 6481 +12566 2 2 13 11 248 6482 6092 +12567 2 2 13 11 4564 5484 6810 +12568 2 2 13 11 4328 5960 5556 +12569 2 2 13 11 4417 6658 5230 +12570 2 2 13 11 4427 6383 6682 +12571 2 2 13 11 3934 5437 6795 +12572 2 2 13 11 3935 6796 5438 +12573 2 2 13 11 4494 5769 6191 +12574 2 2 13 11 4821 6622 5500 +12575 2 2 13 11 4334 6081 6935 +12576 2 2 13 11 134 135 6660 +12577 2 2 13 11 3 337 6897 +12578 2 2 13 11 4 6898 239 +12579 2 2 13 11 298 6352 299 +12580 2 2 13 11 4394 5738 5933 +12581 2 2 13 11 3875 6730 5227 +12582 2 2 13 11 3971 6496 5393 +12583 2 2 13 11 3904 5947 6866 +12584 2 2 13 11 4799 6395 6517 +12585 2 2 13 11 4387 5855 6585 +12586 2 2 13 11 3 6897 168 +12587 2 2 13 11 4 53 6898 +12588 2 2 13 11 4518 5396 6161 +12589 2 2 13 11 310 6912 311 +12590 2 2 13 11 265 6913 266 +12591 2 2 13 11 4288 6320 5243 +12592 2 2 13 11 4419 5275 6892 +12593 2 2 13 11 3931 6815 6164 +12594 2 2 13 11 4440 6508 5469 +12595 2 2 13 11 3986 6937 5443 +12596 2 2 13 11 3679 6069 5737 +12597 2 2 13 11 4428 5496 6514 +12598 2 2 13 11 4369 5387 6243 +12599 2 2 13 11 4310 5962 5603 +12600 2 2 13 11 4371 6244 5388 +12601 2 2 13 11 4349 5798 6600 +12602 2 2 13 11 84 85 6799 +12603 2 2 13 11 4195 5990 5541 +12604 2 2 13 11 3666 5557 6666 +12605 2 2 13 11 3691 6680 5234 +12606 2 2 13 11 3667 6667 5558 +12607 2 2 13 11 4625 6818 6271 +12608 2 2 13 11 4761 6351 5539 +12609 2 2 13 11 4444 6399 6486 +12610 2 2 13 11 4714 5903 6680 +12611 2 2 13 11 91 92 6906 +12612 2 2 13 11 126 127 6931 +12613 2 2 13 11 4796 5292 6342 +12614 2 2 13 11 3894 5933 5738 +12615 2 2 13 11 3852 5633 6008 +12616 2 2 13 11 4210 6379 5803 +12617 2 2 13 11 4114 6234 5507 +12618 2 2 13 11 4261 6186 5576 +12619 2 2 13 11 4382 6517 6395 +12620 2 2 13 11 4304 6780 5280 +12621 2 2 13 11 4562 5573 6189 +12622 2 2 13 11 4422 5896 6334 +12623 2 2 13 11 3772 5727 6718 +12624 2 2 13 11 4613 6441 5856 +12625 2 2 13 11 4791 6579 5428 +12626 2 2 13 11 5134 5807 6946 +12627 2 2 13 11 3920 6557 5262 +12628 2 2 13 11 4101 5325 6735 +12629 2 2 13 11 4792 5429 6557 +12630 2 2 13 11 4304 6168 6048 +12631 2 2 13 11 4736 6731 5271 +12632 2 2 13 11 4754 5572 6376 +12633 2 2 13 11 4250 6370 5758 +12634 2 2 13 11 4251 5759 6371 +12635 2 2 13 11 4302 5677 5964 +12636 2 2 13 11 4303 5965 5678 +12637 2 2 13 11 3689 5375 6253 +12638 2 2 13 11 4383 6379 5643 +12639 2 2 13 11 3865 5884 6122 +12640 2 2 13 11 4984 6701 5408 +12641 2 2 13 11 3810 5280 6780 +12642 2 2 13 11 4670 6609 5920 +12643 2 2 13 11 100 101 6769 +12644 2 2 13 11 4825 6160 6789 +12645 2 2 13 11 4401 6003 5951 +12646 2 2 13 11 326 6928 327 +12647 2 2 13 11 249 6929 250 +12648 2 2 13 11 3748 6785 6731 +12649 2 2 13 11 4662 5420 6137 +12650 2 2 13 11 4150 6711 5284 +12651 2 2 13 11 4310 5603 5952 +12652 2 2 13 11 3657 6349 5320 +12653 2 2 13 11 4389 5486 6388 +12654 2 2 13 11 4390 6389 5487 +12655 2 2 13 11 4171 5742 6059 +12656 2 2 13 11 3919 5270 6579 +12657 2 2 13 11 4660 6757 5524 +12658 2 2 13 11 4388 5393 6496 +12659 2 2 13 11 3807 6180 5913 +12660 2 2 13 11 109 110 6581 +12661 2 2 13 11 3980 5860 5881 +12662 2 2 13 11 4332 5826 5790 +12663 2 2 13 11 4282 6768 5421 +12664 2 2 13 11 4864 5941 5836 +12665 2 2 13 11 4279 6820 5776 +12666 2 2 13 11 4268 5593 6851 +12667 2 2 13 11 4565 5413 6953 +12668 2 2 13 11 4456 6647 6014 +12669 2 2 13 11 328 6481 329 +12670 2 2 13 11 247 6482 248 +12671 2 2 13 11 5119 6261 6905 +12672 2 2 13 11 4452 6396 6922 +12673 2 2 13 11 4312 5498 5957 +12674 2 2 13 11 3871 5306 6565 +12675 2 2 13 11 4552 6048 6168 +12676 2 2 13 11 3677 6762 5255 +12677 2 2 13 11 4803 6336 5523 +12678 2 2 13 11 4198 5271 6641 +12679 2 2 13 11 3730 5603 5962 +12680 2 2 13 11 4585 5650 6281 +12681 2 2 13 11 5097 5822 6546 +12682 2 2 13 11 5098 6547 5823 +12683 2 2 13 11 4836 6275 6899 +12684 2 2 13 11 4923 5936 6159 +12685 2 2 13 11 4403 5881 5860 +12686 2 2 13 11 3708 6198 6846 +12687 2 2 13 11 4179 6905 5474 +12688 2 2 13 11 3863 5282 6752 +12689 2 2 13 11 3864 6753 5283 +12690 2 2 13 11 4590 6043 5801 +12691 2 2 13 11 281 6537 282 +12692 2 2 13 11 4472 6575 6791 +12693 2 2 13 11 4254 6462 5899 +12694 2 2 13 11 4312 6068 5644 +12695 2 2 13 11 4460 5550 6352 +12696 2 2 13 11 3970 6671 5851 +12697 2 2 13 11 4802 6866 5947 +12698 2 2 13 11 3857 5529 6054 +12699 2 2 13 11 3858 6055 5530 +12700 2 2 13 11 3932 5888 5782 +12701 2 2 13 11 4819 5857 6566 +12702 2 2 13 11 4273 5673 6683 +12703 2 2 13 11 157 6388 5486 +12704 2 2 13 11 64 5487 6389 +12705 2 2 13 11 4684 5684 6255 +12706 2 2 13 11 4685 6256 5685 +12707 2 2 13 11 4731 6481 6091 +12708 2 2 13 11 4732 6092 6482 +12709 2 2 13 11 3824 6728 5785 +12710 2 2 13 11 4498 5767 6889 +12711 2 2 13 11 4520 5945 6751 +12712 2 2 13 11 4025 6907 6712 +12713 2 2 13 11 4373 6662 6781 +12714 2 2 13 11 4130 6189 5444 +12715 2 2 13 11 4337 6411 5288 +12716 2 2 13 11 4820 6567 5890 +12717 2 2 13 11 287 6564 288 +12718 2 2 13 11 4333 5790 5826 +12719 2 2 13 11 4369 6076 6422 +12720 2 2 13 11 4371 6423 6077 +12721 2 2 13 11 3660 5950 6588 +12722 2 2 13 11 4481 6905 6261 +12723 2 2 13 11 4799 5739 6395 +12724 2 2 13 11 3695 5756 6444 +12725 2 2 13 11 3696 6445 5757 +12726 2 2 13 11 3921 6485 5766 +12727 2 2 13 11 3835 6186 5724 +12728 2 2 13 11 3827 6202 5672 +12729 2 2 13 11 4225 5409 6316 +12730 2 2 13 11 4226 6317 5410 +12731 2 2 13 11 3865 6232 6051 +12732 2 2 13 11 3851 5309 6650 +12733 2 2 13 11 4355 6478 6878 +12734 2 2 13 11 4356 6879 6479 +12735 2 2 13 11 4104 5278 6513 +12736 2 2 13 11 3788 5302 6737 +12737 2 2 13 11 4559 5514 6124 +12738 2 2 13 11 4311 5391 6439 +12739 2 2 13 11 3782 6208 5688 +12740 2 2 13 11 3885 6347 6606 +12741 2 2 13 11 4451 6295 5365 +12742 2 2 13 11 4640 6449 5840 +12743 2 2 13 11 4134 5600 6576 +12744 2 2 13 11 3940 5784 6709 +12745 2 2 13 11 4395 6212 5468 +12746 2 2 13 11 4220 5657 5950 +12747 2 2 13 11 4180 5656 5925 +12748 2 2 13 11 4178 5381 6490 +12749 2 2 13 11 4553 5550 6184 +12750 2 2 13 11 4421 5242 6611 +12751 2 2 13 11 4446 6415 5872 +12752 2 2 13 11 4933 6617 6172 +12753 2 2 13 11 4934 6173 6618 +12754 2 2 13 11 301 6729 5525 +12755 2 2 13 11 4665 6034 6657 +12756 2 2 13 11 4560 6125 5515 +12757 2 2 13 11 3703 5630 6076 +12758 2 2 13 11 3704 6077 5631 +12759 2 2 13 11 3721 6281 5650 +12760 2 2 13 11 4444 6486 5906 +12761 2 2 13 11 4234 5459 6206 +12762 2 2 13 11 4965 6864 6871 +12763 2 2 13 11 4966 6872 6865 +12764 2 2 13 11 4913 5464 6578 +12765 2 2 13 11 3838 5409 6243 +12766 2 2 13 11 3839 6244 5410 +12767 2 2 13 11 4278 6824 5523 +12768 2 2 13 11 4563 6721 5354 +12769 2 2 13 11 4326 6253 5375 +12770 2 2 13 11 3687 6653 6830 +12771 2 2 13 11 5171 6712 6907 +12772 2 2 13 11 4293 5480 6308 +12773 2 2 13 11 3956 6430 5932 +12774 2 2 13 11 4221 6754 5995 +12775 2 2 13 11 3801 5350 6797 +12776 2 2 13 11 4421 6830 5242 +12777 2 2 13 11 4449 6449 6570 +12778 2 2 13 11 4032 6443 5792 +12779 2 2 13 11 4763 5450 6657 +12780 2 2 13 11 4211 5674 6221 +12781 2 2 13 11 4600 6008 5633 +12782 2 2 13 11 3757 6439 5391 +12783 2 2 13 11 3800 6880 5349 +12784 2 2 13 11 3880 6105 5826 +12785 2 2 13 11 333 6916 334 +12786 2 2 13 11 242 6917 243 +12787 2 2 13 11 270 6873 271 +12788 2 2 13 11 4465 6637 5566 +12789 2 2 13 11 4466 5567 6638 +12790 2 2 13 11 4647 6422 6076 +12791 2 2 13 11 4247 5456 6282 +12792 2 2 13 11 4648 6077 6423 +12793 2 2 13 11 4337 5288 6538 +12794 2 2 13 11 102 6340 5385 +12795 2 2 13 11 4106 5289 6810 +12796 2 2 13 11 4228 6214 5518 +12797 2 2 13 11 4262 6070 5527 +12798 2 2 13 11 4263 5528 6071 +12799 2 2 13 11 3748 6899 6275 +12800 2 2 13 11 3872 6953 5413 +12801 2 2 13 11 4333 6003 5790 +12802 2 2 13 11 3832 6514 5496 +12803 2 2 13 11 4675 5851 6671 +12804 2 2 13 11 4538 6444 5756 +12805 2 2 13 11 4539 5757 6445 +12806 2 2 13 11 4334 6167 5738 +12807 2 2 13 11 4545 5872 6415 +12808 2 2 13 11 4211 6129 5553 +12809 2 2 13 11 4422 6334 5482 +12810 2 2 13 11 3871 6636 5565 +12811 2 2 13 11 4633 6709 5784 +12812 2 2 13 11 4883 6885 6068 +12813 2 2 13 11 4724 6725 5277 +12814 2 2 13 11 3734 6690 5330 +12815 2 2 13 11 3951 6596 6657 +12816 2 2 13 11 3834 6859 5324 +12817 2 2 13 11 4540 5324 6859 +12818 2 2 13 11 4521 5792 6443 +12819 2 2 13 11 4563 5354 6774 +12820 2 2 13 11 4220 6364 5657 +12821 2 2 13 11 4631 5507 6234 +12822 2 2 13 11 3807 5964 5677 +12823 2 2 13 11 3808 5678 5965 +12824 2 2 13 11 4268 6851 5819 +12825 2 2 13 11 3722 5644 6068 +12826 2 2 13 11 4317 5538 6539 +12827 2 2 13 11 4768 5819 6851 +12828 2 2 13 11 4197 5836 5941 +12829 2 2 13 11 4222 5968 5875 +12830 2 2 13 11 3726 6170 6403 +12831 2 2 13 11 4055 5352 6648 +12832 2 2 13 11 4056 6649 5353 +12833 2 2 13 11 4706 6470 6636 +12834 2 2 13 11 4313 6574 5650 +12835 2 2 13 11 4361 6595 5598 +12836 2 2 13 11 4017 5566 6637 +12837 2 2 13 11 4018 6638 5567 +12838 2 2 13 11 4319 6116 5556 +12839 2 2 13 11 3726 6403 5969 +12840 2 2 13 11 87 6434 5607 +12841 2 2 13 11 4777 6641 6870 +12842 2 2 13 11 4342 6617 5645 +12843 2 2 13 11 4343 5646 6618 +12844 2 2 13 11 4613 5856 5977 +12845 2 2 13 11 3869 6225 5770 +12846 2 2 13 11 3951 6657 6034 +12847 2 2 13 11 3908 6395 5739 +12848 2 2 13 11 4320 6224 5513 +12849 2 2 13 11 3682 5293 6694 +12850 2 2 13 11 286 6154 5568 +12851 2 2 13 11 3683 6695 5294 +12852 2 2 13 11 3933 5944 6834 +12853 2 2 13 11 3659 5478 6360 +12854 2 2 13 11 4068 5465 6611 +12855 2 2 13 11 4364 5601 6131 +12856 2 2 13 11 4365 6132 5602 +12857 2 2 13 11 3824 6285 5518 +12858 2 2 13 11 4482 5422 6305 +12859 2 2 13 11 3800 6124 5531 +12860 2 2 13 11 3721 6574 5998 +12861 2 2 13 11 4460 6184 5550 +12862 2 2 13 11 4506 5545 6930 +12863 2 2 13 11 5343 6862 6019 +12864 2 2 13 11 5344 6020 6863 +12865 2 2 13 11 4801 6315 5501 +12866 2 2 13 11 3705 5790 6003 +12867 2 2 13 11 283 5372 6673 +12868 2 2 13 11 4530 6238 5985 +12869 2 2 13 11 4429 5363 6862 +12870 2 2 13 11 4430 6863 5364 +12871 2 2 13 11 4154 6713 5291 +12872 2 2 13 11 4160 5545 6176 +12873 2 2 13 11 4436 5607 6434 +12874 2 2 13 11 3731 6645 5918 +12875 2 2 13 11 3791 5456 6413 +12876 2 2 13 11 3801 5544 6125 +12877 2 2 13 11 3732 5919 6646 +12878 2 2 13 11 4376 5408 6633 +12879 2 2 13 11 4440 6677 6708 +12880 2 2 13 11 4638 6563 5389 +12881 2 2 13 11 4333 5906 5951 +12882 2 2 13 11 4484 5565 6636 +12883 2 2 13 11 3943 6805 5384 +12884 2 2 13 11 3767 6246 5880 +12885 2 2 13 11 4417 6277 5830 +12886 2 2 13 11 4143 6382 5504 +12887 2 2 13 11 4229 5725 6078 +12888 2 2 13 11 311 6912 5663 +12889 2 2 13 11 265 5664 6913 +12890 2 2 13 11 324 5404 6532 +12891 2 2 13 11 252 6533 5405 +12892 2 2 13 11 4220 5731 6364 +12893 2 2 13 11 3917 6702 5392 +12894 2 2 13 11 4845 6027 6790 +12895 2 2 13 11 3854 6236 5452 +12896 2 2 13 11 3855 5453 6237 +12897 2 2 13 11 4204 6862 5363 +12898 2 2 13 11 4205 5364 6863 +12899 2 2 13 11 4496 6782 5309 +12900 2 2 13 11 3827 6414 6202 +12901 2 2 13 11 4647 6076 5630 +12902 2 2 13 11 4648 5631 6077 +12903 2 2 13 11 4433 5647 6203 +12904 2 2 13 11 4434 6204 5648 +12905 2 2 13 11 4558 5517 6339 +12906 2 2 13 11 4396 6178 5885 +12907 2 2 13 11 4397 5886 6179 +12908 2 2 13 11 4350 5485 6500 +12909 2 2 13 11 4760 6597 6363 +12910 2 2 13 11 3941 6096 5647 +12911 2 2 13 11 3942 5648 6097 +12912 2 2 13 11 4248 5977 5856 +12913 2 2 13 11 4411 6625 6045 +12914 2 2 13 11 4412 6046 6626 +12915 2 2 13 11 4415 6119 5834 +12916 2 2 13 11 4554 5932 6430 +12917 2 2 13 11 4786 6383 5711 +12918 2 2 13 11 4336 6360 5478 +12919 2 2 13 11 4653 6403 6170 +12920 2 2 13 11 136 6420 5474 +12921 2 2 13 11 4749 6290 6839 +12922 2 2 13 11 4750 6840 6291 +12923 2 2 13 11 4783 5875 5968 +12924 2 2 13 11 4229 6078 6803 +12925 2 2 13 11 3948 5579 6484 +12926 2 2 13 11 4314 5366 6518 +12927 2 2 13 11 4315 6519 5367 +12928 2 2 13 11 4421 6611 5465 +12929 2 2 13 11 3993 5843 6419 +12930 2 2 13 11 4291 5834 6119 +12931 2 2 13 11 4074 6508 5492 +12932 2 2 13 11 4588 6202 6414 +12933 2 2 13 11 4753 6623 6819 +12934 2 2 13 11 4419 5481 6451 +12935 2 2 13 11 4788 6781 6662 +12936 2 2 13 11 3944 6682 6331 +12937 2 2 13 11 4446 5449 6813 +12938 2 2 13 11 5326 6920 5866 +12939 2 2 13 11 4394 6081 5738 +12940 2 2 13 11 4350 6292 5485 +12941 2 2 13 11 4091 5983 6742 +12942 2 2 13 11 4377 5927 5933 +12943 2 2 13 11 4438 6098 5697 +12944 2 2 13 11 4439 5698 6099 +12945 2 2 13 11 3959 5627 6580 +12946 2 2 13 11 3841 6775 5516 +12947 2 2 13 11 4245 6918 5570 +12948 2 2 13 11 4160 6930 5545 +12949 2 2 13 11 4684 6255 6520 +12950 2 2 13 11 4685 6521 6256 +12951 2 2 13 11 3725 6135 6257 +12952 2 2 13 11 4502 6586 5443 +12953 2 2 13 11 4629 6540 6468 +12954 2 2 13 11 4630 6469 6541 +12955 2 2 13 11 4535 5987 6515 +12956 2 2 13 11 4786 6331 6682 +12957 2 2 13 11 4407 6520 6255 +12958 2 2 13 11 4836 6899 5780 +12959 2 2 13 11 4408 6256 6521 +12960 2 2 13 11 4254 6704 5670 +12961 2 2 13 11 4542 5980 6527 +12962 2 2 13 11 4435 5959 6067 +12963 2 2 13 11 4726 6834 5944 +12964 2 2 13 11 4922 5598 6497 +12965 2 2 13 11 4687 5321 6801 +12966 2 2 13 11 3883 5951 5906 +12967 2 2 13 11 4326 5375 6561 +12968 2 2 13 11 4107 6881 5371 +12969 2 2 13 11 4398 6353 6476 +12970 2 2 13 11 4399 6477 6354 +12971 2 2 13 11 4652 6527 5980 +12972 2 2 13 11 4333 6105 5906 +12973 2 2 13 11 3707 6820 5814 +12974 2 2 13 11 4243 6180 5677 +12975 2 2 13 11 4348 5576 6463 +12976 2 2 13 11 4104 6698 5426 +12977 2 2 13 11 4210 5803 6447 +12978 2 2 13 11 3703 6076 5885 +12979 2 2 13 11 3704 5886 6077 +12980 2 2 13 11 4919 5703 6881 +12981 2 2 13 11 4431 5369 6722 +12982 2 2 13 11 4432 6723 5370 +12983 2 2 13 11 3788 5421 6768 +12984 2 2 13 11 3676 6500 5485 +12985 2 2 13 11 3928 5339 6761 +12986 2 2 13 11 3996 6474 6926 +12987 2 2 13 11 3997 6927 6475 +12988 2 2 13 11 3673 5560 6668 +12989 2 2 13 11 4638 5998 6574 +12990 2 2 13 11 4023 5801 6043 +12991 2 2 13 11 4391 6067 5959 +12992 2 2 13 11 4625 5974 6088 +12993 2 2 13 11 4283 6393 5832 +12994 2 2 13 11 4284 5833 6394 +12995 2 2 13 11 4243 5636 6118 +12996 2 2 13 11 3664 6363 6597 +12997 2 2 13 11 4437 6484 5579 +12998 2 2 13 11 4581 6094 6736 +12999 2 2 13 11 3979 6104 5859 +13000 2 2 13 11 3687 6830 5440 +13001 2 2 13 11 4317 5578 6866 +13002 2 2 13 11 4339 6347 5759 +13003 2 2 13 11 4595 6805 5877 +13004 2 2 13 11 3652 5830 6277 +13005 2 2 13 11 3936 6440 6021 +13006 2 2 13 11 4602 5663 6912 +13007 2 2 13 11 4603 6913 5664 +13008 2 2 13 11 4469 5539 6351 +13009 2 2 13 11 4447 5368 6778 +13010 2 2 13 11 4394 5933 5927 +13011 2 2 13 11 3894 5738 6167 +13012 2 2 13 11 4776 6065 6773 +13013 2 2 13 11 4131 6835 5347 +13014 2 2 13 11 4313 5650 6433 +13015 2 2 13 11 4433 6847 5366 +13016 2 2 13 11 4434 5367 6848 +13017 2 2 13 11 4642 6814 5460 +13018 2 2 13 11 4106 5484 6677 +13019 2 2 13 11 3886 5754 6874 +13020 2 2 13 11 3887 6875 5755 +13021 2 2 13 11 4125 6833 5396 +13022 2 2 13 11 3956 6798 6919 +13023 2 2 13 11 3703 5885 6178 +13024 2 2 13 11 3704 6179 5886 +13025 2 2 13 11 4487 5880 6246 +13026 2 2 13 11 4509 6419 5843 +13027 2 2 13 11 4133 6555 5542 +13028 2 2 13 11 4333 5826 6105 +13029 2 2 13 11 3811 5356 6900 +13030 2 2 13 11 4625 6088 6818 +13031 2 2 13 11 4703 6091 6928 +13032 2 2 13 11 4704 6929 6092 +13033 2 2 13 11 4612 6002 5984 +13034 2 2 13 11 4505 6166 6430 +13035 2 2 13 11 4337 6538 5607 +13036 2 2 13 11 4282 5421 6576 +13037 2 2 13 11 3852 6008 6819 +13038 2 2 13 11 3850 6332 5609 +13039 2 2 13 11 4362 5561 6656 +13040 2 2 13 11 3816 6631 5457 +13041 2 2 13 11 3817 5458 6632 +13042 2 2 13 11 3835 6463 5576 +13043 2 2 13 11 4421 5440 6830 +13044 2 2 13 11 5068 6121 6401 +13045 2 2 13 11 4484 6470 5962 +13046 2 2 13 11 4411 6391 6625 +13047 2 2 13 11 4412 6626 6392 +13048 2 2 13 11 4507 6583 5434 +13049 2 2 13 11 4508 5435 6584 +13050 2 2 13 11 3854 5746 6236 +13051 2 2 13 11 3855 6237 5747 +13052 2 2 13 11 4370 6112 6149 +13053 2 2 13 11 4516 6509 5467 +13054 2 2 13 11 4554 6430 6166 +13055 2 2 13 11 4637 6323 5949 +13056 2 2 13 11 4794 5730 6601 +13057 2 2 13 11 4510 5682 6474 +13058 2 2 13 11 4511 6475 5683 +13059 2 2 13 11 4669 6488 6418 +13060 2 2 13 11 3966 6462 5574 +13061 2 2 13 11 3895 6361 5717 +13062 2 2 13 11 4262 6372 5612 +13063 2 2 13 11 4263 5613 6373 +13064 2 2 13 11 4546 5570 6918 +13065 2 2 13 11 326 5588 6928 +13066 2 2 13 11 250 6929 5589 +13067 2 2 13 11 4477 6248 6022 +13068 2 2 13 11 4156 6476 5475 +13069 2 2 13 11 4157 5476 6477 +13070 2 2 13 11 5035 6358 6249 +13071 2 2 13 11 5036 6250 6359 +13072 2 2 13 11 3722 6885 5547 +13073 2 2 13 11 4363 6242 6414 +13074 2 2 13 11 3849 5949 6323 +13075 2 2 13 11 4342 5645 6468 +13076 2 2 13 11 4343 6469 5646 +13077 2 2 13 11 4321 5688 6208 +13078 2 2 13 11 4377 5464 6825 +13079 2 2 13 11 4665 6657 5450 +13080 2 2 13 11 4405 6556 5614 +13081 2 2 13 11 4264 6432 5835 +13082 2 2 13 11 4595 6257 6135 +13083 2 2 13 11 3881 5835 6461 +13084 2 2 13 11 4479 6668 5560 +13085 2 2 13 11 4286 6314 5574 +13086 2 2 13 11 4448 6015 6240 +13087 2 2 13 11 4369 5885 6076 +13088 2 2 13 11 4371 6077 5886 +13089 2 2 13 11 4545 6415 6152 +13090 2 2 13 11 4454 5780 6492 +13091 2 2 13 11 4342 6540 5810 +13092 2 2 13 11 4343 5811 6541 +13093 2 2 13 11 3949 6559 6487 +13094 2 2 13 11 3953 6515 5987 +13095 2 2 13 11 4465 6049 6637 +13096 2 2 13 11 4466 6638 6050 +13097 2 2 13 11 3690 6889 5767 +13098 2 2 13 11 3649 6551 5618 +13099 2 2 13 11 3943 5877 6805 +13100 2 2 13 11 4296 6044 5978 +13101 2 2 13 11 3769 5428 6655 +13102 2 2 13 11 3668 5726 6229 +13103 2 2 13 11 3932 6697 6466 +13104 2 2 13 11 3854 5452 6506 +13105 2 2 13 11 4402 5859 6104 +13106 2 2 13 11 3855 6507 5453 +13107 2 2 13 11 5170 5937 6849 +13108 2 2 13 11 3952 6023 6619 +13109 2 2 13 11 4904 5830 6809 +13110 2 2 13 11 4729 6400 6145 +13111 2 2 13 11 105 5543 6348 +13112 2 2 13 11 3675 6813 5449 +13113 2 2 13 11 4351 5594 6534 +13114 2 2 13 11 4615 5978 6044 +13115 2 2 13 11 4352 6535 5595 +13116 2 2 13 11 4276 6249 6358 +13117 2 2 13 11 4597 5500 6622 +13118 2 2 13 11 4277 6359 6250 +13119 2 2 13 11 4444 5906 6105 +13120 2 2 13 11 4478 5791 6807 +13121 2 2 13 11 4579 6214 5789 +13122 2 2 13 11 3725 6257 5704 +13123 2 2 13 11 329 6481 5686 +13124 2 2 13 11 247 5687 6482 +13125 2 2 13 11 3896 5787 6295 +13126 2 2 13 11 3834 5465 6859 +13127 2 2 13 11 4261 6721 6186 +13128 2 2 13 11 3952 6849 5937 +13129 2 2 13 11 3975 5479 6845 +13130 2 2 13 11 4620 6601 5730 +13131 2 2 13 11 3913 6219 6941 +13132 2 2 13 11 4499 6149 6112 +13133 2 2 13 11 4443 5618 6551 +13134 2 2 13 11 3684 6766 5424 +13135 2 2 13 11 3699 6362 6378 +13136 2 2 13 11 3685 5425 6767 +13137 2 2 13 11 3953 6825 5464 +13138 2 2 13 11 4362 6802 5561 +13139 2 2 13 11 4228 5789 6214 +13140 2 2 13 11 4445 6418 6488 +13141 2 2 13 11 4288 5837 6320 +13142 2 2 13 11 3940 6757 6661 +13143 2 2 13 11 4295 5984 6002 +13144 2 2 13 11 3695 6444 6453 +13145 2 2 13 11 3696 6454 6445 +13146 2 2 13 11 4275 6088 5974 +13147 2 2 13 11 4626 6697 5477 +13148 2 2 13 11 3990 6471 6199 +13149 2 2 13 11 3929 6492 5780 +13150 2 2 13 11 4632 5997 6590 +13151 2 2 13 11 4373 5561 6662 +13152 2 2 13 11 4601 5913 6180 +13153 2 2 13 11 4091 6742 5420 +13154 2 2 13 11 4247 6018 6413 +13155 2 2 13 11 3861 6152 6415 +13156 2 2 13 11 4459 5969 6403 +13157 2 2 13 11 3859 6367 5923 +13158 2 2 13 11 4563 5724 6186 +13159 2 2 13 11 4380 6229 5726 +13160 2 2 13 11 4366 6784 5483 +13161 2 2 13 11 3989 5641 6433 +13162 2 2 13 11 310 5700 6912 +13163 2 2 13 11 266 6913 5701 +13164 2 2 13 11 4766 5973 6907 +13165 2 2 13 11 4580 6021 6440 +13166 2 2 13 11 5082 5662 6883 +13167 2 2 13 11 4331 5887 6651 +13168 2 2 13 11 3692 5654 6733 +13169 2 2 13 11 4823 6095 6253 +13170 2 2 13 11 3740 6748 5500 +13171 2 2 13 11 4727 6144 6463 +13172 2 2 13 11 3868 6531 5952 +13173 2 2 13 11 4379 5868 6271 +13174 2 2 13 11 3883 6058 6402 +13175 2 2 13 11 4424 6382 5818 +13176 2 2 13 11 3845 6522 5548 +13177 2 2 13 11 4547 5893 6803 +13178 2 2 13 11 4548 6804 5894 +13179 2 2 13 11 3884 6370 5970 +13180 2 2 13 11 3885 5971 6371 +13181 2 2 13 11 4444 6357 6281 +13182 2 2 13 11 3918 6401 6121 +13183 2 2 13 11 4207 6396 5634 +13184 2 2 13 11 4208 5635 6397 +13185 2 2 13 11 3770 6791 5429 +13186 2 2 13 11 4433 6203 6054 +13187 2 2 13 11 4434 6055 6204 +13188 2 2 13 11 4256 6795 5437 +13189 2 2 13 11 4257 5438 6796 +13190 2 2 13 11 4585 6281 6357 +13191 2 2 13 11 3892 6534 5594 +13192 2 2 13 11 3893 5595 6535 +13193 2 2 13 11 4506 6930 6772 +13194 2 2 13 11 3859 6149 6367 +13195 2 2 13 11 4492 6364 5731 +13196 2 2 13 11 327 6928 6091 +13197 2 2 13 11 249 6092 6929 +13198 2 2 13 11 4072 6882 6511 +13199 2 2 13 11 4819 6566 6749 +13200 2 2 13 11 4820 6750 6567 +13201 2 2 13 11 4720 6554 6492 +13202 2 2 13 11 3880 6357 6105 +13203 2 2 13 11 4858 6700 5689 +13204 2 2 13 11 4967 5707 6833 +13205 2 2 13 11 4387 5710 6499 +13206 2 2 13 11 3871 6302 6636 +13207 2 2 13 11 4116 5711 6383 +13208 2 2 13 11 4915 6651 5800 +13209 2 2 13 11 4698 6296 5696 +13210 2 2 13 11 4400 5526 6868 +13211 2 2 13 11 4328 5923 6367 +13212 2 2 13 11 3883 6402 5621 +13213 2 2 13 11 3972 6602 5769 +13214 2 2 13 11 3921 5766 6344 +13215 2 2 13 11 4545 6655 5872 +13216 2 2 13 11 4178 5614 6556 +13217 2 2 13 11 4588 6414 6242 +13218 2 2 13 11 4536 6934 5739 +13219 2 2 13 11 3908 5739 6934 +13220 2 2 13 11 3922 6662 5561 +13221 2 2 13 11 3702 6421 5660 +13222 2 2 13 11 3900 6240 6015 +13223 2 2 13 11 4267 5506 6741 +13224 2 2 13 11 4503 6461 5835 +13225 2 2 13 11 3765 6468 5645 +13226 2 2 13 11 3766 5646 6469 +13227 2 2 13 11 4598 6826 5499 +13228 2 2 13 11 4626 6466 6697 +13229 2 2 13 11 3708 6846 5504 +13230 2 2 13 11 4017 6546 6045 +13231 2 2 13 11 4018 6046 6547 +13232 2 2 13 11 4237 6864 5864 +13233 2 2 13 11 4238 5865 6865 +13234 2 2 13 11 4409 6940 6106 +13235 2 2 13 11 3832 5570 6514 +13236 2 2 13 11 4807 6502 5610 +13237 2 2 13 11 4461 6312 6230 +13238 2 2 13 11 3779 5821 6726 +13239 2 2 13 11 4210 5643 6379 +13240 2 2 13 11 3906 5523 6824 +13241 2 2 13 11 3955 5499 6669 +13242 2 2 13 11 4381 5660 6421 +13243 2 2 13 11 3940 6661 5784 +13244 2 2 13 11 4553 5525 6729 +13245 2 2 13 11 4450 6845 5479 +13246 2 2 13 11 3872 6271 5868 +13247 2 2 13 11 4549 6402 6058 +13248 2 2 13 11 4851 6941 6219 +13249 2 2 13 11 4307 6631 5580 +13250 2 2 13 11 4308 5581 6632 +13251 2 2 13 11 3873 5800 6651 +13252 2 2 13 11 3836 6478 5624 +13253 2 2 13 11 3837 5625 6479 +13254 2 2 13 11 4699 6453 6444 +13255 2 2 13 11 4700 6445 6454 +13256 2 2 13 11 4471 6321 6446 +13257 2 2 13 11 3885 5759 6347 +13258 2 2 13 11 3672 6048 6258 +13259 2 2 13 11 4533 5860 6861 +13260 2 2 13 11 4256 5878 6325 +13261 2 2 13 11 4257 6326 5879 +13262 2 2 13 11 3842 6860 5524 +13263 2 2 13 11 4085 5938 6287 +13264 2 2 13 11 4373 6781 5662 +13265 2 2 13 11 4654 6378 6362 +13266 2 2 13 11 3859 6027 6149 +13267 2 2 13 11 4310 6305 6000 +13268 2 2 13 11 4246 6159 5936 +13269 2 2 13 11 3759 6868 5526 +13270 2 2 13 11 4916 6511 6882 +13271 2 2 13 11 4275 6580 5627 +13272 2 2 13 11 4381 5524 6860 +13273 2 2 13 11 4609 6199 6471 +13274 2 2 13 11 4524 6497 5598 +13275 2 2 13 11 4699 6474 5682 +13276 2 2 13 11 4700 5683 6475 +13277 2 2 13 11 5235 6365 6653 +13278 2 2 13 11 4196 6409 5748 +13279 2 2 13 11 3823 5483 6784 +13280 2 2 13 11 4370 6149 6027 +13281 2 2 13 11 4325 5547 6885 +13282 2 2 13 11 4454 6492 6554 +13283 2 2 13 11 4720 6877 6171 +13284 2 2 13 11 3922 5561 6802 +13285 2 2 13 11 3884 5758 6370 +13286 2 2 13 11 3885 6371 5759 +13287 2 2 13 11 3878 6082 6706 +13288 2 2 13 11 4764 6911 6921 +13289 2 2 13 11 4395 6171 6877 +13290 2 2 13 11 3693 6330 5996 +13291 2 2 13 11 4519 6783 5829 +13292 2 2 13 11 4846 5673 6417 +13293 2 2 13 11 4199 6499 5710 +13294 2 2 13 11 4115 6568 5781 +13295 2 2 13 11 4475 6749 6566 +13296 2 2 13 11 4476 6567 6750 +13297 2 2 13 11 4264 5912 6259 +13298 2 2 13 11 3651 5597 6831 +13299 2 2 13 11 4364 6131 6948 +13300 2 2 13 11 4365 6949 6132 +13301 2 2 13 11 4706 6636 6302 +13302 2 2 13 11 4028 5809 6692 +13303 2 2 13 11 3950 5829 6783 +13304 2 2 13 11 3886 6874 6148 +13305 2 2 13 11 3887 6150 6875 +13306 2 2 13 11 3736 6818 6088 +13307 2 2 13 11 4160 5478 6930 +13308 2 2 13 11 4289 5869 6694 +13309 2 2 13 11 4290 6695 5870 +13310 2 2 13 11 4595 5877 6257 +13311 2 2 13 11 4438 6298 6098 +13312 2 2 13 11 4439 6099 6299 +13313 2 2 13 11 4740 6706 6082 +13314 2 2 13 11 3929 6877 6492 +13315 2 2 13 11 4461 6113 6312 +13316 2 2 13 11 4229 6803 5893 +13317 2 2 13 11 4230 5894 6804 +13318 2 2 13 11 4653 6529 6487 +13319 2 2 13 11 3932 5782 6697 +13320 2 2 13 11 4339 6287 5938 +13321 2 2 13 11 3857 6203 5939 +13322 2 2 13 11 3858 5940 6204 +13323 2 2 13 11 4504 6446 6321 +13324 2 2 13 11 3721 5650 6574 +13325 2 2 13 11 3857 6054 6203 +13326 2 2 13 11 3858 6204 6055 +13327 2 2 13 11 4211 5553 6893 +13328 2 2 13 11 4495 6652 6522 +13329 2 2 13 11 3980 6861 5860 +13330 2 2 13 11 3896 6295 6283 +13331 2 2 13 11 4362 6656 5876 +13332 2 2 13 11 3896 6113 6193 +13333 2 2 13 11 4598 6843 5511 +13334 2 2 13 11 4425 6022 6248 +13335 2 2 13 11 3778 6920 5760 +13336 2 2 13 11 4400 6838 5526 +13337 2 2 13 11 4660 6661 6757 +13338 2 2 13 11 3755 6758 6517 +13339 2 2 13 11 4305 5740 6437 +13340 2 2 13 11 4306 6438 5741 +13341 2 2 13 11 4948 6735 5611 +13342 2 2 13 11 4384 5753 6552 +13343 2 2 13 11 3843 6687 6601 +13344 2 2 13 11 4361 5985 6238 +13345 2 2 13 11 3841 5959 6775 +13346 2 2 13 11 4394 6361 6081 +13347 2 2 13 11 4294 6199 6603 +13348 2 2 13 11 4502 6486 6399 +13349 2 2 13 11 4552 6258 6048 +13350 2 2 13 11 3656 5840 6449 +13351 2 2 13 11 4461 6313 6193 +13352 2 2 13 11 4461 6193 6113 +13353 2 2 13 11 4458 5996 6330 +13354 2 2 13 11 4310 5952 6531 +13355 2 2 13 11 3877 6933 5657 +13356 2 2 13 11 3845 6936 6522 +13357 2 2 13 11 4383 5643 6740 +13358 2 2 13 11 5144 6404 6442 +13359 2 2 13 11 4802 5947 6952 +13360 2 2 13 11 3896 6321 6113 +13361 2 2 13 11 4379 6818 6065 +13362 2 2 13 11 4503 6644 6461 +13363 2 2 13 11 4447 6582 5900 +13364 2 2 13 11 4607 6098 6298 +13365 2 2 13 11 4608 6299 6099 +13366 2 2 13 11 4492 5781 6568 +13367 2 2 13 11 3712 6442 6404 +13368 2 2 13 11 4451 6233 6283 +13369 2 2 13 11 3809 5670 6704 +13370 2 2 13 11 3701 6683 5673 +13371 2 2 13 11 4456 6014 6452 +13372 2 2 13 11 3712 6950 5623 +13373 2 2 13 11 4755 6127 6741 +13374 2 2 13 11 4462 6147 6835 +13375 2 2 13 11 4413 6691 5716 +13376 2 2 13 11 3689 6253 6095 +13377 2 2 13 11 4374 5832 6393 +13378 2 2 13 11 4375 6394 5833 +13379 2 2 13 11 4794 6601 6687 +13380 2 2 13 11 3948 6659 5702 +13381 2 2 13 11 4522 5918 6645 +13382 2 2 13 11 4523 6646 5919 +13383 2 2 13 11 3819 5662 6781 +13384 2 2 13 11 4503 5835 6432 +13385 2 2 13 11 4773 6543 6806 +13386 2 2 13 11 4535 6692 5809 +13387 2 2 13 11 4223 6952 5947 +13388 2 2 13 11 4546 6918 6732 +13389 2 2 13 11 4703 6928 5588 +13390 2 2 13 11 4704 5589 6929 +13391 2 2 13 11 4660 5666 6661 +13392 2 2 13 11 4451 6283 6295 +13393 2 2 13 11 4609 6603 6199 +13394 2 2 13 11 3982 6740 5643 +13395 2 2 13 11 3739 6755 6042 +13396 2 2 13 11 3820 6590 5735 +13397 2 2 13 11 3904 6866 5578 +13398 2 2 13 11 3949 6487 6529 +13399 2 2 13 11 153 5668 6664 +13400 2 2 13 11 68 6665 5669 +13401 2 2 13 11 4437 5579 6891 +13402 2 2 13 11 4200 6652 6122 +13403 2 2 13 11 3852 6623 5762 +13404 2 2 13 11 4409 6310 6940 +13405 2 2 13 11 3697 6901 6101 +13406 2 2 13 11 3863 6752 5682 +13407 2 2 13 11 3864 5683 6753 +13408 2 2 13 11 3929 6212 6877 +13409 2 2 13 11 4670 5920 6412 +13410 2 2 13 11 3897 5810 6540 +13411 2 2 13 11 3898 6541 5811 +13412 2 2 13 11 4776 6773 6620 +13413 2 2 13 11 4414 5762 6559 +13414 2 2 13 11 4799 6517 6758 +13415 2 2 13 11 4504 6283 6233 +13416 2 2 13 11 4458 5792 6640 +13417 2 2 13 11 3733 5714 6939 +13418 2 2 13 11 4419 6892 5923 +13419 2 2 13 11 3872 5600 6953 +13420 2 2 13 11 4701 5608 6887 +13421 2 2 13 11 4254 6553 6704 +13422 2 2 13 11 4402 6939 5714 +13423 2 2 13 11 4831 5899 6462 +13424 2 2 13 11 5000 5705 6785 +13425 2 2 13 11 3894 6530 5933 +13426 2 2 13 11 3914 6230 6312 +13427 2 2 13 11 4367 5769 6602 +13428 2 2 13 11 4471 6312 6113 +13429 2 2 13 11 4512 5657 6933 +13430 2 2 13 11 3753 6851 5593 +13431 2 2 13 11 4586 6461 6644 +13432 2 2 13 11 5064 6737 5861 +13433 2 2 13 11 4450 5653 6845 +13434 2 2 13 11 3883 5906 6486 +13435 2 2 13 11 4709 6888 6384 +13436 2 2 13 11 4418 5751 6619 +13437 2 2 13 11 4500 5623 6950 +13438 2 2 13 11 3729 5900 6582 +13439 2 2 13 11 3883 6486 6058 +13440 2 2 13 11 4841 6756 5723 +13441 2 2 13 11 4872 6785 5705 +13442 2 2 13 11 4279 6902 6181 +13443 2 2 13 11 4610 6355 6408 +13444 2 2 13 11 4267 6741 6127 +13445 2 2 13 11 4459 5762 6623 +13446 2 2 13 11 4487 6246 6515 +13447 2 2 13 11 4246 5771 6654 +13448 2 2 13 11 3918 6103 6406 +13449 2 2 13 11 4069 6620 6773 +13450 2 2 13 11 4449 6570 5988 +13451 2 2 13 11 3724 6656 6480 +13452 2 2 13 11 4541 6806 6543 +13453 2 2 13 11 4471 6113 6321 +13454 2 2 13 11 4563 6186 6721 +13455 2 2 13 11 4902 6714 6716 +13456 2 2 13 11 5001 6413 6018 +13457 2 2 13 11 4764 6120 6911 +13458 2 2 13 11 3988 6216 6622 +13459 2 2 13 11 5339 5722 6761 +13460 2 2 13 11 4471 6446 6258 +13461 2 2 13 11 4477 6710 6248 +13462 2 2 13 11 4249 5785 6728 +13463 2 2 13 11 4493 6193 6313 +13464 2 2 13 11 305 6452 6014 +13465 2 2 13 11 3896 6283 6321 +13466 2 2 13 11 4323 6148 6874 +13467 2 2 13 11 4324 6875 6150 +13468 2 2 13 11 4952 6122 6652 +13469 2 2 13 11 4463 5874 6571 +13470 2 2 13 11 5005 6406 6103 +13471 2 2 13 11 4594 6278 6501 +13472 2 2 13 11 4699 6444 6926 +13473 2 2 13 11 4700 6927 6445 +13474 2 2 13 11 3988 6384 6888 +13475 2 2 13 11 4536 6505 6934 +13476 2 2 13 11 4450 5760 6920 +13477 2 2 13 11 4499 6367 6149 +13478 2 2 13 11 4536 5961 6505 +13479 2 2 13 11 3895 6081 6361 +13480 2 2 13 11 4549 5990 6402 +13481 2 2 13 11 4443 6876 6227 +13482 2 2 13 11 4310 6531 6305 +13483 2 2 13 11 4411 6045 6546 +13484 2 2 13 11 4412 6547 6046 +13485 2 2 13 11 4368 5821 6699 +13486 2 2 13 11 3730 5962 6470 +13487 2 2 13 11 4411 6546 5822 +13488 2 2 13 11 4412 5823 6547 +13489 2 2 13 11 4415 6720 6119 +13490 2 2 13 11 4504 6321 6283 +13491 2 2 13 11 3944 6331 6814 +13492 2 2 13 11 4602 6912 5700 +13493 2 2 13 11 4603 5701 6913 +13494 2 2 13 11 4377 5933 6530 +13495 2 2 13 11 4597 6921 6911 +13496 2 2 13 11 3721 5998 6586 +13497 2 2 13 11 4433 5772 6847 +13498 2 2 13 11 4434 6848 5773 +13499 2 2 13 11 4368 6726 5821 +13500 2 2 13 11 3716 6408 6355 +13501 2 2 13 11 4471 6258 6489 +13502 2 2 13 11 4892 6874 5754 +13503 2 2 13 11 4893 5755 6875 +13504 2 2 13 11 4279 5814 6820 +13505 2 2 13 11 4983 6720 6464 +13506 2 2 13 11 5072 6645 6182 +13507 2 2 13 11 5073 6183 6646 +13508 2 2 13 11 4502 6058 6486 +13509 2 2 13 11 3871 6565 6302 +13510 2 2 13 11 3952 6619 6849 +13511 2 2 13 11 3807 6734 5964 +13512 2 2 13 11 4486 6816 5788 +13513 2 2 13 11 3808 5965 6852 +13514 2 2 13 11 4452 6922 5796 +13515 2 2 13 11 4448 6716 6714 +13516 2 2 13 11 3673 6505 5961 +13517 2 2 13 11 4788 6708 6781 +13518 2 2 13 11 3711 6441 6630 +13519 2 2 13 11 4444 6105 6357 +13520 2 2 13 11 98 6268 6410 +13521 2 2 13 11 5243 6320 6595 +13522 2 2 13 11 4510 6474 6591 +13523 2 2 13 11 4511 6592 6475 +13524 2 2 13 11 3722 6068 6885 +13525 2 2 13 11 4639 6630 6441 +13526 2 2 13 11 4635 6761 5722 +13527 2 2 13 11 4555 6045 6625 +13528 2 2 13 11 4556 6626 6046 +13529 2 2 13 11 4887 6467 6496 +13530 2 2 13 11 3905 5988 6570 +13531 2 2 13 11 4697 6551 6701 +13532 2 2 13 11 4597 6622 6216 +13533 2 2 13 11 4345 6145 6400 +13534 2 2 13 11 3690 5744 6889 +13535 2 2 13 11 3721 6399 6281 +13536 2 2 13 11 4697 5743 6876 +13537 2 2 13 11 4832 6934 6505 +13538 2 2 13 11 4505 6410 6268 +13539 2 2 13 11 4444 6281 6399 +13540 2 2 13 11 3811 6900 5858 +13541 2 2 13 11 3714 6847 5772 +13542 2 2 13 11 3715 5773 6848 +13543 2 2 13 11 4552 6489 6258 +13544 2 2 13 11 3724 5876 6656 +13545 2 2 13 11 4477 6042 6755 +13546 2 2 13 11 4684 6666 6598 +13547 2 2 13 11 4685 6599 6667 +13548 2 2 13 11 4770 6757 6696 +13549 2 2 13 11 4348 6463 6144 +13550 2 2 13 11 3819 6781 6708 +13551 2 2 13 11 3873 6651 5887 +13552 2 2 13 11 4845 6790 6890 +13553 2 2 13 11 3723 6887 5871 +13554 2 2 13 11 4458 6724 5996 +13555 2 2 13 11 4987 6798 5932 +13556 2 2 13 11 3684 6006 6766 +13557 2 2 13 11 3685 6767 6007 +13558 2 2 13 11 3843 6601 6398 +13559 2 2 13 11 3706 6595 6320 +13560 2 2 13 11 4383 6740 5839 +13561 2 2 13 11 4583 6528 6493 +13562 2 2 13 11 4769 6754 6069 +13563 2 2 13 11 3956 5932 6798 +13564 2 2 13 11 4426 6687 6409 +13565 2 2 13 11 4684 6520 6666 +13566 2 2 13 11 4685 6667 6521 +13567 2 2 13 11 4663 6341 6878 +13568 2 2 13 11 4664 6879 6343 +13569 2 2 13 11 3672 6258 6446 +13570 2 2 13 11 4576 6706 6553 +13571 2 2 13 11 3649 6701 6551 +13572 2 2 13 11 3671 6084 6843 +13573 2 2 13 11 3940 6696 6757 +13574 2 2 13 11 3974 6647 6072 +13575 2 2 13 11 4355 6878 6341 +13576 2 2 13 11 4356 6343 6879 +13577 2 2 13 11 4546 6823 6213 +13578 2 2 13 11 93 6853 5806 +13579 2 2 13 11 4003 6890 6790 +13580 2 2 13 11 4507 6598 6666 +13581 2 2 13 11 4508 6667 6599 +13582 2 2 13 11 4131 5948 6835 +13583 2 2 13 11 4834 6850 6832 +13584 2 2 13 11 4694 5858 6900 +13585 2 2 13 11 3990 6858 6471 +13586 2 2 13 11 4287 5996 6724 +13587 2 2 13 11 4388 6496 6467 +13588 2 2 13 11 4675 6800 5851 +13589 2 2 13 11 4279 5776 6902 +13590 2 2 13 11 4456 6072 6647 +13591 2 2 13 11 4316 6819 6008 +13592 2 2 13 11 4653 6487 6403 +13593 2 2 13 11 4342 6172 6617 +13594 2 2 13 11 4343 6618 6173 +13595 2 2 13 11 4535 6515 6246 +13596 2 2 13 11 5018 6792 6178 +13597 2 2 13 11 5019 6179 6793 +13598 2 2 13 11 4009 6213 6823 +13599 2 2 13 11 3863 5897 6924 +13600 2 2 13 11 3864 6925 5898 +13601 2 2 13 11 3914 6312 6489 +13602 2 2 13 11 4529 6832 6850 +13603 2 2 13 11 4532 6766 6006 +13604 2 2 13 11 4533 6007 6767 +13605 2 2 13 11 3859 5923 6892 +13606 2 2 13 11 4503 6428 6644 +13607 2 2 13 11 3778 5866 6920 +13608 2 2 13 11 4455 6501 6278 +13609 2 2 13 11 4832 6505 6668 +13610 2 2 13 11 4620 6398 6601 +13611 2 2 13 11 4471 6489 6312 +13612 2 2 13 11 4462 6835 5948 +13613 2 2 13 11 4497 6170 6779 +13614 2 2 13 11 4580 6440 6745 +13615 2 2 13 11 3666 6666 6520 +13616 2 2 13 11 3667 6521 6667 +13617 2 2 13 11 4617 6675 6511 +13618 2 2 13 11 4515 6493 6528 +13619 2 2 13 11 4435 6775 5959 +13620 2 2 13 11 4459 6403 6487 +13621 2 2 13 11 4713 6471 6858 +13622 2 2 13 11 100 6769 6166 +13623 2 2 13 11 4197 6946 5807 +13624 2 2 13 11 4740 6553 6706 +13625 2 2 13 11 4221 6069 6754 +13626 2 2 13 11 4907 6568 6260 +13627 2 2 13 11 3726 6297 6779 +13628 2 2 13 11 4482 6305 6531 +13629 2 2 13 11 4402 6104 6939 +13630 2 2 13 11 4224 6032 6886 +13631 2 2 13 11 4115 6260 6568 +13632 2 2 13 11 331 6942 5966 +13633 2 2 13 11 245 5967 6943 +13634 2 2 13 11 4452 6765 6006 +13635 2 2 13 11 4796 6779 6297 +13636 2 2 13 11 4245 5900 6918 +13637 2 2 13 11 4204 6019 6862 +13638 2 2 13 11 4205 6863 6020 +13639 2 2 13 11 4786 6726 6331 +13640 2 2 13 11 4230 6804 6192 +13641 2 2 13 11 3731 6182 6645 +13642 2 2 13 11 3732 6646 6183 +13643 2 2 13 11 4784 6678 6786 +13644 2 2 13 11 4785 6787 6679 +13645 2 2 13 11 4072 6511 6675 +13646 2 2 13 11 4491 6302 6565 +13647 2 2 13 11 4525 6235 6681 +13648 2 2 13 11 4697 6876 6551 +13649 2 2 13 11 3806 6044 6756 +13650 2 2 13 11 4720 6492 6877 +13651 2 2 13 11 4854 6333 6602 +13652 2 2 13 11 4924 6746 6807 +13653 2 2 13 11 3721 6586 6399 +13654 2 2 13 11 3736 6065 6818 +13655 2 2 13 11 4488 6786 6678 +13656 2 2 13 11 4489 6679 6787 +13657 2 2 13 11 4316 6264 6819 +13658 2 2 13 11 4957 6101 6743 +13659 2 2 13 11 4517 6630 6589 +13660 2 2 13 11 4533 6861 6007 +13661 2 2 13 11 3980 6674 6861 +13662 2 2 13 11 4554 6166 6769 +13663 2 2 13 11 3983 6248 6710 +13664 2 2 13 11 5151 6192 6804 +13665 2 2 13 11 3930 6681 6235 +13666 2 2 13 11 4542 6527 6923 +13667 2 2 13 11 4544 6886 6032 +13668 2 2 13 11 3856 6106 6940 +13669 2 2 13 11 3726 6779 6170 +13670 2 2 13 11 3996 6591 6474 +13671 2 2 13 11 3997 6475 6592 +13672 2 2 13 11 4368 6331 6726 +13673 2 2 13 11 4542 6923 6620 +13674 2 2 13 11 4572 6642 6634 +13675 2 2 13 11 4573 6635 6643 +13676 2 2 13 11 3677 6267 6762 +13677 2 2 13 11 5140 6772 6318 +13678 2 2 13 11 4443 6551 6876 +13679 2 2 13 11 4346 6653 6365 +13680 2 2 13 11 4478 6807 6746 +13681 2 2 13 11 3924 6060 6821 +13682 2 2 13 11 3925 6822 6061 +13683 2 2 13 11 4367 6602 6333 +13684 2 2 13 11 3659 6318 6772 +13685 2 2 13 11 4502 6399 6586 +13686 2 2 13 11 3924 6821 6422 +13687 2 2 13 11 3925 6423 6822 +13688 2 2 13 11 4736 6899 6731 +13689 2 2 13 11 4639 6589 6630 +13690 2 2 13 11 3740 6911 6120 +13691 2 2 13 11 5100 6585 6523 +13692 2 2 13 11 4437 6101 6901 +13693 2 2 13 11 4093 6644 6428 +13694 2 2 13 11 4629 6634 6642 +13695 2 2 13 11 4630 6643 6635 +13696 2 2 13 11 3889 6625 6391 +13697 2 2 13 11 3890 6392 6626 +13698 2 2 13 11 4726 6542 6834 +13699 2 2 13 11 4502 6937 6058 +13700 2 2 13 11 4702 6834 6542 +13701 2 2 13 11 3895 6935 6081 +13702 2 2 13 11 5186 6884 6390 +13703 2 2 13 11 3673 6668 6505 +13704 2 2 13 11 4395 6877 6212 +13705 2 2 13 11 3748 6731 6899 +13706 2 2 13 11 4829 6510 6688 +13707 2 2 13 11 4474 6919 6138 +13708 2 2 13 11 4415 6464 6720 +13709 2 2 13 11 270 6707 6873 +13710 2 2 13 11 4629 6642 6540 +13711 2 2 13 11 4630 6541 6643 +13712 2 2 13 11 3796 6725 6788 +13713 2 2 13 11 3773 6523 6585 +13714 2 2 13 11 4565 6762 6267 +13715 2 2 13 11 4570 6745 6440 +13716 2 2 13 11 4753 6819 6264 +13717 2 2 13 11 5366 6847 6518 +13718 2 2 13 11 5367 6519 6848 +13719 2 2 13 11 4178 6556 6689 +13720 2 2 13 11 3897 6540 6642 +13721 2 2 13 11 3898 6643 6541 +13722 2 2 13 11 4901 6689 6556 +13723 2 2 13 11 4497 6951 6170 +13724 2 2 13 11 3892 6948 6131 +13725 2 2 13 11 3893 6132 6949 +13726 2 2 13 11 4490 6390 6884 +13727 2 2 13 11 3714 6518 6847 +13728 2 2 13 11 3715 6848 6519 +13729 2 2 13 11 3754 6688 6510 +13730 2 2 13 11 4467 6839 6290 +13731 2 2 13 11 4468 6291 6840 +13732 2 2 13 11 4767 6873 6707 +13733 2 2 13 11 3931 6589 6815 +13734 2 2 13 11 4740 6704 6553 +13735 2 2 13 11 4777 6870 6407 +13736 2 2 13 11 4724 6788 6725 +13737 2 2 13 11 4879 6940 6310 +13738 2 2 13 11 4728 6407 6870 +13739 2 2 13 11 4746 6484 6901 +13740 2 2 13 11 4477 6755 6710 +13741 2 2 13 11 4256 6685 6795 +13742 2 2 13 11 4257 6796 6686 +13743 2 2 13 11 4639 6815 6589 +13744 2 2 13 11 4978 6795 6685 +13745 2 2 13 11 4979 6686 6796 +13746 2 2 13 11 4538 6926 6444 +13747 2 2 13 11 4539 6445 6927 +13748 2 2 13 11 4886 6710 6755 +13749 2 2 13 11 4437 6901 6484 +13750 2 2 13 11 3873 6923 6527 +13751 2 2 13 11 4776 6620 6923 +13752 2 2 13 11 4645 6854 6858 +13753 2 2 13 11 4495 6522 6936 +13754 2 2 13 11 4546 6732 6823 +13755 2 2 13 11 4790 6823 6732 +13756 2 2 13 11 4618 6811 6867 +13757 2 2 13 11 4619 6869 6812 +13758 2 2 13 11 333 6908 6916 +13759 2 2 13 11 243 6917 6909 +13760 2 2 13 11 4713 6858 6854 +13761 2 2 13 11 4639 6888 6815 +13762 2 2 13 11 4756 6867 6811 +13763 2 2 13 11 4757 6812 6869 +13764 2 2 13 11 4709 6815 6888 +13765 2 2 13 11 4747 6916 6908 +13766 2 2 13 11 4748 6909 6917 +$EndElements diff --git a/test/mixeddimension/facet/1p2c_1p2c/matrixproblem.hh b/test/mixeddimension/facet/1p2c_1p2c/matrixproblem.hh new file mode 100644 index 0000000000000000000000000000000000000000..ad434a0420b1e66d5f80cc972df13304ef61f6c9 --- /dev/null +++ b/test/mixeddimension/facet/1p2c_1p2c/matrixproblem.hh @@ -0,0 +1,255 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * + * \brief A test problem for the one-phase model: + * water is flowing from bottom to top through and around a low permeable lens. + */ +#ifndef DUMUX_1P2C_MATRIX_PROBLEM_HH +#define DUMUX_1P2C_MATRIX_PROBLEM_HH + +#include <dumux/mixeddimension/facet/mpfa/properties.hh> +#include <dumux/mixeddimension/subproblemproperties.hh> + +#include <dumux/porousmediumflow/1p2c/implicit/model.hh> +#include <dumux/porousmediumflow/implicit/problem.hh> + +#include <dumux/material/fluidsystems/h2on2.hh> +#include "matrixspatialparams.hh" + +namespace Dumux +{ +template <class TypeTag> +class OnePTwoCMpfaMatrixProblem; + +namespace Properties +{ +NEW_TYPE_TAG(OnePTwoCIMatrixProblem, INHERITS_FROM(OnePTwoC)); +NEW_TYPE_TAG(OnePTwoCNIMatrixProblem, INHERITS_FROM(OnePTwoCNI)); +NEW_TYPE_TAG(OnePTwoCICCMpfaMatrixProblem, INHERITS_FROM(FacetCouplingBulkMpfaModel, OnePTwoCIMatrixProblem)); +NEW_TYPE_TAG(OnePTwoCNICCMpfaMatrixProblem, INHERITS_FROM(FacetCouplingBulkMpfaModel, OnePTwoCNIMatrixProblem)); + +// Set fluid configuration +SET_TYPE_PROP(OnePTwoCIMatrixProblem, FluidSystem, FluidSystems::H2ON2<typename GET_PROP_TYPE(TypeTag, Scalar), false>); +SET_TYPE_PROP(OnePTwoCNIMatrixProblem, FluidSystem, FluidSystems::H2ON2<typename GET_PROP_TYPE(TypeTag, Scalar), false>); + +// Set the problem property +SET_TYPE_PROP(OnePTwoCIMatrixProblem, Problem, OnePTwoCMpfaMatrixProblem<TypeTag>); +SET_TYPE_PROP(OnePTwoCNIMatrixProblem, Problem, OnePTwoCMpfaMatrixProblem<TypeTag>); + +// Define whether mole(true) or mass (false) fractions are used +SET_BOOL_PROP(OnePTwoCIMatrixProblem, UseMoles, true); +SET_BOOL_PROP(OnePTwoCNIMatrixProblem, UseMoles, true); + +// Set the spatial parameters +SET_TYPE_PROP(OnePTwoCIMatrixProblem, SpatialParams, OnePMatrixSpatialParams<TypeTag>); +SET_TYPE_PROP(OnePTwoCNIMatrixProblem, SpatialParams, OnePMatrixSpatialParams<TypeTag>); + +// Linear solver settings +SET_TYPE_PROP(OnePTwoCIMatrixProblem, LinearSolver, SuperLUBackend<TypeTag>); +SET_TYPE_PROP(OnePTwoCNIMatrixProblem, LinearSolver, SuperLUBackend<TypeTag>); + +// Enable gravity +SET_BOOL_PROP(OnePTwoCIMatrixProblem, ProblemEnableGravity, false); +SET_BOOL_PROP(OnePTwoCNIMatrixProblem, ProblemEnableGravity, false); + +// Solution-independent tensor +// SET_BOOL_PROP(OnePTwoCICCMpfaMatrixProblem, SolutionDependentAdvection, false); +// SET_BOOL_PROP(OnePTwoCNICCMpfaMatrixProblem, SolutionDependentMolecularDiffusion, false); +// SET_BOOL_PROP(OnePTwoCICCMpfaMatrixProblem, SolutionDependentAdvection, false); +// SET_BOOL_PROP(OnePTwoCNICCMpfaMatrixProblem, SolutionDependentMolecularDiffusion, false); +// SET_BOOL_PROP(OnePTwoCNICCMpfaMatrixProblem, SolutionDependentHeatConduction, false); + +// change mpfa method +//SET_PROP(OnePMatrixProblem, MpfaMethod) { static const MpfaMethods value = MpfaMethods::lMethod; }; +} + +/*! + * \ingroup OnePModel + * \ingroup ImplicitTestProblems + * \brief Test problem for the one-phase model + */ + +template <class TypeTag> +class OnePTwoCMpfaMatrixProblem : public ImplicitPorousMediaProblem<TypeTag> +{ + using ParentType = ImplicitPorousMediaProblem<TypeTag>; + + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Element = typename GridView::template Codim<0>::Entity; + using Intersection = typename GridView::Intersection; + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Indices = typename GET_PROP_TYPE(TypeTag, Indices); + using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); + using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem); + using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); + using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); + using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); + using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); + + using GlobalProblemTypeTag = typename GET_PROP_TYPE(TypeTag, GlobalProblemTypeTag); + using CouplingManager = typename GET_PROP_TYPE(GlobalProblemTypeTag, CouplingManager); + + // copy some indices for convenience + enum + { + // indices of the primary variables + pressureIdx = Indices::pressureIdx, + massOrMoleFracIdx = Indices::massOrMoleFracIdx, + + // indices of the equations + conti0EqIdx = Indices::conti0EqIdx, + transportEqIdx = Indices::transportEqIdx + }; + + //! property that defines whether mole or mass fractions are used + static const bool useMoles = GET_PROP_VALUE(TypeTag, UseMoles); + + static constexpr int numEq = GET_PROP_VALUE(TypeTag, NumEq); + static constexpr int dim = GridView::dimension; + static constexpr int dimWorld = GridView::dimensionworld; + + using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; + + +public: + OnePTwoCMpfaMatrixProblem(TimeManager &timeManager, const GridView &gridView) + : ParentType(timeManager, gridView) + { + //initialize fluid system + FluidSystem::init(); + + name_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Problem, Name) + "_matrix"; + eps_ = 1e-6; + + // stating in the console whether mole or mass fractions are used + if(useMoles) + std::cout<<"problem uses mole fractions"<<std::endl; + else + std::cout<<"problem uses mass fractions"<<std::endl; + } + + /*! + * \brief The problem name. + * + * This is used as a prefix for files generated by the simulation. + */ + const std::string& name() const + { return name_; } + + /*! + * \brief Return the temperature within the domain in [K]. + * + * This problem assumes a temperature of 10 degrees Celsius. + */ + Scalar temperature() const + { return 273.15 + 40; } + + /*! + * \brief Return the sources within the domain. + */ + PrimaryVariables sourceAtPos(const GlobalPosition& globalPos) const + { return PrimaryVariables(0.0); } + + /*! + * \brief Specifies which kind of boundary condition should be + * used for which equation on a given boundary control volume. + */ + BoundaryTypes boundaryTypes(const Element& element, const SubControlVolumeFace& scvf) const + { + BoundaryTypes values; + const auto globalPos = scvf.ipGlobal(); + + values.setAllNeumann(); + if (globalPos[1] < eps_ && globalPos[1] > this->bBoxMax()[1] - eps_) + values.setAllDirichlet(); + + if (couplingManager().isInteriorBoundary(element, scvf)) + values.setAllNeumann(); + + return values; + } + + /*! + * \brief Specifies if a given intersection is on an interior boundary + */ + bool isInteriorBoundary(const Element& element, const Intersection& is) const + { return couplingManager().isInteriorBoundary(element, is); } + + /*! + * \brief Evaluate the boundary conditions for a dirichlet + * control volume. + */ + PrimaryVariables dirichletAtPos(const GlobalPosition& globalPos) const + { + PrimaryVariables values = initialAtPos(globalPos); + return values; + } + + /*! + * \brief Evaluate the boundary conditions for a neumann + * boundary segment. + */ + PrimaryVariables neumannAtPos(const GlobalPosition& globalPos) const + { return PrimaryVariables(0.0); } + + /*! + * \brief Evaluate the initial value for a control volume (isothermal case) + */ + template<class T = TypeTag> + typename std::enable_if<std::is_same<T, TTAG(OnePTwoCICCMpfaMatrixProblem)>::value, PrimaryVariables>::type + initialAtPos(const GlobalPosition& globalPos) const + { + PrimaryVariables values(0.0); + values[pressureIdx] = 1.0e5; // + 1.0e5*globalPos[1]/this->bBoxMax()[1]; + return values; + } + + /*! + * \brief Evaluate the initial value for a control volume (non-isothermal case) + */ + template<class T = TypeTag> + typename std::enable_if<std::is_same<T, TTAG(OnePTwoCNICCMpfaMatrixProblem)>::value, PrimaryVariables>::type + initialAtPos(const GlobalPosition& globalPos) const + { + PrimaryVariables values(0.0); + values[pressureIdx] = 1.0e5; // + 1.0e5*globalPos[1]/this->bBoxMax()[1]; + values[Indices::temperatureIdx] = temperature(); + return values; + } + + //! Set the coupling manager + void setCouplingManager(std::shared_ptr<CouplingManager> cm) + { couplingManager_ = cm; } + + //! Get the coupling manager + const CouplingManager& couplingManager() const + { return *couplingManager_; } + +private: + std::string name_; + Scalar eps_; + std::shared_ptr<CouplingManager> couplingManager_; +}; +} //end namespace + +#endif diff --git a/test/mixeddimension/facet/1p2c_1p2c/matrixspatialparams.hh b/test/mixeddimension/facet/1p2c_1p2c/matrixspatialparams.hh new file mode 100644 index 0000000000000000000000000000000000000000..e4c0a49d6c65daba98df9eee3a8dff92a945f20b --- /dev/null +++ b/test/mixeddimension/facet/1p2c_1p2c/matrixspatialparams.hh @@ -0,0 +1,139 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * + * \brief The spatial parameters class for the matrix problem + */ +#ifndef DUMUX_1P_MATRIX_SPATIALPARAMS_HH +#define DUMUX_1P_MATRIX_SPATIALPARAMS_HH + +#include <dumux/material/spatialparams/implicit1p.hh> + +namespace Dumux +{ + +/*! + * \ingroup OnePModel + * \ingroup ImplicitTestProblems + * + * \brief The spatial parameters class for the matrix problem + */ +template<class TypeTag> +class OnePMatrixSpatialParams : public ImplicitSpatialParamsOneP<TypeTag> +{ + using ParentType = ImplicitSpatialParamsOneP<TypeTag>; + + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Element = typename GridView::template Codim<0>::Entity; + using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); + + static constexpr int dimWorld = GridView::dimensionworld; + using GlobalPosition = Dune::FieldVector<Scalar,dimWorld>; + + using Tensor = Dune::FieldMatrix<Scalar, dimWorld, dimWorld>; + +public: + using PermeabilityType = Tensor; + + OnePMatrixSpatialParams(const Problem& problem, const GridView& gridView) + : ParentType(problem, gridView) + { + Scalar permeability = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, MatrixPermeability); + + K_[0][0] = permeability; + K_[1][1] = permeability; + K_[0][1] = 0.; + K_[1][0] = 0.; + } + + /*! + * \brief Return the intrinsic permeability for the given position in [m^2]. + */ + Tensor permeabilityAtPos(const GlobalPosition& globalPos) const + { return K_; } + + /*! + * \brief Define the dispersivity. + * + * \param element The finite element + * \param scv The sub-control volume + * \param elemSol The solution for all dofs of the element + */ + Scalar dispersivity(const Element &element, + const SubControlVolume& scv, + const ElementSolutionVector& elemSol) const + { return 0; } + + /*! + * \brief Define the porosity in [-]. + */ + Scalar porosityAtPos(const GlobalPosition& globalPos) const + { return 0.2; } + + /*! + * \brief Returns the heat capacity \f$[J / (kg K)]\f$ of the rock matrix. + * + * This is only required for non-isothermal models. + * + * \param element The element + * \param scv The sub control volume + * \param elemSol The element solution vector + */ + Scalar solidHeatCapacity(const Element &element, + const SubControlVolume& scv, + const ElementSolutionVector& elemSol) const + { return 790; /*specific heat capacity of granite [J / (kg K)]*/ } + + /*! + * \brief Returns the mass density \f$[kg / m^3]\f$ of the rock matrix. + * + * This is only required for non-isothermal models. + * + * \param element The element + * \param scv The sub control volume + * \param elemSol The element solution vector + */ + Scalar solidDensity(const Element &element, + const SubControlVolume& scv, + const ElementSolutionVector& elemSol) const + { return 2700; /*density of granite [kg/m^3]*/ } + + /*! + * \brief Returns the thermal conductivity \f$\mathrm{[W/(m K)]}\f$ of the porous material. + * + * \param element The element + * \param scv The sub control volume + * \param elemSol The element solution vector + */ + Scalar solidThermalConductivity(const Element &element, + const SubControlVolume& scv, + const ElementSolutionVector& elemSol) const + { return 2.8; } + +private: + Tensor K_; +}; +} //end namespace + +#endif diff --git a/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2c_1p2c.cc b/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2c_1p2c.cc new file mode 100644 index 0000000000000000000000000000000000000000..40bba0e65f42812e9f0216649f725235b9d07d4c --- /dev/null +++ b/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2c_1p2c.cc @@ -0,0 +1,45 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * + * \brief test for the 1d 3d cell-centered coupled model + */ +#include "config.h" +#include "1d2dtestproblem.hh" +#include <dumux/mixeddimension/facet/start.hh> + +/*! + * \brief Provides an interface for customizing error messages associated with + * reading in parameters. + * + * \param progName The name of the program, that was tried to be started. + * \param errorMsg The error message that was issued by the start function. + * Comprises the thing that went wrong and a general help message. + */ +void usage(const char *progName, const std::string &errorMsg) +{ + // TODO +} + +int main(int argc, char** argv) +{ + typedef TTAG(OnePTwoCIFacetCoupling) ProblemTypeTag; + return Dumux::start<ProblemTypeTag>(argc, argv, usage); +} diff --git a/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2c_1p2c.input b/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2c_1p2c.input new file mode 100644 index 0000000000000000000000000000000000000000..60a9b494c0aa040f8b1b6347f57a6ffcd7b7d3eb --- /dev/null +++ b/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2c_1p2c.input @@ -0,0 +1,32 @@ +[TimeManager] +DtInitial = 1 # [s] +TEnd = 10000000 # [s] +DtInitialBulkProblem = 1 # [s] +DtInitialLowDimProblem = 1 # [s] +EpisodeTime = 1000 # [s] + +[Grid] +File = ./grids/simplefracture_long.msh + +[Problem] +Name = test_1dfracture + +[MixedDimension] +UseIterativeSolver = False + +[IterativeAlgorithm] +MaxIterations = 100 +Tolerance = 1.0e-8 +Verbose = 1 + +[SpatialParams] +FractureAperture = 1e-1 # [m] +FracturePermeability = 1e-15 # [m^2] +MatrixPermeability = 1e-14 # [m^2] + +[Vtk] +AddVelocity = False + +[Newton] +MaxRelativeShift = 1e-5 +MaxSteps = 20 diff --git a/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2cni_1p2cni.cc b/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2cni_1p2cni.cc new file mode 100644 index 0000000000000000000000000000000000000000..4dac2687e96f895996a21ac04364de8527c6d5ac --- /dev/null +++ b/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2cni_1p2cni.cc @@ -0,0 +1,45 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * + * \brief test for the 1d 3d cell-centered coupled model + */ +#include "config.h" +#include "1d2dtestproblem.hh" +#include <dumux/mixeddimension/facet/start.hh> + +/*! + * \brief Provides an interface for customizing error messages associated with + * reading in parameters. + * + * \param progName The name of the program, that was tried to be started. + * \param errorMsg The error message that was issued by the start function. + * Comprises the thing that went wrong and a general help message. + */ +void usage(const char *progName, const std::string &errorMsg) +{ + // TODO +} + +int main(int argc, char** argv) +{ + typedef TTAG(OnePTwoCNIFacetCoupling) ProblemTypeTag; + return Dumux::start<ProblemTypeTag>(argc, argv, usage); +} diff --git a/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2cni_1p2cni.input b/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2cni_1p2cni.input new file mode 100644 index 0000000000000000000000000000000000000000..afad3955e811cfb1fc608d6251194e03c13fc4e4 --- /dev/null +++ b/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2cni_1p2cni.input @@ -0,0 +1,32 @@ +[TimeManager] +DtInitial = 1 # [s] +TEnd = 10000000 # [s] +DtInitialBulkProblem = 1 # [s] +DtInitialLowDimProblem = 1 # [s] +EpisodeTime = 1000 # [s] + +[Grid] +File = ./grids/simplefracture_long.msh + +[Problem] +Name = test_1dfracture_ni + +[MixedDimension] +UseIterativeSolver = False + +[IterativeAlgorithm] +MaxIterations = 100 +Tolerance = 1.0e-8 +Verbose = 1 + +[SpatialParams] +FractureAperture = 1e-1 # [m] +FracturePermeability = 1e-12 # [m^2] +MatrixPermeability = 1e-14 # [m^2] + +[Vtk] +AddVelocity = False + +[Newton] +MaxRelativeShift = 1e-5 +MaxSteps = 20 diff --git a/test/mixeddimension/facet/1p_1p/1d2dtestproblem.hh b/test/mixeddimension/facet/1p_1p/1d2dtestproblem.hh new file mode 100644 index 0000000000000000000000000000000000000000..18e8312ed39f7e8df8aebeb6e997b2deeb5a53f5 --- /dev/null +++ b/test/mixeddimension/facet/1p_1p/1d2dtestproblem.hh @@ -0,0 +1,97 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * + * \brief A test problem for the 1d2d coupled problem: + * 1d fractures living on the element facets of a 2d matrix + */ +#ifndef DUMUX_1D2D_FACET_TEST_PROBLEM_HH +#define DUMUX_1D2D_FACET_TEST_PROBLEM_HH + +#include "fractureproblem.hh" +#include "matrixproblem.hh" + +#include <dumux/mixeddimension/problem.hh> +#include <dumux/mixeddimension/facet/gmshdualfacetgridcreator.hh> +#include <dumux/mixeddimension/facet/mpfa/couplingmanager.hh> + +namespace Dumux +{ +template <class TypeTag> +class OnePFacetCouplingProblem; + +namespace Properties +{ +// Type tag of the global Problem and the two sub problems +NEW_TYPE_TAG(OnePFacetCoupling, INHERITS_FROM(MixedDimension)); + +// Set the problem property +SET_TYPE_PROP(OnePFacetCoupling, Problem, Dumux::OnePFacetCouplingProblem<TypeTag>); + +// Set the grid creator +SET_TYPE_PROP(OnePFacetCoupling, GridCreator, Dumux::GmshDualFacetGridCreator<TypeTag>); + +// Set the two sub-problems of the global problem +SET_TYPE_PROP(OnePFacetCoupling, BulkProblemTypeTag, TTAG(OnePCCMpfaMatrixProblem)); +SET_TYPE_PROP(OnePFacetCoupling, LowDimProblemTypeTag, TTAG(OnePCCFractureProblem)); + +// The coupling manager +SET_TYPE_PROP(OnePFacetCoupling, CouplingManager, CCMpfaFacetCouplingManager<TypeTag>); + +// The linear solver to be used +SET_TYPE_PROP(OnePFacetCoupling, LinearSolver, ILU0BiCGSTABBackend<TypeTag>); + +// The sub-problems need to know the global problem's type tag +SET_TYPE_PROP(OnePCCMpfaMatrixProblem, GlobalProblemTypeTag, TTAG(OnePFacetCoupling)); +SET_TYPE_PROP(OnePCCFractureProblem, GlobalProblemTypeTag, TTAG(OnePFacetCoupling)); + +// The subproblems inherit the parameter tree from this problem +SET_PROP(OnePCCMpfaMatrixProblem, ParameterTree) : GET_PROP(TTAG(OnePFacetCoupling), ParameterTree) {}; +SET_PROP(OnePCCFractureProblem, ParameterTree) : GET_PROP(TTAG(OnePFacetCoupling), ParameterTree) {}; + +// Set the grids for the two sub-problems +SET_TYPE_PROP(OnePCCMpfaMatrixProblem, Grid, Dune::ALUGrid<2, 2, Dune::simplex, Dune::nonconforming>); +SET_TYPE_PROP(OnePCCFractureProblem, Grid, Dune::FoamGrid<1,2>); + +} + +template <class TypeTag> +class OnePFacetCouplingProblem : public MixedDimensionProblem<TypeTag> +{ + using ParentType = MixedDimensionProblem<TypeTag>; + + using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); + + using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); + using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); + + using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); + using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); + +public: + + OnePFacetCouplingProblem(TimeManager &timeManager, const BulkGridView &bulkGridView, const LowDimGridView &lowDimGridView) + : ParentType(timeManager, bulkGridView, lowDimGridView) + {} +}; + +} //end namespace + +#endif diff --git a/test/mixeddimension/facet/1p_1p/CMakeLists.txt b/test/mixeddimension/facet/1p_1p/CMakeLists.txt new file mode 100644 index 0000000000000000000000000000000000000000..9c66a8c1eb500828a2933e5d35fa18cf60b8bc4a --- /dev/null +++ b/test/mixeddimension/facet/1p_1p/CMakeLists.txt @@ -0,0 +1,3 @@ +dune_add_test(SOURCES test_fracture_1p_1p.cc) +dune_symlink_to_source_files(FILES "grids" "test_fracture_1p_1p.input") +set(CMAKE_BUILD_TYPE Release) diff --git a/test/mixeddimension/facet/1p_1p/fractureproblem.hh b/test/mixeddimension/facet/1p_1p/fractureproblem.hh new file mode 100644 index 0000000000000000000000000000000000000000..981b50e564dc84c5e648dbe2d4f4ef33bb9651d8 --- /dev/null +++ b/test/mixeddimension/facet/1p_1p/fractureproblem.hh @@ -0,0 +1,209 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * + * \brief A test problem for the one-dimensional single-phase fracture model + */ +#ifndef DUMUX_1P_FRACTURE_PROBLEM_HH +#define DUMUX_1P_FRACTURE_PROBLEM_HH + +#include <dumux/implicit/cellcentered/tpfa/properties.hh> +#include <dumux/mixeddimension/subproblemproperties.hh> + +#include <dumux/porousmediumflow/1p/implicit/model.hh> +#include <dumux/porousmediumflow/implicit/problem.hh> + +#include <dumux/material/components/unit.hh> +#include <dumux/material/fluidsystems/liquidphase.hh> + +#include "fracturespatialparams.hh" + +namespace Dumux +{ + +//! Forward declaration of the problem class +template <class TypeTag> +class OnePFractureProblem; + +namespace Properties +{ +NEW_TYPE_TAG(OnePFractureProblem, INHERITS_FROM(OneP)); +NEW_TYPE_TAG(OnePCCFractureProblem, INHERITS_FROM(CCTpfaModel, OnePFractureProblem)); + +SET_PROP(OnePFractureProblem, Fluid) +{ +private: + typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar; +public: + typedef FluidSystems::LiquidPhase<Scalar, Unit<Scalar> > type; +}; + +// Set the problem property +SET_TYPE_PROP(OnePFractureProblem, Problem, OnePFractureProblem<TypeTag>); + +// Set the spatial parameters +SET_TYPE_PROP(OnePFractureProblem, SpatialParams, OnePFractureSpatialParams<TypeTag>); + +// Linear solver settings +SET_TYPE_PROP(OnePFractureProblem, LinearSolver, SuperLUBackend<TypeTag>); + +// Enable gravity +SET_BOOL_PROP(OnePFractureProblem, ProblemEnableGravity, false); +} + +/*! + * \ingroup OnePModel + * \ingroup ImplicitTestProblems + * \brief Test problem for the one-phase model: + */ +template <class TypeTag> +class OnePFractureProblem : public ImplicitPorousMediaProblem<TypeTag> +{ + using ParentType = ImplicitPorousMediaProblem<TypeTag>; + + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Element = typename GridView::template Codim<0>::Entity; + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Indices = typename GET_PROP_TYPE(TypeTag, Indices); + using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); + using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); + using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); + using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); + using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); + + using GlobalProblemTypeTag = typename GET_PROP_TYPE(TypeTag, GlobalProblemTypeTag); + using CouplingManager = typename GET_PROP_TYPE(GlobalProblemTypeTag, CouplingManager); + + enum + { + conti0EqIdx = Indices::conti0EqIdx, + pressureIdx = Indices::pressureIdx + }; + + static constexpr int numEq = GET_PROP_VALUE(TypeTag, NumEq); + static constexpr int dim = GridView::dimension; + static constexpr int dimWorld = GridView::dimensionworld; + + using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; + +public: + OnePFractureProblem(TimeManager &timeManager, const GridView &gridView) + : ParentType(timeManager, gridView) + { + name_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Problem, Name) + "_fracture"; + eps_ = 1e-6; + } + + /*! + * \brief The problem name. + * This is used as a prefix for files generated by the simulation. + */ + const std::string& name() const + { return name_; } + + /*! + * \brief Return the temperature within the domain in [K]. + * + * This problem assumes a temperature of 10 degrees Celsius. + */ + Scalar temperature() const + { return 273.15 + 10; } // 10C + + /*! + * \brief Return how much the domain is extruded at a given sub-control volume. + */ + Scalar extrusionFactorAtPos(const GlobalPosition &globalPos) const + { + //! return the user-specified fracture aperture + static const Scalar a = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, FractureAperture); + return a; + } + + + /*! + * \brief Return the sources within the domain. + */ + PrimaryVariables source(const Element& element, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolume& scv) const + { + // we have only sources coming from the bulk domain + return couplingManager().evalSourcesFromBulk(element, fvGeometry, elemVolVars, scv); + } + + /*! + * \brief Specifies which kind of boundary condition should be used. + */ + BoundaryTypes boundaryTypesAtPos(const GlobalPosition& globalPos) const + { + BoundaryTypes values; + if (globalPos[0] < eps_ || globalPos[0] > this->bBoxMax()[0] - eps_) + values.setAllDirichlet(); + else + values.setAllNeumann(); + return values; + } + + /*! + * \brief Evaluate the boundary conditions for a dirichlet + * control volume. + */ + PrimaryVariables dirichletAtPos(const GlobalPosition& globalPos) const + { + PrimaryVariables values; + values[pressureIdx] = 2.0 - globalPos[0]/this->bBoxMax()[0]; + return values; + } + + PrimaryVariables neumannAtPos(const GlobalPosition& globalPos) const + { return PrimaryVariables(0.0); } + + /*! + * \brief Evaluate the initial value for a control volume. + * + * For this method, the \a priVars parameter stores primary + * variables. + */ + PrimaryVariables initialAtPos(const GlobalPosition& globalPos) const + { + PrimaryVariables priVars; + priVars[pressureIdx] = 2.0 - globalPos[0]/this->bBoxMax()[0]; + return priVars; + }; + + //! Set the coupling manager + void setCouplingManager(std::shared_ptr<CouplingManager> cm) + { couplingManager_ = cm; } + + //! Get the coupling manager + const CouplingManager& couplingManager() const + { return *couplingManager_; } + +private: + std::string name_; + Scalar eps_; + std::shared_ptr<CouplingManager> couplingManager_; +}; +} //end namespace + +#endif diff --git a/test/mixeddimension/facet/1p_1p/fracturespatialparams.hh b/test/mixeddimension/facet/1p_1p/fracturespatialparams.hh new file mode 100644 index 0000000000000000000000000000000000000000..6747b6dfd53358e878cdd21864b9603afe8c0c6e --- /dev/null +++ b/test/mixeddimension/facet/1p_1p/fracturespatialparams.hh @@ -0,0 +1,78 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * + * \brief The spatial parameters class for the fracture problem + */ +#ifndef DUMUX_1P_FRACTURE_SPATIALPARAMS_HH +#define DUMUX_1P_FRACTURE_SPATIALPARAMS_HH + +#include <dumux/material/spatialparams/implicit1p.hh> + +namespace Dumux +{ + +/*! + * \ingroup OnePModel + * \ingroup ImplicitTestProblems + * + * \brief The spatial parameters class for the fracture problem + */ +template<class TypeTag> +class OnePFractureSpatialParams : public ImplicitSpatialParamsOneP<TypeTag> +{ + using ParentType = ImplicitSpatialParamsOneP<TypeTag>; + + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Element = typename GridView::template Codim<0>::Entity; + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + + static constexpr int dimWorld = GridView::dimensionworld; + using GlobalPosition = Dune::FieldVector<Scalar,dimWorld>; + +public: + using PermeabilityType = Scalar; + + OnePFractureSpatialParams(const Problem& problem, const GridView& gridView) + : ParentType(problem, gridView) + { + permeability_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, FracturePermeability); + } + + /*! + * \brief Return the intrinsic permeability for a given position in [m^2]. + */ + Scalar permeabilityAtPos(const GlobalPosition& globalPos) const + { return permeability_; } + + /*! + * \brief Define the porosity in [-]. + */ + Scalar porosityAtPos(const GlobalPosition& globalPos) const + { return 0.8; } + +private: + Scalar permeability_; +}; +} //end namespace + +#endif diff --git a/test/mixeddimension/facet/1p_1p/grids/minifracture.msh b/test/mixeddimension/facet/1p_1p/grids/minifracture.msh new file mode 100644 index 0000000000000000000000000000000000000000..63b76af4f5807b4ea70cad200226e4b596d2d85e --- /dev/null +++ b/test/mixeddimension/facet/1p_1p/grids/minifracture.msh @@ -0,0 +1,28 @@ +$MeshFormat +2.2 0 8 +$EndMeshFormat +$Nodes +8 +1 0 0 0 +2 1 0 0 +3 1 1 0 +4 0 1 0 +5 0.3 0.5 0 +6 0.7 0.5 0 +7 0.4999999999999999 0.75 0 +8 0.5 0.25 0 +$EndNodes +$Elements +11 +1 1 2 1 9 5 6 +2 2 2 2 11 1 4 5 +3 2 2 3 13 5 6 7 +4 2 2 3 13 3 7 6 +5 2 2 3 13 4 5 7 +6 2 2 3 13 3 4 7 +7 2 2 4 15 2 3 6 +8 2 2 5 17 5 6 8 +9 2 2 5 17 1 5 8 +10 2 2 5 17 2 8 6 +11 2 2 5 17 1 8 2 +$EndElements diff --git a/test/mixeddimension/facet/1p_1p/grids/simplefracture_long.msh b/test/mixeddimension/facet/1p_1p/grids/simplefracture_long.msh new file mode 100644 index 0000000000000000000000000000000000000000..97d57ee2faf29cac9cffb972184496b3cbce3f46 --- /dev/null +++ b/test/mixeddimension/facet/1p_1p/grids/simplefracture_long.msh @@ -0,0 +1,20728 @@ +$MeshFormat +2.2 0 8 +$EndMeshFormat +$Nodes +6953 +1 0 0 0 +2 1 0 0 +3 1 1 0 +4 0 1 0 +5 0 2 0 +6 1 2 0 +7 0 1.961246838739447 0 +8 0 1.923620027356419 0 +9 0 1.887086839128796 0 +10 0 1.851615478578754 0 +11 0 1.817175089469696 0 +12 0 1.783735707587069 0 +13 0 1.751268236839613 0 +14 0 1.719744426337889 0 +15 0 1.689136857907859 0 +16 0 1.659418885121227 0 +17 0 1.630564671287283 0 +18 0 1.602549093390542 0 +19 0 1.57534779490678 0 +20 0 1.548937093166071 0 +21 0 1.523294014611084 0 +22 0 1.498396249203548 0 +23 0 1.474222134050282 0 +24 0 1.450750629754289 0 +25 0 1.42796132677119 0 +26 0 1.405834394400535 0 +27 0 1.384350577400349 0 +28 0 1.363491184451146 0 +29 0 1.343238067032042 0 +30 0 1.323573604946558 0 +31 0 1.304480687581044 0 +32 0 1.285942703790913 0 +33 0 1.267943520816152 0 +34 0 1.250467486362735 0 +35 0 1.233499389066202 0 +36 0 1.217024467022857 0 +37 0 1.201028387241073 0 +38 0 1.185497232544095 0 +39 0 1.170417484876865 0 +40 0 1.155776031483197 0 +41 0 1.141560131320103 0 +42 0 1.127757413025329 0 +43 0 1.114355867344446 0 +44 0 1.101343837356743 0 +45 0 1.088710000985292 0 +46 0 1.076443364265634 0 +47 0 1.064533257314828 0 +48 0 1.052969311414612 0 +49 0 1.041741473455155 0 +50 0 1.030839971892862 0 +51 0 1.020255320150878 0 +52 0 1.009978311119173 0 +53 0 0.9900216888807783 0 +54 0 0.9797446798490225 0 +55 0 0.9691600281069848 0 +56 0 0.9582585265446345 0 +57 0 0.9470306885851157 0 +58 0 0.9354667426848361 0 +59 0 0.9235566357339615 0 +60 0 0.9112899990142319 0 +61 0 0.8986561626427046 0 +62 0 0.8856441326549224 0 +63 0 0.8722425869739866 0 +64 0 0.8584398686792792 0 +65 0 0.844223968516258 0 +66 0 0.8295825151226676 0 +67 0 0.8145027674555209 0 +68 0 0.7989716127586306 0 +69 0 0.7829755329769404 0 +70 0 0.7665006109336951 0 +71 0 0.7495325136372667 0 +72 0 0.7320564791839617 0 +73 0 0.7140572962093195 0 +74 0 0.6955193124193149 0 +75 0 0.6764263950539335 0 +76 0 0.6567619329685902 0 +77 0 0.6365088155496345 0 +78 0 0.6156494226005882 0 +79 0 0.5941656056005681 0 +80 0 0.5720386732300877 0 +81 0 0.5492493702471728 0 +82 0 0.5257778659513737 0 +83 0 0.5016037507983127 0 +84 0 0.4767059853907288 0 +85 0 0.4510629068356712 0 +86 0 0.4246522050948855 0 +87 0 0.3974509066110418 0 +88 0 0.3694353287142109 0 +89 0 0.3405811148801705 0 +90 0 0.3108631420934366 0 +91 0 0.280255573663297 0 +92 0 0.2487317631614541 0 +93 0 0.2162642924138732 0 +94 0 0.1828249105311132 0 +95 0 0.1483845214219136 0 +96 0 0.1129131608717201 0 +97 0 0.07637997264393659 0 +98 0 0.03875316126073414 0 +99 0.03999999999992186 0 0 +100 0.07999999999984518 0 0 +101 0.1199999999997832 0 0 +102 0.1599999999996745 0 0 +103 0.1999999999995579 0 0 +104 0.2399999999994413 0 0 +105 0.2799999999993247 0 0 +106 0.3199999999992081 0 0 +107 0.3599999999990915 0 0 +108 0.3999999999989749 0 0 +109 0.4399999999988584 0 0 +110 0.4799999999987418 0 0 +111 0.5199999999987361 0 0 +112 0.5599999999988415 0 0 +113 0.5999999999989468 0 0 +114 0.6399999999990521 0 0 +115 0.6799999999991574 0 0 +116 0.7199999999992628 0 0 +117 0.7599999999993681 0 0 +118 0.7999999999994734 0 0 +119 0.8399999999995788 0 0 +120 0.8799999999996841 0 0 +121 0.9199999999997894 0 0 +122 0.9599999999998947 0 0 +123 1 0.03875316126044642 0 +124 1 0.07637997264337447 0 +125 1 0.1129131608709185 0 +126 1 0.148384521420854 0 +127 1 0.1828249105297957 0 +128 1 0.2162642924123149 0 +129 1 0.2487317631596681 0 +130 1 0.2802555736612968 0 +131 1 0.310863142091238 0 +132 1 0.3405811148777859 0 +133 1 0.3694353287116517 0 +134 1 0.3974509066083207 0 +135 1 0.4246522050920155 0 +136 1 0.4510629068326624 0 +137 1 0.4767059853875909 0 +138 1 0.5016037507950835 0 +139 1 0.5257778659484318 0 +140 1 0.5492493702445046 0 +141 1 0.5720386732276799 0 +142 1 0.5941656055984066 0 +143 1 0.6156494225986616 0 +144 1 0.6365088155479306 0 +145 1 0.656761932967097 0 +146 1 0.6764263950526404 0 +147 1 0.6955193124182117 0 +148 1 0.7140572962083968 0 +149 1 0.7320564791832096 0 +150 1 0.7495325136366761 0 +151 1 0.7665006109332575 0 +152 1 0.782975532976647 0 +153 1 0.7989716127584735 0 +154 1 0.8145027674554923 0 +155 1 0.8295825151227607 0 +156 1 0.8442239685164651 0 +157 1 0.8584398686795944 0 +158 1 0.8722425869744029 0 +159 1 0.8856441326553172 0 +160 1 0.8986561626430498 0 +161 1 0.9112899990145296 0 +162 1 0.9235566357342145 0 +163 1 0.9354667426850464 0 +164 1 0.9470306885852854 0 +165 1 0.9582585265447658 0 +166 1 0.9691600281070806 0 +167 1 0.9797446798490843 0 +168 1 0.9900216888808085 0 +169 1 1.009978311119173 0 +170 1 1.020255320150877 0 +171 1 1.030839971892861 0 +172 1 1.041741473455154 0 +173 1 1.052969311414611 0 +174 1 1.064533257314827 0 +175 1 1.076443364265633 0 +176 1 1.088710000985291 0 +177 1 1.101343837356743 0 +178 1 1.114355867344445 0 +179 1 1.127757413025327 0 +180 1 1.141560131320103 0 +181 1 1.155776031483196 0 +182 1 1.170417484876864 0 +183 1 1.185497232544094 0 +184 1 1.201028387241072 0 +185 1 1.217024467022855 0 +186 1 1.2334993890662 0 +187 1 1.250467486362734 0 +188 1 1.267943520816151 0 +189 1 1.285942703790912 0 +190 1 1.304480687581042 0 +191 1 1.323573604946557 0 +192 1 1.34323806703204 0 +193 1 1.363491184451145 0 +194 1 1.384350577400348 0 +195 1 1.405834394400534 0 +196 1 1.427961326771189 0 +197 1 1.450750629754288 0 +198 1 1.474222134050281 0 +199 1 1.498396249203547 0 +200 1 1.523294014611084 0 +201 1 1.548937093166071 0 +202 1 1.57534779490678 0 +203 1 1.602549093390542 0 +204 1 1.630564671287284 0 +205 1 1.659418885121229 0 +206 1 1.689136857907859 0 +207 1 1.719744426337889 0 +208 1 1.751268236839613 0 +209 1 1.783735707587067 0 +210 1 1.817175089469695 0 +211 1 1.851615478578753 0 +212 1 1.887086839128794 0 +213 1 1.923620027356417 0 +214 1 1.961246838739447 0 +215 0.9599999999998334 2 0 +216 0.9199999999996669 2 0 +217 0.879999999999508 2 0 +218 0.8399999999997222 2 0 +219 0.7999999999999997 2 0 +220 0.7600000000002772 2 0 +221 0.7200000000005549 2 0 +222 0.6800000000008324 2 0 +223 0.6400000000011098 2 0 +224 0.6000000000013872 2 0 +225 0.5600000000016645 2 0 +226 0.5200000000019419 2 0 +227 0.4800000000019974 2 0 +228 0.4400000000018309 2 0 +229 0.4000000000016645 2 0 +230 0.360000000001498 2 0 +231 0.3200000000013316 2 0 +232 0.2800000000011651 2 0 +233 0.2400000000009987 2 0 +234 0.2000000000008322 2 0 +235 0.1600000000006658 2 0 +236 0.1200000000004994 2 0 +237 0.08000000000033292 2 0 +238 0.04000000000016646 2 0 +239 0.009999999999981104 1 0 +240 0.01999999999996237 1 0 +241 0.02999999999994307 1 0 +242 0.03999999999992186 1 0 +243 0.04999999999989966 1 0 +244 0.05999999999987837 1 0 +245 0.06999999999986051 1 0 +246 0.07999999999984518 1 0 +247 0.0899999999998299 1 0 +248 0.09999999999981463 1 0 +249 0.1099999999997994 1 0 +250 0.1199999999997832 1 0 +251 0.1299999999997609 1 0 +252 0.1399999999997328 1 0 +253 0.1499999999997036 1 0 +254 0.1599999999996745 1 0 +255 0.1699999999996453 1 0 +256 0.1799999999996162 1 0 +257 0.189999999999587 1 0 +258 0.1999999999995579 1 0 +259 0.2099999999995288 1 0 +260 0.2199999999994996 1 0 +261 0.2299999999994704 1 0 +262 0.2399999999994413 1 0 +263 0.2499999999994121 1 0 +264 0.259999999999383 1 0 +265 0.2699999999993538 1 0 +266 0.2799999999993247 1 0 +267 0.2899999999992955 1 0 +268 0.2999999999992664 1 0 +269 0.3099999999992372 1 0 +270 0.3199999999992081 1 0 +271 0.329999999999179 1 0 +272 0.3399999999991498 1 0 +273 0.3499999999991207 1 0 +274 0.3599999999990915 1 0 +275 0.3699999999990624 1 0 +276 0.3799999999990332 1 0 +277 0.3899999999990041 1 0 +278 0.3999999999989749 1 0 +279 0.4099999999989458 1 0 +280 0.4199999999989167 1 0 +281 0.4299999999988875 1 0 +282 0.4399999999988584 1 0 +283 0.4499999999988292 1 0 +284 0.4599999999988 1 0 +285 0.4699999999987708 1 0 +286 0.4799999999987418 1 0 +287 0.4899999999987126 1 0 +288 0.4999999999986943 1 0 +289 0.5099999999987098 1 0 +290 0.5199999999987361 1 0 +291 0.5299999999987626 1 0 +292 0.5399999999987888 1 0 +293 0.5499999999988152 1 0 +294 0.5599999999988415 1 0 +295 0.5699999999988679 1 0 +296 0.5799999999988942 1 0 +297 0.5899999999989205 1 0 +298 0.5999999999989468 1 0 +299 0.6099999999989731 1 0 +300 0.6199999999989995 1 0 +301 0.6299999999990258 1 0 +302 0.6399999999990521 1 0 +303 0.6499999999990784 1 0 +304 0.6599999999991049 1 0 +305 0.6699999999991312 1 0 +306 0.6799999999991574 1 0 +307 0.6899999999991837 1 0 +308 0.6999999999992101 1 0 +309 0.7099999999992365 1 0 +310 0.7199999999992628 1 0 +311 0.7299999999992892 1 0 +312 0.7399999999993154 1 0 +313 0.7499999999993417 1 0 +314 0.7599999999993681 1 0 +315 0.7699999999993945 1 0 +316 0.7799999999994207 1 0 +317 0.789999999999447 1 0 +318 0.7999999999994734 1 0 +319 0.8099999999994998 1 0 +320 0.8199999999995261 1 0 +321 0.8299999999995523 1 0 +322 0.8399999999995788 1 0 +323 0.8499999999996051 1 0 +324 0.8599999999996314 1 0 +325 0.8699999999996577 1 0 +326 0.8799999999996841 1 0 +327 0.8899999999997104 1 0 +328 0.8999999999997367 1 0 +329 0.9099999999997631 1 0 +330 0.9199999999997894 1 0 +331 0.9299999999998156 1 0 +332 0.939999999999842 1 0 +333 0.9499999999998684 1 0 +334 0.9599999999998947 1 0 +335 0.969999999999921 1 0 +336 0.9799999999999475 1 0 +337 0.9899999999999737 1 0 +338 0.5048683847089982 1.496966078704385 0 +339 0.7113755267421392 1.28439929627209 0 +340 0.2870897505559813 1.285911559479631 0 +341 0.4971637719999193 1.219543611537615 0 +342 0.8349999999995662 1.165012760259128 0 +343 0.16499999999966 1.16501276025838 0 +344 0.3051755485833004 1.141833156394544 0 +345 0.6978641611449509 1.141179812287203 0 +346 0.2541598676914442 1.537498841875233 0 +347 0.7516074000513059 1.530214991369846 0 +348 0.5749999999988812 1.121590436419565 0 +349 0.4249999999989025 1.120996334876456 0 +350 0.5886825120497132 1.742395246458429 0 +351 0.9049999999997509 1.095075210653423 0 +352 0.09499999999982227 1.095075210653024 0 +353 0.14379076891955 1.308427229581727 0 +354 0.8544707740310964 1.305664085757452 0 +355 0.2249252111609139 1.095412579796293 0 +356 0.7750747888379796 1.095412579796752 0 +357 0.4250637377962498 1.359847963402365 0 +358 0.5768274368598336 1.35129270071606 0 +359 0.232351283641529 1.768503569817728 0 +360 0.3802897055841284 1.226198321611149 0 +361 0.6192760303371638 1.22479805545081 0 +362 0.4025305533449121 1.669262073403616 0 +363 0.504999999998701 1.080842025111615 0 +364 0.3540355588524646 1.075474426616115 0 +365 0.644999999999064 1.079635838679168 0 +366 0.7990645241381551 1.730231666731534 0 +367 0.2316891351137946 1.404742804797436 0 +368 0.7694331512231478 1.402730452017867 0 +369 0.1545042280176006 1.063593299286463 0 +370 0.8454957719816769 1.063593299286772 0 +371 0.2849999999993101 1.065820086360372 0 +372 0.7149999999992496 1.065820086360718 0 +373 0.09377905012273467 1.225368003754102 0 +374 0.9062209498772704 1.225368003754103 0 +375 0.6373218323081091 1.468198342147499 0 +376 0.2437488911468461 1.206227823557092 0 +377 0.7563457096313686 1.204448828360671 0 +378 0.3742987035237452 1.48152301108111 0 +379 0.130120956628325 1.488144491727632 0 +380 0.8842018299350152 1.417708531946811 0 +381 0.4454026484076493 1.061978585006698 0 +382 0.1436146135644482 1.629187449451359 0 +383 0.5629536743808899 1.06080313266998 0 +384 0.9452464482995113 1.054556622190714 0 +385 0.05475355170023977 1.054556622190453 0 +386 0.5950547835237185 1.600890719371526 0 +387 0.8740072178815945 1.542984157925946 0 +388 0.5108757413372551 1.148615146531299 0 +389 0.4502909068163569 1.82938502013177 0 +390 0.320959186607418 1.382362774719732 0 +391 0.6740927104205064 1.374617160813473 0 +392 0.07186653785835088 1.159868242939921 0 +393 0.928133462141609 1.159868242940092 0 +394 0.4959118282364381 1.309385292052621 0 +395 0.3643843179845154 1.13888859794135 0 +396 0.394999999998989 1.049706683155523 0 +397 0.09900920945088526 1.394612170649323 0 +398 0.6342119551505342 1.139828098776277 0 +399 0.1761403003962369 1.239746873375074 0 +400 0.8274952264771659 1.237723114919311 0 +401 0.3119424735119836 1.211680323591548 0 +402 0.6870211765169325 1.211624423530248 0 +403 0.204572779491465 1.049475474480661 0 +404 0.7954272205075397 1.049475474480903 0 +405 0.5641251270693396 1.188701642478922 0 +406 0.6938995237861791 1.848342835421058 0 +407 0.55453485340953 1.256873385419238 0 +408 0.1048764334162882 1.047448610287509 0 +409 0.8951235665832384 1.047448610287716 0 +410 0.5026335410681588 1.395655529701533 0 +411 0.3643240580771657 1.304695217186724 0 +412 0.7096536221770959 1.648333690533706 0 +413 0.4363994351997544 1.18712353107406 0 +414 0.6368321661548365 1.299017190009066 0 +415 0.324999999999193 1.044874475977855 0 +416 0.6751442204991802 1.045403814441373 0 +417 0.6149999999989879 1.045311677015255 0 +418 0.2834057122870183 1.65669529178889 0 +419 0.4424341595009901 1.267051502655688 0 +420 0.2469301178973238 1.14826630595116 0 +421 0.7530698821014439 1.14826630595191 0 +422 0.07143472313351716 1.295821946784376 0 +423 0.9276346844210719 1.295049584115116 0 +424 0.2224279297201235 1.324104723781493 0 +425 0.8633971649281783 1.864639346706618 0 +426 0.1425930199360525 1.117439720643538 0 +427 0.8574069800633141 1.11743972064408 0 +428 0.4313365006717135 1.567463047102743 0 +429 0.7841807853234315 1.299559681794741 0 +430 0.4843312226870911 1.043718999612552 0 +431 0.8835672430108014 1.654316002243618 0 +432 0.2472488140342124 1.041119926334183 0 +433 0.7527511859645566 1.041119926334408 0 +434 0.0475989151197406 1.100213359190462 0 +435 0.9524010848800448 1.100213359190834 0 +436 0.5262244164522624 1.039972999530269 0 +437 0.1387448480122291 1.868075170033056 0 +438 0.8182179157022071 1.47531658027092 0 +439 0.1198586083418926 1.735554942864486 0 +440 0.5782092546423236 1.861628818245807 0 +441 0.3227958499757315 1.86550086858886 0 +442 0.2963443339199617 1.45414217456952 0 +443 0.4760358061261165 1.11884223216365 0 +444 0.3360668310449968 1.561700003484749 0 +445 0.5203473837657192 1.669521313702595 0 +446 0.6005435161090046 1.085506457923628 0 +447 0.4362003367629996 1.432232531259177 0 +448 0.1651436870037796 1.373609734503185 0 +449 0.8062768600613532 1.603678045390721 0 +450 0.5721601540390162 1.422483920265093 0 +451 0.2705835837177517 1.108619809700702 0 +452 0.7294164162809211 1.108619809701243 0 +453 0.929392206389964 1.365084835705914 0 +454 0.1864718869718126 1.126018362677127 0 +455 0.8135281130272991 1.126018362677697 0 +456 0.3344082486261599 1.748186264316926 0 +457 0.2329460877155683 1.261831202934324 0 +458 0.3127434919582956 1.098227407216015 0 +459 0.6871248470305197 1.098025283728294 0 +460 0.6666634367468084 1.548678585712974 0 +461 0.7059985982824595 1.443645413628561 0 +462 0.0880348923487676 1.564160737256966 0 +463 0.8962248988273027 1.756537303899436 0 +464 0.1174095429570162 1.156001542818463 0 +465 0.8825904570426577 1.156001542819261 0 +466 0.3945727958490747 1.090005009089835 0 +467 0.8324775331093248 1.372361299807416 0 +468 0.3614282206818003 1.03507407938755 0 +469 0.7403340088783437 1.342877523132671 0 +470 0.5428783977445191 1.096307691144361 0 +471 0.2059344475222542 1.476256816378896 0 +472 0.425738149301633 1.033524767413993 0 +473 0.9246321199467035 1.484420615646103 0 +474 0.1744882687329351 1.553141965653251 0 +475 0.1751514215878712 1.033583309557956 0 +476 0.8248485784112987 1.03358330955813 0 +477 0.6986772632360908 1.744352652800111 0 +478 0.1354786227014112 1.031764002975215 0 +479 0.8645213772979718 1.031764002975363 0 +480 0.515371287911105 1.575021930415143 0 +481 0.04985701529613179 1.20381835688959 0 +482 0.9501429847039704 1.203818356889792 0 +483 0.1356191196138404 1.203391819878145 0 +484 0.8644361939104058 1.203133908868517 0 +485 0.5771546382616788 1.524403817864126 0 +486 0.1902710231370598 1.082273511389928 0 +487 0.8097289768620298 1.082273511390346 0 +488 0.5844780350137612 1.031919667260371 0 +489 0.2949999999992809 1.03218665545763 0 +490 0.6447839974194614 1.032526177169373 0 +491 0.7049999999992214 1.032186655457807 0 +492 0.3386417500680102 1.257812188029089 0 +493 0.3549062890939554 1.18732522773497 0 +494 0.2097435177636035 1.174326610202922 0 +495 0.7902564822353856 1.174326610203758 0 +496 0.6459079348747186 1.186828513620802 0 +497 0.2797423306870386 1.180649839711299 0 +498 0.7212555455889628 1.179591474007765 0 +499 0.2739284282698835 1.343376949108817 0 +500 0.6619618549268813 1.25470389556274 0 +501 0.06974372727177681 1.455592152671457 0 +502 0.03216403228629063 1.032116530624794 0 +503 0.9678359677135613 1.032116530624944 0 +504 0.3828333561213982 1.405700943887016 0 +505 0.4048784758487263 1.158511166190438 0 +506 0.07499999999985285 1.030822819132027 0 +507 0.9249999999997995 1.030822819132173 0 +508 0.4714467339244875 1.164260216518812 0 +509 0.05638110927802219 1.348365021899717 0 +510 0.4553259913329818 1.030077482502192 0 +511 0.5958623226376665 1.157873110951488 0 +512 0.5547414348476822 1.029868773340605 0 +513 0.760452995118204 1.257428995447735 0 +514 0.1319722170854474 1.256878163711136 0 +515 0.8696324864519224 1.258573757825914 0 +516 0.4572442991479824 1.741561175628193 0 +517 0.04814828103691974 1.252553517768934 0 +518 0.9518517189628571 1.252553517769338 0 +519 0.1229207587044873 1.076365566024789 0 +520 0.8770792412949471 1.076365566025116 0 +521 0.203855458945367 1.688748245649081 0 +522 0.2239627504718836 1.609684914668316 0 +523 0.2763901191838297 1.239297140096479 0 +524 0.5862732550271118 1.299917186960195 0 +525 0.2533910647130193 1.076071473630957 0 +526 0.746608935285705 1.076071473631355 0 +527 0.03898608645145495 1.138715992232082 0 +528 0.9610139135485798 1.138715992232449 0 +529 0.4726850006227989 1.083854564865381 0 +530 0.1879677589347564 1.286596558441257 0 +531 0.6179323802290941 1.392486538899737 0 +532 0.5246136467267515 1.189403168958926 0 +533 0.438622568151799 1.505122055911884 0 +534 0.4164012791981738 1.311632414995821 0 +535 0.5138519793785878 1.113764797232734 0 +536 0.5505558842535986 1.152296101333632 0 +537 0.2286319907358996 1.867417555706223 0 +538 0.1453868199239883 1.431983459051211 0 +539 0.9467566053090382 1.421237450062602 0 +540 0.6319082750988454 1.671469534242648 0 +541 0.9268512964147272 1.59618598493076 0 +542 0.6836219048474306 1.325605431183472 0 +543 0.0752100818455609 1.12468940322967 0 +544 0.9247899181541184 1.124689403229922 0 +545 0.0769102984955212 1.67216964801866 0 +546 0.2266702183242972 1.027164454102343 0 +547 0.7733297816745925 1.027164454102493 0 +548 0.5094674813310797 1.264196899877203 0 +549 0.3460718419089456 1.112652257447309 0 +550 0.6539609433060007 1.112582868665854 0 +551 0.03095925860294166 1.075253881247921 0 +552 0.9690407413969335 1.075253881248284 0 +553 0.3723806536000443 1.354835804846698 0 +554 0.5273551167236247 1.790846882407766 0 +555 0.7225962044601031 1.23378066830778 0 +556 0.3950173176655707 1.26871462402894 0 +557 0.8828755332595645 1.351456441184084 0 +558 0.7653573584609243 1.464506585398373 0 +559 0.4535664057216711 1.225202082826928 0 +560 0.7808572111062158 1.813954609853594 0 +561 0.7736518006864613 1.908899104393791 0 +562 0.07958294756056862 1.066870977253348 0 +563 0.1081572010676713 1.343581737917401 0 +564 0.9204170524390723 1.066870977253651 0 +565 0.4272240465958173 1.08888385026421 0 +566 0.3180579033420357 1.319725536656434 0 +567 0.7883947112036476 1.349437668616844 0 +568 0.5256144948566308 1.350578018113227 0 +569 0.8140267334883057 1.536180092638261 0 +570 0.3168980447747105 1.501858811864778 0 +571 0.4738100646241676 1.353989244197258 0 +572 0.1817751161976196 1.199514735523571 0 +573 0.8191202158725644 1.199992414668096 0 +574 0.1094412303760258 1.123859586718336 0 +575 0.890558769623521 1.123859586718911 0 +576 0.6072316071079984 1.115182507181506 0 +577 0.5407759365081095 1.300398237819001 0 +578 0.2687145685562897 1.028267818260896 0 +579 0.7312854314423486 1.028267818261052 0 +580 0.3848499011084606 1.026220027758316 0 +581 0.09438381662255753 1.187827283366739 0 +582 0.9056161833777533 1.187827283366877 0 +583 0.5381752219618656 1.067269536279207 0 +584 0.4035860052508178 1.9085339591121 0 +585 0.4933266463598208 1.906876434721966 0 +586 0.5791726680740346 1.224396131825406 0 +587 0.2236307030788081 1.127656637560064 0 +588 0.776369296920125 1.127656637560704 0 +589 0.7240101678577586 1.39005283925881 0 +590 0.5071306834769315 1.02625513141825 0 +591 0.3193444349961477 1.175643043238262 0 +592 0.2788484115801563 1.39277161430332 0 +593 0.2291431614987724 1.063034403560922 0 +594 0.7708568385000947 1.063034403561262 0 +595 0.7004693288541993 1.501744798367538 0 +596 0.6808691982410278 1.175490553125656 0 +597 0.8187947105819663 1.419523644513117 0 +598 0.3453210823463811 1.634395215945646 0 +599 0.05572254946890599 1.510845131907316 0 +600 0.3962669583047747 1.123996924313109 0 +601 0.1610911214063988 1.094851142463035 0 +602 0.8389088785928496 1.094851142463484 0 +603 0.4655126411242813 1.6215263669657 0 +604 0.5984505789434684 1.26008984836154 0 +605 0.5276125684044863 1.45335230450441 0 +606 0.4012227660695611 1.192196291299601 0 +607 0.5732641923368413 1.090592014021488 0 +608 0.6017031352219305 1.192719313123014 0 +609 0.5915857119596174 1.05822828647841 0 +610 0.3131646032185611 1.070868119354563 0 +611 0.6868059079327227 1.070880372134253 0 +612 0.04687169832595089 1.398384554542657 0 +613 0.4373238795439551 1.150317819767526 0 +614 0.03245394526644756 1.174104559919675 0 +615 0.9675460547336536 1.174104559919884 0 +616 0.718550209908918 1.582842817849688 0 +617 0.8749173617249391 1.470681398428636 0 +618 0.8230523744243365 1.281352424224439 0 +619 0.07895518036043786 1.811813076251157 0 +620 0.2082028320168079 1.223734683991199 0 +621 0.7896444750335313 1.223404834676072 0 +622 0.6467635294185026 1.801653110195687 0 +623 0.6469062969066819 1.91420798254675 0 +624 0.104999999999807 1.023705229002148 0 +625 0.8949999999997217 1.023705229002247 0 +626 0.7711757512590844 1.66515641734804 0 +627 0.9548380205133138 1.331633358682849 0 +628 0.5299936044782878 1.225084057652564 0 +629 0.6574620269413445 1.42070492433435 0 +630 0.1981889624062577 1.024890894031797 0 +631 0.8018110375928029 1.024890894031918 0 +632 0.6209181603243408 1.346268299270745 0 +633 0.3391650416318992 1.024665133074319 0 +634 0.2844836266571301 1.589577585708552 0 +635 0.9415188663418799 1.538229576488797 0 +636 0.4192758564183099 1.057652982670849 0 +637 0.6517914139308951 1.608816183609679 0 +638 0.9423647441389441 1.705967568047342 0 +639 0.4555037721575113 1.304048527328971 0 +640 0.379452767186408 1.814361250475803 0 +641 0.3357722291285306 1.141650135089167 0 +642 0.4173464661051023 1.226707887981034 0 +643 0.9223024049908609 1.906069030610277 0 +644 0.6651635023958936 1.141772030982669 0 +645 0.4673525941927508 1.196043115007613 0 +646 0.9298954366245888 1.821874496146171 0 +647 0.1834429980742782 1.058380130575113 0 +648 0.8165570019248389 1.058380130575404 0 +649 0.3759462771784473 1.061302503952137 0 +650 0.1549999999996889 1.02221252282042 0 +651 0.8449999999995867 1.022212522820531 0 +652 0.2475564184779633 1.299889332127325 0 +653 0.2504710027680291 1.453151165689995 0 +654 0.2745060729982198 1.1382096137547 0 +655 0.7254939270004104 1.138209613755408 0 +656 0.6146826352280125 1.023768448068067 0 +657 0.3480876393771392 1.218320149655876 0 +658 0.3353900204201292 1.422177612590626 0 +659 0.164744018633862 1.79898400239591 0 +660 0.06136688115016602 1.616576484513275 0 +661 0.3151488066220225 1.022604313855231 0 +662 0.8180341197256054 1.317837195040082 0 +663 0.05081468179599744 1.02043497625855 0 +664 0.9491853182037735 1.020434976258642 0 +665 0.6535555701545785 1.219810214182851 0 +666 0.09621011880110795 1.263978198508291 0 +667 0.9086652393369654 1.262947028991559 0 +668 0.6846135277903629 1.020786696508784 0 +669 0.5614276279877052 1.475012107783639 0 +670 0.3859848290187913 1.543251293990811 0 +671 0.1801337726086816 1.336234406647904 0 +672 0.450690562024449 1.10375028210227 0 +673 0.6525579664355614 1.053661542809959 0 +674 0.4518420797877518 1.390859658623436 0 +675 0.863194229940893 1.602393221548905 0 +676 0.5072419189512092 1.055580801080491 0 +677 0.7996397202508009 1.258535168113664 0 +678 0.6208534869099951 1.070467992210701 0 +679 0.6214819367662816 1.093820312696573 0 +680 0.5504476470798463 1.384313375717408 0 +681 0.5385801555017435 1.123675515015415 0 +682 0.3461661413192844 1.056636093517496 0 +683 0.08312641484563575 1.918454894790681 0 +684 0.5736752371555937 1.656200270238859 0 +685 0.4749529830694161 1.535501085771155 0 +686 0.474999999998756 1.02119976559362 0 +687 0.06116647035632453 1.080027491555228 0 +688 0.9388335296434021 1.080027491555599 0 +689 0.2902609242367211 1.092466405302242 0 +690 0.7097390757618164 1.092466405302733 0 +691 0.1921143744799669 1.439214249394353 0 +692 0.3688173944349879 1.101172545697751 0 +693 0.4708959074629217 1.255796333059937 0 +694 0.2104642353092421 1.366605532913096 0 +695 0.4956770080563517 1.176708192573298 0 +696 0.03544579990692806 1.31261815245473 0 +697 0.2906181420916345 1.800169314422933 0 +698 0.1826874667777417 1.923689544068806 0 +699 0.2788079446919697 1.723487117810183 0 +700 0.8954983700176242 1.316352287984157 0 +701 0.4065983848656299 1.021686330095798 0 +702 0.7469595602463371 1.307263741791362 0 +703 0.5350061574492293 1.019802261500719 0 +704 0.2732209111343161 1.923784880056412 0 +705 0.1642993460496607 1.139158603729777 0 +706 0.8357006539495735 1.139158603730439 0 +707 0.2450618270813173 1.020151332089083 0 +708 0.7549381729174609 1.020151332089197 0 +709 0.6778664241681795 1.288727433175952 0 +710 0.02321986608265446 1.053552581468502 0 +711 0.9767801339172393 1.053552581468754 0 +712 0.6637800237508615 1.019673250132107 0 +713 0.9648920616781493 1.285360057838596 0 +714 0.4700428252082163 1.061348707599324 0 +715 0.6959664684676375 1.25596411311435 0 +716 0.274336154868959 1.486857053664732 0 +717 0.859555809988204 1.70710620490268 0 +718 0.3948773504896747 1.729793310929485 0 +719 0.375459424328313 1.166833218046657 0 +720 0.6259729348091094 1.517232753959606 0 +721 0.1051207993864324 1.293982979665758 0 +722 0.1489963915488253 1.685718413104741 0 +723 0.12197099217751 1.102971434274687 0 +724 0.8780290078219228 1.102971434275165 0 +725 0.6224034537111914 1.168741878062297 0 +726 0.4782346811296834 1.457195269046559 0 +727 0.1916588275864359 1.153305401110045 0 +728 0.808341172412639 1.15330540111074 0 +729 0.8290715396551643 1.659912084697822 0 +730 0.2695777097337912 1.04623887496122 0 +731 0.7304222902648487 1.04623887496146 0 +732 0.3832988932168223 1.594890512279816 0 +733 0.23940255049482 1.176184851616829 0 +734 0.7605974495040165 1.17618485161771 0 +735 0.2997606355031102 1.114700265991839 0 +736 0.7002458984271072 1.114693200965817 0 +737 0.1350437084035231 1.054480564031925 0 +738 0.8649562915958616 1.054480564032177 0 +739 0.1535489845508016 1.042207986976496 0 +740 0.8464510154484944 1.042207986976704 0 +741 0.30901978967761 1.243605663149359 0 +742 0.3253416060451962 1.690207729830557 0 +743 0.5346068490343162 1.727438836572012 0 +744 0.02573684457220856 1.114825325769857 0 +745 0.9742631554277377 1.114825325770101 0 +746 0.8344175404560306 1.774396056578362 0 +747 0.1295299807760892 1.535211494863679 0 +748 0.9447800288308483 1.650953644708485 0 +749 0.0528581554567815 1.72193971791524 0 +750 0.0920474170988192 1.145470529203618 0 +751 0.9079525829010122 1.145470529204047 0 +752 0.2423443279418369 1.111699486614291 0 +753 0.7576556720569906 1.111699486614849 0 +754 0.6176178344116282 1.426428827483588 0 +755 0.4909462759205802 1.099217897989591 0 +756 0.2025650979701836 1.100066226241647 0 +757 0.7974349020288216 1.100066226242132 0 +758 0.2847081921562871 1.21287736086785 0 +759 0.8582753181417773 1.931742848137956 0 +760 0.07350146430712444 1.098180701794621 0 +761 0.9264985356925344 1.098180701795035 0 +762 0.2504804308953618 1.366429950529226 0 +763 0.1758405404669717 1.737825380517377 0 +764 0.4492771293794934 1.129927817775632 0 +765 0.3199551262486476 1.280932793007847 0 +766 0.6306615739083007 1.268997354379919 0 +767 0.1695619102620896 1.507805457993693 0 +768 0.206817653132825 1.068672067828947 0 +769 0.7931823468661675 1.068672067829293 0 +770 0.1388865773955359 1.141595002649761 0 +771 0.8611134226038619 1.141595002650475 0 +772 0.7264377386871367 1.698569524523234 0 +773 0.1462190433959284 1.23264913638115 0 +774 0.8539250492147981 1.232272956556789 0 +775 0.5327335382141311 1.53149462873611 0 +776 0.3312608165783479 1.080865103700489 0 +777 0.6709377155380395 1.081180031413402 0 +778 0.1038223262446245 1.434252626593483 0 +779 0.3957141263811421 1.446312390112534 0 +780 0.5423518164594813 1.045766800746079 0 +781 0.7656825601534485 1.576956265475083 0 +782 0.457771578467531 1.673756860525292 0 +783 0.1386052984819073 1.177774628988324 0 +784 0.8613947015174809 1.177774628989154 0 +785 0.03064047675698196 1.228422238228792 0 +786 0.9692984182498403 1.228560049614654 0 +787 0.3052929899393282 1.049468038574465 0 +788 0.6946611523550207 1.049539835347877 0 +789 0.9594770046973375 1.458433612853462 0 +790 0.1621524829917373 1.265857814480317 0 +791 0.9601012575361855 1.386569755895768 0 +792 0.2469316846177428 1.237495906239972 0 +793 0.4874058124764199 1.141762884680299 0 +794 0.4381852144054595 1.017579803230586 0 +795 0.7038379148887731 1.356190112030703 0 +796 0.1643546501515032 1.465369649396486 0 +797 0.3209782524407079 1.122529743021743 0 +798 0.03140041854011572 1.280975321460325 0 +799 0.6796548079837164 1.122455612933911 0 +800 0.8479028893300604 1.508397242784909 0 +801 0.781461123383506 1.500275373296001 0 +802 0.4017251044733837 1.069185231670215 0 +803 0.3639894499329577 1.0175308856422 0 +804 0.2110236677891623 1.52267675785457 0 +805 0.3352150220181531 1.932190367522508 0 +806 0.2215733283575031 1.151701975123256 0 +807 0.7784266716413957 1.151701975124007 0 +808 0.01732335881401268 1.017288754910273 0 +809 0.9826766411859112 1.017288754910306 0 +810 0.584113732952564 1.93468825658745 0 +811 0.1451124223790181 1.34394987548412 0 +812 0.5732117507522227 1.017266357000999 0 +813 0.1320485497884978 1.581379616183636 0 +814 0.7142250957385593 1.93436460746508 0 +815 0.1397577237023708 1.091389127401331 0 +816 0.86024227629698 1.091389127401738 0 +817 0.5477097286139612 1.613511529721244 0 +818 0.8964405404792415 1.384421660303715 0 +819 0.7592515402809309 1.766580445021483 0 +820 0.1027690986309362 1.06762285053724 0 +821 0.8972309013685922 1.067622850537532 0 +822 0.3379618690102277 1.460519758985365 0 +823 0.1230826102563555 1.01854899165203 0 +824 0.8769173897430907 1.018548991652111 0 +825 0.6184121476452416 1.561174626292751 0 +826 0.8475726314166462 1.33967925933898 0 +827 0.3686254642033712 1.251233838531329 0 +828 0.1266919706459415 1.375311365833281 0 +829 0.06703733796428706 1.230791447389639 0 +830 0.9329626620356544 1.230791447389813 0 +831 0.8873821998342596 1.285140734274467 0 +832 0.6492956341968291 1.724042238840412 0 +833 0.2634519459183526 1.265702117636851 0 +834 0.7149503558518808 1.317866633526652 0 +835 0.5648971388353405 1.56484162942942 0 +836 0.4920220431073269 1.066416542844554 0 +837 0.518743848235153 1.845046013291716 0 +838 0.4182798098737909 1.398915959212635 0 +839 0.7135276344933216 1.20471154674194 0 +840 0.08511963209959281 1.048630554699387 0 +841 0.9148803679000121 1.048630554699599 0 +842 0.598838162057048 1.016857355008949 0 +843 0.3518912447391224 1.158855316424406 0 +844 0.632848718998555 1.018019237482506 0 +845 0.6483547785703244 1.158869785269719 0 +846 0.5737288210390995 1.144659941374075 0 +847 0.02101200697820348 1.094540536350213 0 +848 0.9789879930218649 1.09454053635045 0 +849 0.2029274742840555 1.251949239728037 0 +850 0.3760438501018435 1.081615701034624 0 +851 0.914322897332451 1.444424363886258 0 +852 0.06805100739912706 1.186189790708724 0 +853 0.9319489926010983 1.186189790708768 0 +854 0.5855332095051125 1.794305260711012 0 +855 0.6343591332954933 1.048712883120502 0 +856 0.2849999999993101 1.017258406842087 0 +857 0.7149999999992493 1.017258406842185 0 +858 0.7383434752987191 1.424839730307673 0 +859 0.6752192673054986 1.470065968157034 0 +860 0.08779985109549458 1.017990595009571 0 +861 0.9122001489041109 1.017990595009649 0 +862 0.6528235302694242 1.344019306307661 0 +863 0.1779401265167148 1.599949870808794 0 +864 0.5546530607412045 1.211785712977279 0 +865 0.8513820751604271 1.406981107082139 0 +866 0.04382015169950791 1.551087075978233 0 +867 0.2181650277570157 1.29378777502682 0 +868 0.7974166745205853 1.378995107201303 0 +869 0.07988593648935285 1.323748565666345 0 +870 0.7524694856701515 1.620488599703033 0 +871 0.2962581360430431 1.547569635686735 0 +872 0.4498213345046592 1.082629396880051 0 +873 0.5196297092657058 1.093376025421895 0 +874 0.4419498980022703 1.043150271056709 0 +875 0.568994607856848 1.042535902853124 0 +876 0.3469588125728622 1.331561977430853 0 +877 0.5876260298347696 1.104478412772627 0 +878 0.6878392734148544 1.410049720542555 0 +879 0.5542603151278055 1.078691599257077 0 +880 0.03575722722513339 1.432550694825774 0 +881 0.4467439492385682 1.337612930504251 0 +882 0.5303350227773364 1.166447905910315 0 +883 0.6308753008142262 1.117392401627417 0 +884 0.9232142663124301 1.330128687280605 0 +885 0.05933028558700117 1.864080619328858 0 +886 0.08881770639590164 1.488004959293343 0 +887 0.3882498810844109 1.32456290900526 0 +888 0.8511990058120416 1.441908160647442 0 +889 0.9605570188934992 1.500063951422074 0 +890 0.1822317739143025 1.017639627022243 0 +891 0.8177682260848371 1.017639627022332 0 +892 0.9498142671274913 1.766645879759187 0 +893 0.1207035052929326 1.227768548161322 0 +894 0.8789687249328717 1.224221887760149 0 +895 0.4787621746340503 1.284659820698208 0 +896 0.6006810476486413 1.490735659225033 0 +897 0.3784552070524573 1.044138450055919 0 +898 0.218210089388379 1.566507426468412 0 +899 0.6790669877403435 1.685472310170668 0 +900 0.7391730172755183 1.492899891210004 0 +901 0.02334128481750834 1.201376189411586 0 +902 0.976658715182473 1.201376189411772 0 +903 0.4743238962420662 1.421210505449406 0 +904 0.1821973871908495 1.100805185223681 0 +905 0.8178026128082696 1.100805185224179 0 +906 0.4123510836380153 1.103987037352426 0 +907 0.7645780670357591 1.369536194853452 0 +908 0.8911502033818453 1.507417584351576 0 +909 0.7109396949484268 1.542688014463661 0 +910 0.5652829731956515 1.32051839191376 0 +911 0.05366620553673269 1.121810002453433 0 +912 0.9463337944630141 1.121810002453881 0 +913 0.421846259883653 1.780271626685188 0 +914 0.7282050099572057 1.259413370524345 0 +915 0.2214162017745438 1.197461024401772 0 +916 0.7809827444424337 1.199195793668273 0 +917 0.3750142522908606 1.199544322151415 0 +918 0.1845971709676333 1.177493123268267 0 +919 0.8154028290314971 1.17749312326909 0 +920 0.6333763331752649 1.857707707142758 0 +921 0.1915540986612671 1.398402789430784 0 +922 0.4225921849734932 1.624419298665114 0 +923 0.03387348846111227 1.015899485282361 0 +924 0.9661265115387395 1.01589948528242 0 +925 0.2231574639843962 1.045758009434277 0 +926 0.776842536014497 1.045758009434528 0 +927 0.2725398215141116 1.081257498476481 0 +928 0.7274601784845115 1.081257498476921 0 +929 0.287696081212362 1.156423926965742 0 +930 0.7108249566319291 1.158764699719963 0 +931 0.5916223512374552 1.133720606337292 0 +932 0.2350442647952174 1.652908866044909 0 +933 0.5855938306501858 1.380325120392519 0 +934 0.4715681724035449 1.581028291492537 0 +935 0.8418141408456581 1.259485989507131 0 +936 0.7643817999237927 1.231469244239164 0 +937 0.669995403316218 1.062889432440023 0 +938 0.1595310920820351 1.1885728417315 0 +939 0.8404689079172745 1.188572841732376 0 +940 0.625094108830086 1.199782092796714 0 +941 0.2717971273760793 1.314405739853056 0 +942 0.1871682298225736 1.645354373732688 0 +943 0.1173818456212346 1.034334607369009 0 +944 0.8826181543782377 1.034334607369173 0 +945 0.03189877589768881 1.371201856949706 0 +946 0.03770714788182898 1.477552960024035 0 +947 0.3072870723780685 1.349554356499209 0 +948 0.5608941264376373 1.108136705438094 0 +949 0.6127843368407898 1.314293660968488 0 +950 0.1669286053797976 1.116491127132817 0 +951 0.8330713946194106 1.116491127133367 0 +952 0.841011785908762 1.56825334772903 0 +953 0.1390729585363194 1.015384365982212 0 +954 0.8609270414630409 1.015384365982283 0 +955 0.408610396098658 1.136637931759814 0 +956 0.2727474957353982 1.427683775905435 0 +957 0.4222229175893341 1.016357806279581 0 +958 0.4671424346748636 1.042922357705219 0 +959 0.2126965781286911 1.016632798978344 0 +960 0.7873034218702811 1.016632798978436 0 +961 0.3558393601930892 1.386767720482331 0 +962 0.3005643706533258 1.19031282187702 0 +963 0.8773524753151363 1.812451963402752 0 +964 0.1715393775150516 1.07516201995467 0 +965 0.8284606224841315 1.07516201995504 0 +966 0.7848484138806036 1.434094363967352 0 +967 0.4896467260301543 1.016490847720485 0 +968 0.4090374695796062 1.039661421460267 0 +969 0.04785293513927573 1.039160660371534 0 +970 0.9521470648605014 1.039160660371717 0 +971 0.5192042285394238 1.01639104763949 0 +972 0.7107068551454572 1.796180889260681 0 +973 0.1162135326283688 1.181877349784169 0 +974 0.8837864673713693 1.18187734978523 0 +975 0.2499651433316649 1.329733935364252 0 +976 0.101530015081079 1.611563645251985 0 +977 0.3879863847654005 1.144518011207138 0 +978 0.2876017521159563 1.048751556567512 0 +979 0.7123982478825878 1.048751556567772 0 +980 0.6748264625287863 1.235425032416492 0 +981 0.30128234277826 1.01662504845527 0 +982 0.7676963624331639 1.328675880426054 0 +983 0.3293061123404644 1.062557840500174 0 +984 0.3319474162443696 1.195782095947593 0 +985 0.6676191774403487 1.196414102658601 0 +986 0.01603076109681405 1.037232906096547 0 +987 0.9839692389031077 1.037232906096625 0 +988 0.0237728167223666 1.155397808673102 0 +989 0.9762271832776999 1.15539780867335 0 +990 0.5796953554051784 1.072633604815174 0 +991 0.6023934233408159 1.033792643958504 0 +992 0.2636670648221204 1.162890432890539 0 +993 0.7363329351765793 1.162890432891376 0 +994 0.6393174594094391 1.242479804508066 0 +995 0.2577196191555046 1.125801657172263 0 +996 0.7422803808432327 1.125801657172915 0 +997 0.06925318001422347 1.015416076919484 0 +998 0.9307468199854646 1.015416076919555 0 +999 0.9693398153186322 1.357454839924715 0 +1000 0.4164151595852283 1.253874359707409 0 +1001 0.4278048029939758 1.468498876034178 0 +1002 0.3591906099290338 1.278158869810226 0 +1003 0.530204894573735 1.412213562155625 0 +1004 0.1906068062079785 1.039816657255773 0 +1005 0.8093931937911105 1.039816657255976 0 +1006 0.6614890112017699 1.503569819347941 0 +1007 0.08728436784372604 1.365199104903088 0 +1008 0.6285051988883447 1.034436664346815 0 +1009 0.6127499493739298 1.144056294141511 0 +1010 0.5630892057169667 1.283066295016315 0 +1011 0.420061208438303 1.282443376695496 0 +1012 0.6486233908940694 1.015782496410471 0 +1013 0.2392160293569889 1.496598062407582 0 +1014 0.7636850866090904 1.284514689735623 0 +1015 0.09280397515413977 1.11444210765936 0 +1016 0.9071960248453916 1.114442107659803 0 +1017 0.3908298290229613 1.296473534928996 0 +1018 0.3570969256837546 1.513787243780693 0 +1019 0.4937145947038362 1.119776222429542 0 +1020 0.3011417699143227 1.417335682079365 0 +1021 0.535852822695271 1.274640122608464 0 +1022 0.6994729783965448 1.187941200321058 0 +1023 0.6992454682576172 1.016634976191159 0 +1024 0.7543715370226114 1.859974057558124 0 +1025 0.52213598020332 1.32102277528815 0 +1026 0.4984882904558169 1.338154690025477 0 +1027 0.453042611509742 1.941634900706103 0 +1028 0.5317434507261012 1.14349089166425 0 +1029 0.07576651641425737 1.417638095801315 0 +1030 0.9610217559471596 1.574479236630343 0 +1031 0.1604917762563934 1.213202960246828 0 +1032 0.8393358742972696 1.213012715060642 0 +1033 0.2533043276454702 1.095272315543577 0 +1034 0.7466956723533112 1.095272315544064 0 +1035 0.2051791141809452 1.137452636653062 0 +1036 0.7948208858180859 1.137452636653693 0 +1037 0.4764212749072455 1.788568293079991 0 +1038 0.5183443969227232 1.068965302220556 0 +1039 0.2588864111108916 1.189057439459088 0 +1040 0.7411135888878539 1.189057439460056 0 +1041 0.6092676172239896 1.285168890166481 0 +1042 0.6605249056169841 1.037289440931298 0 +1043 0.08002756883388029 1.206142615735062 0 +1044 0.9199724311664677 1.206142615735259 0 +1045 0.09255756052184733 1.033764991064498 0 +1046 0.9074424394777344 1.033764991064648 0 +1047 0.2554401950341439 1.058463570059767 0 +1048 0.744559804964575 1.058463570060075 0 +1049 0.9092071797876939 1.560598448136613 0 +1050 0.1311875568177489 1.944127962111655 0 +1051 0.4552236224512686 1.014850753853796 0 +1052 0.0292818724631451 1.342011367700425 0 +1053 0.3729537025080666 1.121835884452202 0 +1054 0.4240391690753835 1.169071485835996 0 +1055 0.4908120604233604 1.709691052377504 0 +1056 0.0950333449551794 1.168642583115016 0 +1057 0.9049666550448063 1.168642583115446 0 +1058 0.2160518152260851 1.814661904713744 0 +1059 0.55567518745793 1.014397568857115 0 +1060 0.344624197812278 1.040238710609723 0 +1061 0.04697726977973533 1.157456826726417 0 +1062 0.5101785563923218 1.239416087560102 0 +1063 0.9530227302203623 1.157456826726629 0 +1064 0.5774768754272473 1.16841610755576 0 +1065 0.4496231757060124 1.17040906319534 0 +1066 0.1104091998713541 1.205009845943742 0 +1067 0.8895908001287585 1.205009845944253 0 +1068 0.4699642066362467 1.491426532187457 0 +1069 0.4069941249805112 1.852659895008483 0 +1070 0.4351062845121629 1.21024686095713 0 +1071 0.8078474282445104 1.86196677252668 0 +1072 0.3962311796043581 1.373538074038283 0 +1073 0.6426834915883372 1.373191361642871 0 +1074 0.3206507348510015 1.603280990226957 0 +1075 0.589945325313159 1.456824413013083 0 +1076 0.9751811035022794 1.259113773789341 0 +1077 0.1176502788948742 1.059261450855904 0 +1078 0.882349721104576 1.059261450856158 0 +1079 0.08960154393460185 1.5247868019029 0 +1080 0.3617487314489472 1.43706916597798 0 +1081 0.01672564688097562 1.134098993152536 0 +1082 0.9832743531190394 1.134098993152721 0 +1083 0.1964018427018784 1.310704454554017 0 +1084 0.03864703065873284 1.059921518824767 0 +1085 0.9613529693410905 1.059921518825047 0 +1086 0.4534559287543344 1.884793343662517 0 +1087 0.04698705756953726 1.778070073464848 0 +1088 0.06237605580063066 1.141360655307879 0 +1089 0.9376239441990379 1.141360655308076 0 +1090 0.06891141872568582 1.04683203206937 0 +1091 0.9310885812739933 1.04683203206959 0 +1092 0.4736314826835565 1.32540770122966 0 +1093 0.06703082981185354 1.27105185563872 0 +1094 0.9327811214695709 1.269073793312503 0 +1095 0.6021373889833467 1.699828213200178 0 +1096 0.5584707826822748 1.132469266243076 0 +1097 0.863488528217939 1.378352110216156 0 +1098 0.2902117698043898 1.26033299790055 0 +1099 0.5011931542425805 1.040130698839658 0 +1100 0.2365098776918482 1.080115166220042 0 +1101 0.7634901223069654 1.080115166220452 0 +1102 0.04440309113455441 1.656832720451006 0 +1103 0.9264789138049752 1.394642416693109 0 +1104 0.2591182893134713 1.015108001587667 0 +1105 0.7408817106852218 1.015108001587754 0 +1106 0.6532594277221753 1.278453077011473 0 +1107 0.7006787139208592 1.230088738061946 0 +1108 0.4307488462440198 1.071913306297576 0 +1109 0.5038756623246924 1.199140274258191 0 +1110 0.5144832785213653 1.288881941804271 0 +1111 0.8570624818758337 1.280462041411847 0 +1112 0.2622766136635372 1.219335751676736 0 +1113 0.5059361000286065 1.616606751512862 0 +1114 0.02435229388447152 1.260437274686242 0 +1115 0.1514987515658174 1.399072558371672 0 +1116 0.6435069330559549 1.09827329187248 0 +1117 0.4013790429946008 1.50429808815484 0 +1118 0.5448537626758532 1.182577725348483 0 +1119 0.3502748759863072 1.014715868918223 0 +1120 0.2271625550769119 1.723464227730544 0 +1121 0.1680780570161887 1.014768798196081 0 +1122 0.8319219429830211 1.014768798196153 0 +1123 0.01612157377241585 1.068583287858511 0 +1124 0.9838784262275513 1.068583287858851 0 +1125 0.2107888131967949 1.03422457922024 0 +1126 0.7892111868021889 1.034224579220399 0 +1127 0.170077575570412 1.306890007245519 0 +1128 0.96446725914928 1.61489265528045 0 +1129 0.6171282442080105 1.633952939785105 0 +1130 0.1392455552605454 1.072264392394617 0 +1131 0.860754444738809 1.072264392394939 0 +1132 0.4673730393193751 1.141346674094104 0 +1133 0.08037730913511788 1.08525360001454 0 +1134 0.9196226908645516 1.085253600014918 0 +1135 0.5392374691044528 1.499917124911838 0 +1136 0.500507661967947 1.366415948825976 0 +1137 0.1310993912053274 1.284183979150925 0 +1138 0.6081506402700735 1.0603398946826 0 +1139 0.3450952957259867 1.094396680620111 0 +1140 0.2632140217185417 1.622803503307088 0 +1141 0.3206098558574353 1.156322140155059 0 +1142 0.6795105079739993 1.154868186584574 0 +1143 0.8164463568610144 1.349341624818541 0 +1144 0.5816697939685267 1.202504989059667 0 +1145 0.1070712199643722 1.244307087377708 0 +1146 0.8946770858769926 1.244995448867616 0 +1147 0.1188463134212067 1.789037814288943 0 +1148 0.9752126980741912 1.312250835241471 0 +1149 0.3279377418496755 1.014324132417214 0 +1150 0.118332750746222 1.322568619377422 0 +1151 0.1142640479385176 1.655496233638815 0 +1152 0.3940631572554494 1.014085361485176 0 +1153 0.6362795954503547 1.064890646902633 0 +1154 0.5781750259494849 1.248757073254238 0 +1155 0.6899237412610107 1.037639851017039 0 +1156 0.9692231032428993 1.418428702300109 0 +1157 0.2304244292351013 1.01636421293752 0 +1158 0.7695755707637636 1.01636421293761 0 +1159 0.1689714021005658 1.047917782443216 0 +1160 0.8310285978986405 1.047917782443464 0 +1161 0.2767735740689962 1.850697146275869 0 +1162 0.6662215974524117 1.307727800873085 0 +1163 0.5989350359323878 1.236912426522421 0 +1164 0.6676365819098316 1.102130322639346 0 +1165 0.6798484832125943 1.583346017391035 0 +1166 0.9547485371468434 1.871469203552564 0 +1167 0.2970493465702064 1.081238828120493 0 +1168 0.7029506534282867 1.081238828120929 0 +1169 0.4225415884448154 1.534920512767768 0 +1170 0.2227219391655229 1.436259376331281 0 +1171 0.3725541286571634 1.705262112799084 0 +1172 0.03446271388088232 1.588527085831263 0 +1173 0.3951821133074684 1.245125964478851 0 +1174 0.7350046788939972 1.21459751859619 0 +1175 0.4366236914300083 1.241875069126993 0 +1176 0.3336053944597156 1.307315401918199 0 +1177 0.3101880276316399 1.037617782732386 0 +1178 0.3366855792099399 1.795581428929004 0 +1179 0.1084216317660207 1.084916405064285 0 +1180 0.8915783682334816 1.084916405064652 0 +1181 0.4343910849675152 1.69991290490074 0 +1182 0.4759932499312994 1.232707875168285 0 +1183 0.4119728001697494 1.082816303704818 0 +1184 0.5581381923059603 1.233668049754009 0 +1185 0.1827695075909666 1.855632524965281 0 +1186 0.4115711164955508 1.339620902518397 0 +1187 0.8997870444010682 1.622090952459767 0 +1188 0.1298202732700994 1.452968090907417 0 +1189 0.5303625628932096 1.250765945842498 0 +1190 0.3262307633193099 1.229225940268823 0 +1191 0.4686630715451836 1.101432200957633 0 +1192 0.4781386790132462 1.381890160445526 0 +1193 0.8025475828857709 1.571731018726347 0 +1194 0.5982484843677046 1.214893986131703 0 +1195 0.5071280938487064 1.134522290227878 0 +1196 0.9521967649206859 1.945125779974887 0 +1197 0.208946054927438 1.087734952362177 0 +1198 0.7910539450715237 1.0877349523626 0 +1199 0.5454445087416474 1.693807004503302 0 +1200 0.04425590105703177 1.087112571068343 0 +1201 0.9557440989427626 1.08711257106872 0 +1202 0.4348713832640062 1.105130020306964 0 +1203 0.1212387324129834 1.410725387443975 0 +1204 0.8748081708171568 1.332494210010687 0 +1205 0.531701500824432 1.949440570608314 0 +1206 0.1905644263512034 1.220225003028779 0 +1207 0.8114543953925862 1.221038415210947 0 +1208 0.5838233149909822 1.01346723817484 0 +1209 0.8948030020751232 1.697460265348612 0 +1210 0.3854086562146177 1.062799568064158 0 +1211 0.1058513327249278 1.703989972331406 0 +1212 0.2378974128992069 1.129832306194317 0 +1213 0.7621025870996405 1.129832306194978 0 +1214 0.3508166508861011 1.130810142089118 0 +1215 0.223501475636426 1.241876441706235 0 +1216 0.03990967374134053 1.694053066877621 0 +1217 0.1285763858643799 1.129429057654668 0 +1218 0.8714236141350802 1.129429057655287 0 +1219 0.6470098631159311 1.131224790135127 0 +1220 0.3869221786982499 1.107016953422077 0 +1221 0.5338857487059122 1.107989197217155 0 +1222 0.594259816424455 1.412340834705424 0 +1223 0.08097562939594526 1.244007189079537 0 +1224 0.9203040709736917 1.242973931036239 0 +1225 0.7312975847315546 1.466502539877618 0 +1226 0.3768371532388788 1.771926153656685 0 +1227 0.3851744991021436 1.63534160915883 0 +1228 0.6672818104517914 1.646693033572066 0 +1229 0.06844028229426127 1.065025969133274 0 +1230 0.9315597177054284 1.065025969133579 0 +1231 0.2976136708814533 1.225253262659552 0 +1232 0.2324365785646558 1.956645751796542 0 +1233 0.8076261185975664 1.949514482014995 0 +1234 0.5272970932159979 1.054967731944338 0 +1235 0.7398596297786042 1.281761775878691 0 +1236 0.6749558891658085 1.013560677437725 0 +1237 0.6088770878552974 1.102815819193598 0 +1238 0.5475695392382699 1.345764172627341 0 +1239 0.3315603475102415 1.104054958468724 0 +1240 0.2576233010837896 1.68680344282223 0 +1241 0.1974623474063127 1.195582362239602 0 +1242 0.8026290130081681 1.195631105010289 0 +1243 0.4485117697187572 1.370204681587779 0 +1244 0.3974036243935294 1.17528784972531 0 +1245 0.6180052055277383 1.248862935485071 0 +1246 0.3781005450341657 1.013278222746576 0 +1247 0.8932980850819866 1.94991634803484 0 +1248 0.2551066866345831 1.030786767446896 0 +1249 0.7448933133641282 1.030786767447065 0 +1250 0.2950093327238816 1.763759658062241 0 +1251 0.9077064765402743 1.354067237478569 0 +1252 0.4864383754210707 1.08646762422074 0 +1253 0.2811006527517921 1.034299794402836 0 +1254 0.7189062356839639 1.034315781362493 0 +1255 0.5325855615335903 1.083191867795916 0 +1256 0.5968207119303641 1.359082961686952 0 +1257 0.5855577491076152 1.327815823573339 0 +1258 0.4920234116599588 1.157294782650777 0 +1259 0.7968434960206228 1.77173407237564 0 +1260 0.2697006728666986 1.064555284921215 0 +1261 0.7302993271319501 1.064555284921558 0 +1262 0.2638894904382683 1.579297994558265 0 +1263 0.285125205610623 1.367059530435991 0 +1264 0.8080681840712355 1.686980391860552 0 +1265 0.1988360824370556 1.346371187157398 0 +1266 0.2210868364101463 1.107660533742082 0 +1267 0.7789131635887757 1.107660533742606 0 +1268 0.3477480826867645 1.358460883125359 0 +1269 0.5441630848075065 1.034228557501702 0 +1270 0.2957062757016458 1.301996665259004 0 +1271 0.2373735526417196 1.033470287641567 0 +1272 0.7626264473571078 1.033470287641752 0 +1273 0.7432849730992642 1.238466666660619 0 +1274 0.7655354323486602 1.705088640507602 0 +1275 0.3104792744560319 1.481964609942909 0 +1276 0.552275115096119 1.448808372931466 0 +1277 0.5414872493534836 1.900237630178375 0 +1278 0.561876305326539 1.763381288632418 0 +1279 0.6745564396241781 1.03143545053497 0 +1280 0.5296842038708257 1.380796159560034 0 +1281 0.7811289864350623 1.543394073796156 0 +1282 0.5514227985736257 1.830867943066162 0 +1283 0.499092151846725 1.751543856082354 0 +1284 0.698926949137658 1.304106306903707 0 +1285 0.4540711508408158 1.049815452939203 0 +1286 0.1824119709117939 1.260697355657497 0 +1287 0.1964425640817918 1.060976065928913 0 +1288 0.803557435917259 1.060976065929218 0 +1289 0.9462244609740303 1.303789785276324 0 +1290 0.6424553026566601 1.328161558121473 0 +1291 0.6064799172631002 1.176318138502318 0 +1292 0.7980359198812659 1.281264115151046 0 +1293 0.4019039525756251 1.215844002663783 0 +1294 0.799990899530184 1.324653649285214 0 +1295 0.3018041839316535 1.1703078363915 0 +1296 0.2749849291949251 1.014037084654936 0 +1297 0.7250150708036864 1.014037084655016 0 +1298 0.9205823767806327 1.513861697064001 0 +1299 0.03558660959702013 1.045698919450772 0 +1300 0.9644133904028299 1.045698919450992 0 +1301 0.1538317161502786 1.082755103213785 0 +1302 0.8461682838489977 1.082755103214174 0 +1303 0.3416340672056184 1.072936402756499 0 +1304 0.5570794333549717 1.167023806777678 0 +1305 0.8111935379353494 1.505449894896943 0 +1306 0.3368801009114792 1.173285988831283 0 +1307 0.8159573031906487 1.260186624811216 0 +1308 0.3664748224067241 1.879783841642942 0 +1309 0.6632549853008139 1.173048695517503 0 +1310 0.5809876230090266 1.045135940485993 0 +1311 0.3835712702538189 1.953552580776986 0 +1312 0.2266364801947291 1.354192187973581 0 +1313 0.2788015096627693 1.117916702394729 0 +1314 0.721198490335866 1.117916702395343 0 +1315 0.5208465880537497 1.212421849634813 0 +1316 0.837463829767092 1.626479860315993 0 +1317 0.5493451930918662 1.062889936150788 0 +1318 0.06232682554474273 1.033603828122874 0 +1319 0.9376731744549724 1.033603828123033 0 +1320 0.8303159237440187 1.823404142090441 0 +1321 0.6290557105190713 1.756878716622504 0 +1322 0.1954167111353211 1.010625940397088 0 +1323 0.8045832888637392 1.01062594039714 0 +1324 0.2055804492321563 1.119950622236444 0 +1325 0.7944195507668509 1.119950622237036 0 +1326 0.7881231338227134 1.458995167237009 0 +1327 0.06627932221822729 1.380967099540743 0 +1328 0.6766623623309993 1.442153706001752 0 +1329 0.4919175654574046 1.030281002704754 0 +1330 0.8343708105342499 1.304370391104469 0 +1331 0.9121450963689021 1.419349345451634 0 +1332 0.5105999368907171 1.423504044893142 0 +1333 0.6569057044723534 1.070379030552191 0 +1334 0.802338556606096 1.238211395778497 0 +1335 0.6970671169175946 1.163463418671204 0 +1336 0.231187807851162 1.224460978449169 0 +1337 0.3262454577867037 1.032784405252578 0 +1338 0.7326059697824412 1.371109073786136 0 +1339 0.393536995428678 1.034289729464825 0 +1340 0.3601191962050916 1.050639404155833 0 +1341 0.5058124497111409 1.097299906122886 0 +1342 0.6874166110571479 1.891601714653192 0 +1343 0.05567537089012627 1.178618114630763 0 +1344 0.9443246291099983 1.178618114630873 0 +1345 0.1484757769158896 1.158041713811067 0 +1346 0.8515242230834029 1.158041713811824 0 +1347 0.428213491074337 1.0468994561553 0 +1348 0.7573304234267674 1.951734240410933 0 +1349 0.5145540346942643 1.170119558743787 0 +1350 0.9011775312106528 1.866074137513676 0 +1351 0.9636567588267799 1.681512133762253 0 +1352 0.3170323106081283 1.262907739964797 0 +1353 0.9592273235099233 1.736967063163039 0 +1354 0.6563831445931259 1.39682051025599 0 +1355 0.4186121358867979 1.199876470381781 0 +1356 0.4135217584530143 1.424818262948549 0 +1357 0.2390356803107166 1.057348146646894 0 +1358 0.760964319688089 1.057348146647204 0 +1359 0.4577019289232521 1.279764572910742 0 +1360 0.504994865789132 1.008730706005746 0 +1361 0.8235213169400097 1.39483121054813 0 +1362 0.1091560533704775 1.143778124737088 0 +1363 0.8908439466292198 1.143778124737719 0 +1364 0.1122239274870524 1.271353930843264 0 +1365 0.5980269648593466 1.072577695503483 0 +1366 0.3721695815631691 1.0296019928432 0 +1367 0.1782870773589796 1.138113414804288 0 +1368 0.8217129226401865 1.138113414804914 0 +1369 0.9077045412438723 1.285342661599792 0 +1370 0.3547587411296007 1.242734551226264 0 +1371 0.781309978768695 1.633019535872545 0 +1372 0.3756458429560244 1.566089563723524 0 +1373 0.1622245164869955 1.416091382791415 0 +1374 0.6787206475367338 1.349663720382962 0 +1375 0.4480193009228002 1.197839780311325 0 +1376 0.2211602872128621 1.07827693169737 0 +1377 0.7788397127860359 1.078276931697751 0 +1378 0.4277147122316601 1.140120387918699 0 +1379 0.3125054059005411 1.63616681540862 0 +1380 0.4520191600589123 1.462413316353598 0 +1381 0.4780912759175534 1.176399487714507 0 +1382 0.4552471842362025 1.070927048475333 0 +1383 0.09948904966319957 1.467316327520788 0 +1384 0.01673059310966755 1.17795735871048 0 +1385 0.983269406890404 1.177957358710483 0 +1386 0.5245238935145241 1.472368380963238 0 +1387 0.04931199799953665 1.069359224603661 0 +1388 0.9506880020002355 1.069359224603994 0 +1389 0.6981477076797283 1.611153637015575 0 +1390 0.6160160546197366 1.96334948232346 0 +1391 0.1116460558047521 1.012727116874489 0 +1392 0.8883539441947464 1.012727116874542 0 +1393 0.7136699046471631 1.417797386501919 0 +1394 0.460621788231202 1.247883901503063 0 +1395 0.7911884271444105 1.40758209260233 0 +1396 0.206014605607537 1.276440389924756 0 +1397 0.7789529625096036 1.240532917965696 0 +1398 0.963963837467823 1.8119075273891 0 +1399 0.6963203486421858 1.477910174755796 0 +1400 0.3578535292272713 1.065855914913647 0 +1401 0.8825475330044039 1.449269539741745 0 +1402 0.3332063783061395 1.539846641249134 0 +1403 0.4468155443447985 1.601477710782173 0 +1404 0.6977993447283805 1.378783191223039 0 +1405 0.6321611182588698 1.083026541081841 0 +1406 0.08475757031901335 1.7655707381442 0 +1407 0.2162733233479228 1.056705987473216 0 +1408 0.7837266766510161 1.056705987473511 0 +1409 0.5923200487370578 1.556282133788927 0 +1410 0.5024140405504284 1.523825017410743 0 +1411 0.6755367480429364 1.95500418874565 0 +1412 0.585302376318118 1.275309169700233 0 +1413 0.04611372998506449 1.953669509922682 0 +1414 0.04166467767575872 1.834625112014256 0 +1415 0.09841948698576948 1.013789090993405 0 +1416 0.9015805130137871 1.013789090993464 0 +1417 0.5855988532257326 1.184214798487958 0 +1418 0.6138771557322263 1.084598032433125 0 +1419 0.07961535751714653 1.173717697897167 0 +1420 0.9203846424829583 1.173717697897389 0 +1421 0.09388964622270515 1.848787072349182 0 +1422 0.681362068123701 1.269051519939747 0 +1423 0.02428973759383199 1.392908134080392 0 +1424 0.682753430852495 1.054979335546691 0 +1425 0.7398588050883511 1.567982920576331 0 +1426 0.2970532175716006 1.333045997602025 0 +1427 0.1284600707858684 1.046254798064075 0 +1428 0.8715399292135432 1.046254798064293 0 +1429 0.5168568859220658 1.027008046865808 0 +1430 0.9633930985562648 1.53005178443705 0 +1431 0.6231848415916569 1.132747412065687 0 +1432 0.9788476593800917 1.330724498042673 0 +1433 0.06073211795988133 1.314268968512277 0 +1434 0.6260720988444692 1.591183241630014 0 +1435 0.04695621898392609 1.012111627343555 0 +1436 0.9530437810158643 1.012111627343613 0 +1437 0.1616284138052639 1.034884911568204 0 +1438 0.83837158619398 1.034884911568383 0 +1439 0.09580254503612032 1.056461271427961 0 +1440 0.9041974549634397 1.056461271428206 0 +1441 0.2552362926413267 1.395397171510955 0 +1442 0.4096927472559348 1.119063817267025 0 +1443 0.293202913333349 1.135091014830442 0 +1444 0.7069751894164503 1.133220292464311 0 +1445 0.8331008013979837 1.741656084893487 0 +1446 0.8840985947546303 1.579137515525924 0 +1447 0.1576505431476743 1.286866874756793 0 +1448 0.2493636691849785 1.801397597213157 0 +1449 0.3007747224298952 1.388205626986782 0 +1450 0.6249126720443516 1.055228272493474 0 +1451 0.5245831136724286 1.127530746859052 0 +1452 0.4319722470154369 1.299030650305157 0 +1453 0.8152025288711811 1.298194439240769 0 +1454 0.6020275023164409 1.050632415683287 0 +1455 0.2930272818319186 1.519316926125008 0 +1456 0.2736462654256175 1.46293010667262 0 +1457 0.7477661082389266 1.396276428289809 0 +1458 0.6293339109123771 1.409732051951666 0 +1459 0.1467675717146781 1.103209049996413 0 +1460 0.8532324282846437 1.103209049996887 0 +1461 0.2279519509102736 1.900101356531651 0 +1462 0.04971231698788624 1.294674114228781 0 +1463 0.8161323101772073 1.894134978752443 0 +1464 0.02824321091941144 1.90522157223009 0 +1465 0.01251764000915863 1.081167122030712 0 +1466 0.9874823599908519 1.08116712203088 0 +1467 0.3573514508105886 1.204735398097151 0 +1468 0.6101994844752797 1.89158484380946 0 +1469 0.02986421501269721 1.526034951228734 0 +1470 0.6076933337046221 1.011758288400327 0 +1471 0.9022480465060874 1.47545467282981 0 +1472 0.09287835819600113 1.082004656801049 0 +1473 0.9071216418036011 1.082004656801392 0 +1474 0.3535865235252714 1.028554080739409 0 +1475 0.6227919001725752 1.012184237444334 0 +1476 0.7365937730613684 1.665025878513171 0 +1477 0.4546934202816162 1.150771076749163 0 +1478 0.6756512914733921 1.783768614804902 0 +1479 0.2995477013510898 1.691341743643306 0 +1480 0.4906731792194428 1.054580577395268 0 +1481 0.3095531183278268 1.083342866075611 0 +1482 0.6904308071550952 1.083323417675065 0 +1483 0.5857933833087164 1.08597193751518 0 +1484 0.4646630736744242 1.010345349191253 0 +1485 0.5408537266307083 1.201325656457649 0 +1486 0.533757626623247 1.648506234262048 0 +1487 0.9158391628949125 1.670876411698502 0 +1488 0.3565174970297745 1.598200949584769 0 +1489 0.08676635959908342 1.287654277814599 0 +1490 0.8459888141912867 1.466384825762305 0 +1491 0.6815667369032885 1.529040007280133 0 +1492 0.8244923932627786 1.448254199395507 0 +1493 0.318299252717366 1.054956464260293 0 +1494 0.1750115020139588 1.089024224567609 0 +1495 0.8249884979852232 1.089024224568065 0 +1496 0.1584066713738506 1.247562575349788 0 +1497 0.2422549531785792 1.281505114043959 0 +1498 0.1052260249087069 1.106327016353782 0 +1499 0.8947739750907995 1.106327016354175 0 +1500 0.3067763933482186 1.965264441618542 0 +1501 0.4765787160756468 1.2132007322945 0 +1502 0.1452540563411426 1.03493550768675 0 +1503 0.8547459436581925 1.034935507686917 0 +1504 0.02129122218746901 1.300114597018594 0 +1505 0.844164891391566 1.539297346778372 0 +1506 0.5464941772426861 1.011559249884041 0 +1507 0.5610535925381057 1.047895282995608 0 +1508 0.3010489353222427 1.102809645112322 0 +1509 0.6989320759405568 1.102767654274176 0 +1510 0.2986789950316274 1.063395561756023 0 +1511 0.7013210049668441 1.063395561756364 0 +1512 0.5924087500491066 1.118954460060622 0 +1513 0.7733382975903708 1.269950097542087 0 +1514 0.2468921135568173 1.427056266792553 0 +1515 0.3420236529420274 1.495810115680273 0 +1516 0.1465881506996409 1.764077409919087 0 +1517 0.9121270534322363 1.787919698068142 0 +1518 0.7433335745915791 1.82197183028254 0 +1519 0.1389339345907782 1.04300552206283 0 +1520 0.8610660654085909 1.043005522063034 0 +1521 0.3150593586492489 1.008025813751174 0 +1522 0.26301933091577 1.284528564474793 0 +1523 0.3647286479433904 1.663821609469348 0 +1524 0.3368200573122268 1.124412750615158 0 +1525 0.6656711582090921 1.124262857336009 0 +1526 0.07877081781676794 1.594231130553396 0 +1527 0.1354666642572639 1.825087714741606 0 +1528 0.1663598598539948 1.064867497559414 0 +1529 0.8336401401452118 1.064867497559731 0 +1530 0.08942809212583332 1.306601178871015 0 +1531 0.857529908056945 1.675565889334949 0 +1532 0.6418563263599547 1.203914341741455 0 +1533 0.01338650830518007 1.106972349329796 0 +1534 0.9866134916948553 1.106972349330005 0 +1535 0.1145807784841902 1.512353564030207 0 +1536 0.4887479985797444 1.240943879353358 0 +1537 0.3260686785797539 1.403099614383736 0 +1538 0.5561096398262423 1.091555582118914 0 +1539 0.6037040757391626 1.836589673903682 0 +1540 0.1581552711497942 1.323760706166316 0 +1541 0.01874304569024386 1.215191332205178 0 +1542 0.9811862769201648 1.21527031952507 0 +1543 0.4862117371378305 1.65516333561732 0 +1544 0.3112587971947582 1.720065956844191 0 +1545 0.637742300624771 1.444157149739842 0 +1546 0.1943459229343064 1.77441466636252 0 +1547 0.2810458619562471 1.101621369583768 0 +1548 0.7189541380423613 1.101621369584299 0 +1549 0.620528336291272 1.184452816143784 0 +1550 0.2356672419650671 1.160371051731645 0 +1551 0.7643327580337528 1.160371051732442 0 +1552 0.4058204976661204 1.057702585100289 0 +1553 0.7618680228798127 1.345883004305126 0 +1554 0.650999941311504 1.089969448461361 0 +1555 0.9502317721536241 1.352935894378699 0 +1556 0.5797844335601458 1.059177608524496 0 +1557 0.7303688500399934 1.73446820373542 0 +1558 0.3144191658558659 1.573557051281711 0 +1559 0.7207015213764739 1.514469598376777 0 +1560 0.1346307090920045 1.106201605560626 0 +1561 0.8653692909073718 1.106201605561103 0 +1562 0.6609267440178047 1.834666613928059 0 +1563 0.1181883349000979 1.903641729580386 0 +1564 0.9289275397207835 1.74102793980628 0 +1565 0.0330669587709776 1.102980605319288 0 +1566 0.9669330412289224 1.102980605319444 0 +1567 0.1418840339251989 1.511189420830781 0 +1568 0.6568629905312598 1.586363776375571 0 +1569 0.4759795406325346 1.033836516011811 0 +1570 0.07816277938700485 1.643354779596752 0 +1571 0.4559955475236971 1.116184535124403 0 +1572 0.4115001443294869 1.181050078636877 0 +1573 0.3789893566625959 1.279840405446548 0 +1574 0.06075176103110969 1.108632952307608 0 +1575 0.939248238968586 1.108632952308025 0 +1576 0.5111988585487603 1.045834148294043 0 +1577 0.4026722094848387 1.561434685963921 0 +1578 0.3562307443188961 1.407866265365277 0 +1579 0.4191721287984816 1.153675025368597 0 +1580 0.9792444659793228 1.438593033278843 0 +1581 0.4323219589611959 1.41351019326556 0 +1582 0.08792983002350216 1.131181013004555 0 +1583 0.91207016997618 1.131181013004916 0 +1584 0.1783258219317796 1.356963783664116 0 +1585 0.04324426086459452 1.185776142796404 0 +1586 0.9567557391355163 1.18577614279659 0 +1587 0.154740114872336 1.008021161127617 0 +1588 0.8452598851269455 1.008021161127652 0 +1589 0.6987464304884959 1.272977936042692 0 +1590 0.9148005468749716 1.312045861390605 0 +1591 0.8787694624623098 1.394168887995288 0 +1592 0.3201483001244542 1.137872298075531 0 +1593 0.4936174623866023 1.269627265360317 0 +1594 0.4826470803606446 1.190158823603414 0 +1595 0.6801416026413017 1.138541929336917 0 +1596 0.4168781002614067 1.817699461124223 0 +1597 0.4155725014209651 1.074248816966523 0 +1598 0.0117552071147949 1.048466678824575 0 +1599 0.9882447928851199 1.048466678824712 0 +1600 0.2385352210663191 1.092793607233794 0 +1601 0.7614647789325154 1.092793607234259 0 +1602 0.3444341586977429 1.828757709742545 0 +1603 0.7730650107450523 1.214810497588176 0 +1604 0.731060578609976 1.893701218237031 0 +1605 0.2258311664530152 1.382944693234825 0 +1606 0.1495767527455916 1.131431570479477 0 +1607 0.8504232472537612 1.131431570480128 0 +1608 0.4446825211947514 1.033119963312767 0 +1609 0.04954565825564744 1.220770452212206 0 +1610 0.9504441575788505 1.220793420776711 0 +1611 0.3609770846955486 1.113104704290984 0 +1612 0.5606282635731242 1.361501975399593 0 +1613 0.2079996040968948 1.411386678035299 0 +1614 0.1618416820970086 1.578071432803962 0 +1615 0.04062386767576311 1.115679418172515 0 +1616 0.9593761323240534 1.115679418172818 0 +1617 0.4435244708936735 1.11650327031105 0 +1618 0.175534804777607 1.704895030586384 0 +1619 0.5729504416268045 1.398315542564204 0 +1620 0.2290228098683907 1.308873262282221 0 +1621 0.3259464329783126 1.337244115632636 0 +1622 0.2064978002433709 1.159152844078602 0 +1623 0.793502199755626 1.159152844079351 0 +1624 0.4382413881497792 1.646680487263044 0 +1625 0.06089959888436646 1.096296802371878 0 +1626 0.9391004011153534 1.096296802372278 0 +1627 0.06425719973477335 1.47811437172569 0 +1628 0.3710676634156111 1.183766791295809 0 +1629 0.3363422712871743 1.157778222641568 0 +1630 0.1610069459156927 1.651374550326023 0 +1631 0.4478908755373141 1.528303722517505 0 +1632 0.9839231783189639 1.243276898733598 0 +1633 0.6453982566274626 1.044479911447842 0 +1634 0.9385967721430639 1.445651244910694 0 +1635 0.4049999999989607 1.010325669332425 0 +1636 0.1473492238489656 1.054027230884211 0 +1637 0.8526507761503666 1.054027230884472 0 +1638 0.3940102133418256 1.351778383582751 0 +1639 0.4760247380804355 1.072194522047131 0 +1640 0.8852028059929484 1.266529568120554 0 +1641 0.4416203057786958 1.093516402057662 0 +1642 0.6636782758597186 1.157563453717568 0 +1643 0.9614976357608271 1.907767582905676 0 +1644 0.5760875050384048 1.62603232124672 0 +1645 0.8773866561344099 1.305139728250962 0 +1646 0.9826090494749027 1.275987708963745 0 +1647 0.3403614053517528 1.011517601636396 0 +1648 0.5477421929065333 1.112128814973993 0 +1649 0.5663653936319523 1.073750528243041 0 +1650 0.1083900479288564 1.364805882705171 0 +1651 0.02987665745149662 1.614416037580508 0 +1652 0.3391315209494828 1.27624315923744 0 +1653 0.1493400074749239 1.72255288215618 0 +1654 0.04246079629601342 1.028053921286899 0 +1655 0.9575392037037957 1.028053921287022 0 +1656 0.5664840037456682 1.031470476004189 0 +1657 0.3873002757682726 1.081246655985661 0 +1658 0.07568757025257022 1.054997260558172 0 +1659 0.9243124297470806 1.054997260558419 0 +1660 0.07932143985782369 1.011673816469576 0 +1661 0.920678560141821 1.011673816469627 0 +1662 0.1879403487172224 1.028375997008667 0 +1663 0.8120596512818856 1.028375997008808 0 +1664 0.2291810379992018 1.459215296149387 0 +1665 0.3219486276012629 1.443440418391772 0 +1666 0.6199585669476186 1.109077260294253 0 +1667 0.1021199732966851 1.03491419026822 0 +1668 0.8978800267028566 1.034914190268374 0 +1669 0.7185416726362968 1.339484131299576 0 +1670 0.3023369799534296 1.274879158863818 0 +1671 0.6636110242490182 1.047796247356454 0 +1672 0.01596239100049949 1.243393822479002 0 +1673 0.7141721551714876 1.249119212650614 0 +1674 0.5032942195011828 1.4596582193332 0 +1675 0.9497587152274398 1.270916397068575 0 +1676 0.5380266210029309 1.316610217892344 0 +1677 0.8734803688066715 1.894713121260277 0 +1678 0.3615147625178329 1.093324921907372 0 +1679 0.2635268253303262 1.036544177860199 0 +1680 0.7364731746683402 1.036544177860393 0 +1681 0.3108839341183536 1.904413000187354 0 +1682 0.4962528747428769 1.961032716164873 0 +1683 0.2590993993591028 1.885302552045916 0 +1684 0.4153848228197968 1.592578696140905 0 +1685 0.5643077910258467 1.717451905003975 0 +1686 0.4342278299860741 1.320773040629483 0 +1687 0.6709619065651022 1.212217460684311 0 +1688 0.3991613327593835 1.470540322840005 0 +1689 0.1650556980539425 1.884492126577331 0 +1690 0.4976139725229419 1.553004764708679 0 +1691 0.7296038013271215 1.29786690671069 0 +1692 0.1868074093375889 1.459137669500813 0 +1693 0.8702726182204868 1.627551034319364 0 +1694 0.223689984529217 1.182484164540328 0 +1695 0.7756114334631499 1.185650017080701 0 +1696 0.2612784195375845 1.140051981112966 0 +1697 0.7387215804611251 1.140051981113688 0 +1698 0.1261511812497802 1.089691626141032 0 +1699 0.8738488187496458 1.08969162614144 0 +1700 0.2359484217714043 1.045443145223011 0 +1701 0.7640515782274224 1.045443145223259 0 +1702 0.1686268695969757 1.441026054663444 0 +1703 0.6844186657385044 1.009174928573805 0 +1704 0.131924221922249 1.239018105148526 0 +1705 0.8705361523540117 1.237814505868862 0 +1706 0.4797977074956976 1.054205962947559 0 +1707 0.4811330023484638 1.012009632641965 0 +1708 0.07795727497581416 1.139337367599855 0 +1709 0.9220427250239228 1.139337367599872 0 +1710 0.05821383211572706 1.011759534039748 0 +1711 0.941786167884012 1.011759534039806 0 +1712 0.04917293455488167 1.331799577707842 0 +1713 0.4601970602426647 1.440229817929107 0 +1714 0.04893286990602787 1.271637590800177 0 +1715 0.6359324003533627 1.219892476233232 0 +1716 0.2738614356296792 1.095130728617688 0 +1717 0.7261385643689789 1.095130728618176 0 +1718 0.3105539960236046 1.112797113469678 0 +1719 0.5016014819810687 1.070136473007622 0 +1720 0.02322850060454679 1.457495002737063 0 +1721 0.0109972683052967 1.01099945954156 0 +1722 0.9890027316946527 1.010999459541614 0 +1723 0.7374134245399585 1.321824765953971 0 +1724 0.3820898034075261 1.095570020516798 0 +1725 0.1867452764643828 1.069925629010018 0 +1726 0.8132547235347162 1.069925629010368 0 +1727 0.475593715474494 1.306540168075893 0 +1728 0.6217384907478309 1.36509156942236 0 +1729 0.3373347310416704 1.049338378076901 0 +1730 0.3642837198023857 1.22141463529862 0 +1731 0.1920885756700064 1.57418041362173 0 +1732 0.6893300349513557 1.112544882634943 0 +1733 0.4449999999988435 1.009834419939386 0 +1734 0.1700748860643287 1.150526006389004 0 +1735 0.8299251139348781 1.150526006389683 0 +1736 0.09186582962255053 1.95800540296326 0 +1737 0.5643355014725605 1.009824024904067 0 +1738 0.5289478002885146 1.011402601026616 0 +1739 0.3621653283032414 1.728327737854277 0 +1740 0.6584726955161372 1.237271700011114 0 +1741 0.5427278046878793 1.584458579189472 0 +1742 0.7623183775324321 1.425712092514215 0 +1743 0.02547551206921448 1.009775380546244 0 +1744 0.9745244879306694 1.009775380546281 0 +1745 0.3529412992202863 1.144496753813938 0 +1746 0.4326110221304705 1.059377340742407 0 +1747 0.3662418250752965 1.153629626053834 0 +1748 0.517871980599294 1.080816405729828 0 +1749 0.4319676729204253 1.380808248127539 0 +1750 0.5738926691441627 1.103111176288461 0 +1751 0.6465563042508211 1.144647387878987 0 +1752 0.09859489244969388 1.32544165797598 0 +1753 0.6375339010817939 1.495050913683121 0 +1754 0.6967396601894161 1.71341023553605 0 +1755 0.6593756972627105 1.010935180684107 0 +1756 0.8331184471826958 1.596006363544031 0 +1757 0.8850499853871938 1.722776790980374 0 +1758 0.8961148323183634 1.534881439365525 0 +1759 0.2739818134134839 1.195999635730333 0 +1760 0.6335438316870903 1.155708931309635 0 +1761 0.229037582356828 1.139197728608386 0 +1762 0.7709624176420738 1.139197728609073 0 +1763 0.6039636780548822 1.658153438395696 0 +1764 0.188095597482738 1.377453523538903 0 +1765 0.2555521166439686 1.346933687821055 0 +1766 0.009912930490979698 1.025902423376436 0 +1767 0.9900870695089976 1.025902423376437 0 +1768 0.3623373094897565 1.457841755368865 0 +1769 0.1176242862198361 1.559822930795623 0 +1770 0.5766003665395085 1.498111411997358 0 +1771 0.4571938465119326 1.18471022988318 0 +1772 0.1581275826813519 1.532229576198945 0 +1773 0.5008660600062748 1.815906300647446 0 +1774 0.1854294366842165 1.527509909607555 0 +1775 0.1205315829907918 1.117590990323308 0 +1776 0.8794684170086939 1.117590990323865 0 +1777 0.194964504568624 1.502411683511218 0 +1778 0.4590965769170281 1.092726363822945 0 +1779 0.6381587890015873 1.538042603638914 0 +1780 0.3668236354042959 1.324419947246179 0 +1781 0.6140980181279748 1.454734385857907 0 +1782 0.2595902921870787 1.250432270327945 0 +1783 0.9757327494972733 1.483092236877727 0 +1784 0.2649060638665572 1.748481407340416 0 +1785 0.3055293456664271 1.126873017774059 0 +1786 0.2449999999994267 1.009670990913548 0 +1787 0.7549999999993507 1.009670990913599 0 +1788 0.695046560129568 1.12656046617977 0 +1789 0.5449886796055228 1.024320193064386 0 +1790 0.0649842999542521 1.53495259832372 0 +1791 0.4634572586411065 1.022760819917886 0 +1792 0.03181169190327937 1.503840213539674 0 +1793 0.2425835267004245 1.069599974389253 0 +1794 0.757416473298351 1.069599974389621 0 +1795 0.3320533437947311 1.21349743691756 0 +1796 0.1323338408924918 1.155457519955617 0 +1797 0.8676661591069742 1.155457519956403 0 +1798 0.2565343694781148 1.176225775491501 0 +1799 0.7435126815472837 1.176198523079507 0 +1800 0.01247696085086004 1.122589760942111 0 +1801 0.987523039149141 1.122589760942236 0 +1802 0.06556473889338765 1.213741341722324 0 +1803 0.9344335637458251 1.213745169816564 0 +1804 0.9271478158824468 1.625694674762937 0 +1805 0.4309311121363045 1.011517013271308 0 +1806 0.08109472075434772 1.399353605119127 0 +1807 0.06147971307893951 1.573710923104925 0 +1808 0.6841545248269346 1.189144133171135 0 +1809 0.7657227375403499 1.302215220964341 0 +1810 0.8624439206485932 1.758791645065031 0 +1811 0.155072236528789 1.487716895119892 0 +1812 0.6949704476117879 1.026648443108347 0 +1813 0.1457363513377697 1.364128303971519 0 +1814 0.8403013925211991 1.321032545269435 0 +1815 0.356820763560079 1.542906462989085 0 +1816 0.08550830360346379 1.105011540413705 0 +1817 0.9144916963961174 1.10501154041412 0 +1818 0.02053398411607882 1.324646479081549 0 +1819 0.1240368264947708 1.143213243553162 0 +1820 0.8759631735047608 1.143213243553859 0 +1821 0.6127367096328877 1.03300909492778 0 +1822 0.8934747587653146 1.336047976327256 0 +1823 0.7270739513648025 1.193762448046446 0 +1824 0.1752184368776151 1.126283605545843 0 +1825 0.8247815631215744 1.12628360554642 0 +1826 0.8102041703435074 1.637111916870119 0 +1827 0.6103800280238214 1.158534652353839 0 +1828 0.7500234758731192 1.222111658292078 0 +1829 0.08717097594833297 1.158387265680563 0 +1830 0.9128290240516461 1.158387265680887 0 +1831 0.9797871248523023 1.376468907498227 0 +1832 0.3166170696317585 1.190975006797362 0 +1833 0.2146148845766929 1.636298158682441 0 +1834 0.01861447673173511 1.41752576251523 0 +1835 0.3897512578210214 1.159579887361764 0 +1836 0.1266112422386982 1.354737419547293 0 +1837 0.3391692139302137 1.659592054851591 0 +1838 0.2016845130700723 1.210250763781453 0 +1839 0.7992031568300352 1.211166790635472 0 +1840 0.792664126268221 1.524898389460468 0 +1841 0.5573820430114038 1.540049571428264 0 +1842 0.6380740774390484 1.172789027114497 0 +1843 0.2232376464142119 1.00958411914316 0 +1844 0.7767623535846921 1.009584119143212 0 +1845 0.6024686209170629 1.514565844696254 0 +1846 0.2849423695736947 1.078531667484422 0 +1847 0.7150576304248637 1.078531667484845 0 +1848 0.1456100583826198 1.556642836083183 0 +1849 0.4180501201640903 1.026176979778029 0 +1850 0.1936412762776413 1.235186419658842 0 +1851 0.3041497694467667 1.156792131505723 0 +1852 0.1639696274917743 1.957393468776791 0 +1853 0.9737822816262725 1.638971398278397 0 +1854 0.1303393100494752 1.012339003492229 0 +1855 0.8696606899499348 1.012339003492284 0 +1856 0.2563550932659178 1.514428140544755 0 +1857 0.0318659543103559 1.087988973767038 0 +1858 0.968134045689499 1.087988973767478 0 +1859 0.4564654773622829 1.557390433553833 0 +1860 0.2512570647326824 1.476789328142382 0 +1861 0.1792869961406473 1.045135879016064 0 +1862 0.820713003858498 1.045135879016294 0 +1863 0.8415989605671719 1.242962806964758 0 +1864 0.1631740024733374 1.227677131980952 0 +1865 0.5450945626466963 1.137843101241501 0 +1866 0.7781476330352186 1.603777668355222 0 +1867 0.5558912131262865 1.119787333810297 0 +1868 0.204999999999543 1.009149411772196 0 +1869 0.7949999999994576 1.009149411772257 0 +1870 0.4582273797523627 1.262244493653419 0 +1871 0.4254445428999811 1.746596752175994 0 +1872 0.5378374929183676 1.559574970150986 0 +1873 0.03457720511724604 1.212296950800446 0 +1874 0.9654227948826942 1.21229695080066 0 +1875 0.8700209059850211 1.496518551380331 0 +1876 0.5675945355170743 1.3003120461337 0 +1877 0.8496440468217714 1.360526511650975 0 +1878 0.7841465124683823 1.368253165614996 0 +1879 0.2909482692433644 1.612229037726445 0 +1880 0.4141127735951107 1.048124555826303 0 +1881 0.1434679067885991 1.27101494884259 0 +1882 0.3863293159074262 1.188760731051833 0 +1883 0.7618849372965923 1.48607523020365 0 +1884 0.1520930466446257 1.145016989540456 0 +1885 0.8479069533546686 1.145016989541159 0 +1886 0.4001232215111544 1.10958575853212 0 +1887 0.4606722793665414 1.708346148464479 0 +1888 0.1945939971618717 1.111928456343726 0 +1889 0.8054060028371891 1.111928456344265 0 +1890 0.2227624038922636 1.16737024954893 0 +1891 0.777121165772221 1.167897891639661 0 +1892 0.2331825557006087 1.104649197274569 0 +1893 0.7668174442982576 1.10464919727508 0 +1894 0.6575666862515637 1.45527827592039 0 +1895 0.1794842438232933 1.162229785601425 0 +1896 0.82051575617585 1.162229785602169 0 +1897 0.1169971873452828 1.046686485382433 0 +1898 0.8830028126541825 1.04668648538265 0 +1899 0.3053040956980385 1.026769250485196 0 +1900 0.06392993616871255 1.24585270171517 0 +1901 0.936070063831129 1.245852701715393 0 +1902 0.06013750131700139 1.432045095227549 0 +1903 0.3958226291316718 1.023505652321041 0 +1904 0.1924508227629811 1.095149888689246 0 +1905 0.8075491772361134 1.095149888689733 0 +1906 0.377148226163243 1.384683121915274 0 +1907 0.3673738420170892 1.071010433513946 0 +1908 0.2674039214137685 1.378029728527427 0 +1909 0.1344414996845994 1.222108759905904 0 +1910 0.02744647986399516 1.735506331588752 0 +1911 0.8659803798364015 1.221093141281715 0 +1912 0.0876569881871975 1.343636705461433 0 +1913 0.6538996920355378 1.026097605344896 0 +1914 0.6933701665226202 1.563787524063246 0 +1915 0.7123807038560013 1.266110315202807 0 +1916 0.5095885034584053 1.184820151560342 0 +1917 0.2933597579722765 1.010368072803908 0 +1918 0.5939928235128039 1.040269355732589 0 +1919 0.5696269032516708 1.266516651681863 0 +1920 0.8619498806529748 1.422974738371203 0 +1921 0.2367565364115237 1.192976067184187 0 +1922 0.7627325250576875 1.192078160427286 0 +1923 0.7441097986637095 1.593083500344335 0 +1924 0.07171557645244529 1.076598344915446 0 +1925 0.9282844235472408 1.076598344915794 0 +1926 0.9347120007217984 1.567878552007669 0 +1927 0.8233423111854732 1.710581195280778 0 +1928 0.2618309309568392 1.204429643427829 0 +1929 0.3828665712359585 1.131614629498487 0 +1930 0.306063105488766 1.834469317280389 0 +1931 0.07397811590968398 1.695754684989576 0 +1932 0.551829080481935 1.427418097095619 0 +1933 0.6271692125494556 1.286971920848768 0 +1934 0.8265006754485748 1.223679790649367 0 +1935 0.2579098681207076 1.047262021849317 0 +1936 0.7420901318780004 1.04726202184957 0 +1937 0.5178858147592814 1.700687013220689 0 +1938 0.3279855027971465 1.247727616175733 0 +1939 0.7669991237691466 1.734910024566651 0 +1940 0.6274613154507542 1.699365570343305 0 +1941 0.09577685086407008 1.209376818520836 0 +1942 0.9042231491367253 1.209376818521126 0 +1943 0.2060120022232498 1.746963032947698 0 +1944 0.4787036845354107 1.852040693945571 0 +1945 0.1704541376211083 1.177970402666852 0 +1946 0.8295458623781076 1.177970402667681 0 +1947 0.14416662426055 1.189927231182806 0 +1948 0.85583337573882 1.189927231183569 0 +1949 0.4803838477741659 1.514226289217374 0 +1950 0.0156776004375533 1.274148142540154 0 +1951 0.2981240476860536 1.206007844677198 0 +1952 0.3239839727924476 1.071426663218374 0 +1953 0.08785474620680163 1.884523387382669 0 +1954 0.675580106770746 1.073304072611617 0 +1955 0.2444933799370497 1.253169245062978 0 +1956 0.2084240140641045 1.39119473368074 0 +1957 0.706720130807567 1.677584372371792 0 +1958 0.4985630721814919 1.286583697951079 0 +1959 0.5272648367935169 1.030309746661296 0 +1960 0.1794491930618081 1.483116361983499 0 +1961 0.612466595261273 1.537821890578596 0 +1962 0.9487159971720964 1.371233950340879 0 +1963 0.6423907119281544 1.010599178919727 0 +1964 0.9653928597467655 1.24668944924121 0 +1965 0.645245503128506 1.260030604115 0 +1966 0.7082398288968355 1.174555644289763 0 +1967 0.02736770568715491 1.064256349414609 0 +1968 0.9726322943127153 1.064256349414922 0 +1969 0.5680345081402352 1.594095559129904 0 +1970 0.362563884902023 1.171575296280291 0 +1971 0.4157620768697803 1.008619152368975 0 +1972 0.2681937934565681 1.957420060780857 0 +1973 0.9743938418550899 1.553111234286536 0 +1974 0.6791418009711589 1.250053136850562 0 +1975 0.2784198226526192 1.05637801625902 0 +1976 0.7215801773459838 1.056378016259317 0 +1977 0.02753429274848121 1.041934772296269 0 +1978 0.972465707251381 1.041934772296453 0 +1979 0.1256376071734777 1.302219577829865 0 +1980 0.2609838056415137 1.086317206399151 0 +1981 0.7390161943571902 1.086317206399599 0 +1982 0.3676316620391438 1.234919150069465 0 +1983 0.5019209186998863 1.109358723710899 0 +1984 0.6677218717434913 1.753575097246623 0 +1985 0.479680976008357 1.095710771767852 0 +1986 0.4825622058110138 1.127951198384719 0 +1987 0.6637594993211857 1.328674258715477 0 +1988 0.03463095676034268 1.24747100852619 0 +1989 0.9371262009871737 1.317695419714111 0 +1990 0.4627619036874025 1.210014839253461 0 +1991 0.5113398094517708 1.224128721267505 0 +1992 0.1704701232449447 1.394540156805218 0 +1993 0.9013876922001541 1.596167525349352 0 +1994 0.5760617612020729 1.007735744418398 0 +1995 0.4520236835492349 1.413634959189053 0 +1996 0.3843314276994749 1.052785872645919 0 +1997 0.2560238928644291 1.110215166345754 0 +1998 0.7064606446168739 1.010452047779177 0 +1999 0.5436292608078989 1.242121071362822 0 +2000 0.7439761071343243 1.110215166346311 0 +2001 0.128203013834791 1.06604649451107 0 +2002 0.8717969861646158 1.066046494511361 0 +2003 0.1638231026155551 1.344567036383962 0 +2004 0.2278375117322295 1.541199029141715 0 +2005 0.437097361665723 1.128646281741983 0 +2006 0.1522173451869736 1.174608683707464 0 +2007 0.847782654812319 1.174608683708255 0 +2008 0.292348746218609 1.242220508949792 0 +2009 0.950141997089236 1.481209888463451 0 +2010 0.8030541759907543 1.362004030032993 0 +2011 0.1260362702479695 1.16985254498585 0 +2012 0.8739637297516609 1.169852544986847 0 +2013 0.758891510663338 1.508405134173101 0 +2014 0.9459306581138512 1.28912645618923 0 +2015 0.70079256369617 1.215690352383343 0 +2016 0.1608953896414062 1.053151652143149 0 +2017 0.8391046103578392 1.05315165214341 0 +2018 0.8673264847469432 1.520896980552137 0 +2019 0.4217217054647685 1.967189886739287 0 +2020 0.5670290114423467 1.158265665607041 0 +2021 0.8806414424851595 1.372527903961492 0 +2022 0.8404250379701619 1.277474672985963 0 +2023 0.1921012955458994 1.049549523920727 0 +2024 0.8078987044531749 1.049549523920973 0 +2025 0.1667596275776418 1.025704905452568 0 +2026 0.833240372421572 1.025704905452702 0 +2027 0.699469288966292 1.335437285881577 0 +2028 0.447163015802219 1.79955888093813 0 +2029 0.2015129249994881 1.547535917057872 0 +2030 0.2956382843634384 1.043318504715491 0 +2031 0.7043328220147673 1.043326308630081 0 +2032 0.149815425092113 1.452000026728363 0 +2033 0.03322219127291086 1.1276583390886 0 +2034 0.9667778087270498 1.127658339088923 0 +2035 0.6024721618403006 1.341253534719694 0 +2036 0.7165605180680079 1.370507799258252 0 +2037 0.08211482328749958 1.436591101799652 0 +2038 0.6775270146101005 1.107470769230827 0 +2039 0.5324294510389613 1.047176526105539 0 +2040 0.05834643421919659 1.043557151751575 0 +2041 0.9416535657805349 1.04355715175178 0 +2042 0.4373309311078256 1.081646688323138 0 +2043 0.1757150562566806 1.009333843141428 0 +2044 0.8242849437424866 1.009333843141474 0 +2045 0.606435889235086 1.129939411271857 0 +2046 0.5674075782240189 1.200250734669209 0 +2047 0.2002405263313292 1.035252963107884 0 +2048 0.7997594736677088 1.035252963108054 0 +2049 0.5523157243353665 1.040903584941117 0 +2050 0.2513120474041305 1.600223033278485 0 +2051 0.008869757682282854 1.06090774539327 0 +2052 0.991130242317674 1.060907745393404 0 +2053 0.428572337150359 1.021999380817825 0 +2054 0.9798449062744337 1.3988480892044 0 +2055 0.8560898397849038 1.249100717623396 0 +2056 0.379906043111042 1.504713625053354 0 +2057 0.272532818139513 1.151381550821801 0 +2058 0.7272559015513816 1.151715946930214 0 +2059 0.356745541492913 1.009917679246867 0 +2060 0.6846557308686028 1.305860243175372 0 +2061 0.08714079832757156 1.734909779511169 0 +2062 0.8400150590438813 1.424156279737596 0 +2063 0.5933383741432143 1.008958334910085 0 +2064 0.2705136801267467 1.553460155605202 0 +2065 0.965385333701911 1.843014132114027 0 +2066 0.6386966745422131 1.355488786214845 0 +2067 0.8665252251706854 1.971809501410483 0 +2068 0.9820949512587762 1.297096437138225 0 +2069 0.03615638995613647 1.150604770057545 0 +2070 0.9638436100439778 1.150604770057832 0 +2071 0.4895994311900977 1.437839367573432 0 +2072 0.1514131063759163 1.603336188169901 0 +2073 0.4177696222708859 1.448159842847469 0 +2074 0.6103923412652905 1.208648684626435 0 +2075 0.3442076737687241 1.442134370437397 0 +2076 0.3404386207122936 1.969127580425501 0 +2077 0.5444207867287427 1.168506061880991 0 +2078 0.4795481514829413 1.10794642130366 0 +2079 0.2009848388279936 1.886086828398841 0 +2080 0.6148075888515304 1.265721875828371 0 +2081 0.09658846249911561 1.414472733446401 0 +2082 0.02353660305992512 1.028593042207709 0 +2083 0.9764633969399723 1.028593042207789 0 +2084 0.04681438408732135 1.454884805392139 0 +2085 0.451175577132779 1.039110595021683 0 +2086 0.5797938481339602 1.134012273139594 0 +2087 0.609934940545047 1.072246520391785 0 +2088 0.1449656292904127 1.008223463394859 0 +2089 0.8550343707089234 1.008223463394896 0 +2090 0.590460099736939 1.170984208737595 0 +2091 0.5292696632865045 1.759059703937938 0 +2092 0.4883221154853772 1.479002461273176 0 +2093 0.5806648813343145 1.022275255686573 0 +2094 0.05129973305321583 1.134712957097158 0 +2095 0.9487002669466476 1.134712957097605 0 +2096 0.04426282461234832 1.049400337207207 0 +2097 0.955737175387451 1.049400337207442 0 +2098 0.8099763954840026 1.798573898416366 0 +2099 0.4661317279311475 1.127806744688285 0 +2100 0.7483715743899884 1.448137144407937 0 +2101 0.09502051656371546 1.043905955397741 0 +2102 0.9049794834358547 1.043905955397932 0 +2103 0.2318473580149737 1.117791116100699 0 +2104 0.7681526419839296 1.117791116101271 0 +2105 0.4482731064374137 1.022160747257612 0 +2106 0.3904237451632521 1.424236798817851 0 +2107 0.7217970621698427 1.76667148339369 0 +2108 0.3961510664141517 1.230308961788109 0 +2109 0.6064958462041103 1.023120951699352 0 +2110 0.07827044573813537 1.221524332051237 0 +2111 0.9217295542618398 1.221524332051461 0 +2112 0.9430398101745519 1.399891910807088 0 +2113 0.5465874879587067 1.869794292935753 0 +2114 0.3214036490763777 1.088510236500664 0 +2115 0.6786623141279533 1.088426701333874 0 +2116 0.5520376257110979 1.193525564168789 0 +2117 0.1299015217104029 1.186260615674174 0 +2118 0.8701076972099632 1.186217630506735 0 +2119 0.5929184663678062 1.434598570127111 0 +2120 0.2017401129760921 1.079678988950125 0 +2121 0.7982598870229237 1.079678988950528 0 +2122 0.1151957459583702 1.024969933208169 0 +2123 0.884804254041114 1.02496993320828 0 +2124 0.2746327014355624 1.255510554686107 0 +2125 0.2472826508168402 1.220350543469557 0 +2126 0.01273565874639171 1.163923468083115 0 +2127 0.9872643412536666 1.163923468083227 0 +2128 0.4712512329975019 1.399596369631081 0 +2129 0.132111284008946 1.022647928026197 0 +2130 0.8678887159904536 1.0226479280263 0 +2131 0.1807586128299933 1.672997320175485 0 +2132 0.136101380073499 1.322928893301953 0 +2133 0.3437952484083727 1.082829196403842 0 +2134 0.5868410512445059 1.145284134045907 0 +2135 0.438603114066438 1.28215724617847 0 +2136 0.6853938462836076 1.045800050598333 0 +2137 0.07561781945562387 1.112309247825873 0 +2138 0.9243821805439293 1.112309247826226 0 +2139 0.5560095425502198 1.516250594280434 0 +2140 0.01871380242351933 1.355514239171304 0 +2141 0.4959481301902377 1.592706067739345 0 +2142 0.07797514699932538 1.021065725418745 0 +2143 0.9220248530003248 1.021065725418842 0 +2144 0.6637545542748219 1.863511076446011 0 +2145 0.3353636582360394 1.038373684102795 0 +2146 0.1645229955356057 1.083357920346921 0 +2147 0.4875327168789771 1.682941262859293 0 +2148 0.8354770044636202 1.083357920347322 0 +2149 0.3761083345513266 1.84687142048503 0 +2150 0.2741008468502953 1.224925449319769 0 +2151 0.6333181207285565 1.105407244731822 0 +2152 0.1755858547231468 1.213850074413578 0 +2153 0.0261757603801651 1.80159747629283 0 +2154 0.6007160861068624 1.576760455524258 0 +2155 0.1793214923670735 1.114422410292022 0 +2156 0.8206785076320341 1.114422410292585 0 +2157 0.6365350515204296 1.0384250866456 0 +2158 0.1693255843156125 1.624881200064417 0 +2159 0.02164870612970708 1.565387712577066 0 +2160 0.6354508407273606 1.028215418302689 0 +2161 0.08270077109235817 1.037857516254943 0 +2162 0.9172992289072571 1.037857516255114 0 +2163 0.5998321287691302 1.769364797826695 0 +2164 0.8298178491891557 1.336571357819605 0 +2165 0.7527859353988637 1.330997162859243 0 +2166 0.5258435291239074 1.303178670179201 0 +2167 0.5116849957764512 1.642206686824897 0 +2168 0.4776052058869856 1.151412640668384 0 +2169 0.01242659049893313 1.145731527548932 0 +2170 0.9875734095011103 1.14573152754917 0 +2171 0.8994886050807953 1.300374556985441 0 +2172 0.2496617762402528 1.161951873983885 0 +2173 0.7503422246961428 1.161949556602649 0 +2174 0.5623022331621876 1.021829685663601 0 +2175 0.7985830155877583 1.662256342634103 0 +2176 0.4468485119230721 1.143439840939882 0 +2177 0.4995799472483723 1.145753470585167 0 +2178 0.5385558254411901 1.36449961192785 0 +2179 0.3152725617578118 1.301914044049464 0 +2180 0.2019650834310384 1.716905711027309 0 +2181 0.8709055538433237 1.274553834352554 0 +2182 0.352717671148069 1.259891628720189 0 +2183 0.4137835368403202 1.212724644096485 0 +2184 0.7829125414814452 1.283070722091011 0 +2185 0.8345090748393948 1.491459210364769 0 +2186 0.4647665742582281 1.032948237937426 0 +2187 0.6572127978963609 1.479948171438262 0 +2188 0.10687252195885 1.586323961651251 0 +2189 0.5421004732268 1.076863751249264 0 +2190 0.1173760866278616 1.390861612958324 0 +2191 0.9448717414548565 1.51610757247957 0 +2192 0.3974005433439814 1.135590000617764 0 +2193 0.7974348103751557 1.482895490993941 0 +2194 0.3148713400133976 1.045500140778384 0 +2195 0.06797456480814938 1.087495973976509 0 +2196 0.9320254351915567 1.087495973976895 0 +2197 0.5219576539716246 1.154555784792072 0 +2198 0.3904272688864535 1.204473783123806 0 +2199 0.3977708065818873 1.392026131897953 0 +2200 0.5945803455850158 1.027906802244898 0 +2201 0.4019486570923889 1.284101626938114 0 +2202 0.2765171062125843 1.025066889101606 0 +2203 0.7234887981607393 1.025080592209863 0 +2204 0.1758557526560303 1.27775460757229 0 +2205 0.9136518823238828 1.375396452990999 0 +2206 0.7443960407730932 1.266873315075178 0 +2207 0.12459080310233 1.431662300570973 0 +2208 0.4480100586917132 1.484851401399625 0 +2209 0.2944378100425409 1.496329730399626 0 +2210 0.8044837195806125 1.440617180702402 0 +2211 0.6399006031828921 1.391510323739811 0 +2212 0.3690439829379977 1.009642632848299 0 +2213 0.170060425218992 1.104164627670242 0 +2214 0.8299395747802024 1.104164627670734 0 +2215 0.2286028152215735 1.037350276990135 0 +2216 0.7713971847772998 1.037350276990342 0 +2217 0.2934789486989772 1.0223920844985 0 +2218 0.6240986683788222 1.024477051803363 0 +2219 0.1067063187395025 1.058628892594812 0 +2220 0.8932936812599981 1.058628892595063 0 +2221 0.1019544830037276 1.156168329210506 0 +2222 0.898045516996135 1.156168329211049 0 +2223 0.1949932944472074 1.167360191180254 0 +2224 0.8050067055518592 1.167360191181032 0 +2225 0.6603777903850399 1.525662481711951 0 +2226 0.245391803708043 1.839016074433248 0 +2227 0.3536320252392992 1.100940444907367 0 +2228 0.430124478536677 1.339336612917217 0 +2229 0.8981725405470772 1.404937256092329 0 +2230 0.7056960397471062 1.966866997920286 0 +2231 0.7065906866764419 1.022438731214329 0 +2232 0.2012001018747546 1.296400206811763 0 +2233 0.5382723984422578 1.056627237162958 0 +2234 0.3798666203494291 1.310251258741632 0 +2235 0.3990227367746531 1.310108703462735 0 +2236 0.9117525192661133 1.64479300902244 0 +2237 0.4951810597463845 1.008451206003383 0 +2238 0.3856346040606316 1.008168370836947 0 +2239 0.2087041922933102 1.662087307904705 0 +2240 0.3500211561285503 1.315240935638154 0 +2241 0.3672262886427102 1.043981484963431 0 +2242 0.1857050544428206 1.00959084544459 0 +2243 0.8142949455562938 1.009590845444634 0 +2244 0.5509801862589658 1.272620855548112 0 +2245 0.2140945244988742 1.098129765853059 0 +2246 0.7859054755000723 1.098129765853532 0 +2247 0.4021674146340235 1.696762127597667 0 +2248 0.5147155367269787 1.008293638884416 0 +2249 0.4369845258039767 1.165050585233715 0 +2250 0.5206700377111164 1.138172889735004 0 +2251 0.546795981103024 1.224721312396716 0 +2252 0.3025089281790439 1.368300007658468 0 +2253 0.2341126445558551 1.518265510477182 0 +2254 0.4356367600180777 1.226413554981793 0 +2255 0.2369969387214383 1.023583745817155 0 +2256 0.7630030612773915 1.023583745817285 0 +2257 0.4559812611581235 1.320533350905662 0 +2258 0.2335734519951339 1.681423422958383 0 +2259 0.4292872480628778 1.671242647141369 0 +2260 0.264472788858505 1.410511893550946 0 +2261 0.2571714983681211 1.31441854883512 0 +2262 0.6033216968307413 1.300647053559742 0 +2263 0.370079851951482 1.91253016377385 0 +2264 0.6794529692814966 1.490715166827631 0 +2265 0.647840151516906 1.635057466727348 0 +2266 0.06135947373672783 1.023243990569141 0 +2267 0.9386405262629929 1.02324399056925 0 +2268 0.6248662932447063 1.044861339047427 0 +2269 0.5986620587730942 1.107755736277664 0 +2270 0.7548265455407078 1.644886179436472 0 +2271 0.009383231058508435 1.094546769210551 0 +2272 0.9906167689415144 1.094546769210673 0 +2273 0.1134398551864522 1.071915810670201 0 +2274 0.8865601448130263 1.071915810670512 0 +2275 0.1205171102691512 1.009444704192922 0 +2276 0.879482889730312 1.00944470419296 0 +2277 0.0489887744904819 1.237643560973488 0 +2278 0.9510033134008493 1.237540097751186 0 +2279 0.2688866197010794 1.778305656566948 0 +2280 0.2957130783744299 1.432191137037003 0 +2281 0.08170306107622252 1.190003637189627 0 +2282 0.9182969389240309 1.190003637189772 0 +2283 0.0265612515232721 1.669183113035363 0 +2284 0.2774339130464847 1.271072567261085 0 +2285 0.3620069931151046 1.125667785784697 0 +2286 0.9586595902743323 1.436468808681142 0 +2287 0.7583855466338468 1.795021702291691 0 +2288 0.109669217838644 1.168406388612293 0 +2289 0.8903307821612053 1.168406388612989 0 +2290 0.4257808632309708 1.267606317903767 0 +2291 0.5692392034793637 1.965073394678322 0 +2292 0.717005996876628 1.485352536021845 0 +2293 0.3842787205213968 1.257130098686424 0 +2294 0.9770491638045107 1.593205418819539 0 +2295 0.7237512723442916 1.609343430199297 0 +2296 0.6523260756385681 1.692825755796842 0 +2297 0.6415398522969602 1.055835752825549 0 +2298 0.6473866148370341 1.06562704554478 0 +2299 0.1439734553980161 1.24702207557063 0 +2300 0.9215455716191034 1.462096544002173 0 +2301 0.1546656494557317 1.118004125443832 0 +2302 0.8453343505435619 1.118004125444394 0 +2303 0.8450882357943197 1.38766758924316 0 +2304 0.09526390365603181 1.024926589485136 0 +2305 0.9047360963435404 1.024926589485246 0 +2306 0.9751489074892264 1.71003651193841 0 +2307 0.483382295349191 1.024440346686145 0 +2308 0.5201125974092214 1.51138207790068 0 +2309 0.6924461965592059 1.429243527648868 0 +2310 0.4642437143912083 1.339026206342744 0 +2311 0.3049183415756433 1.008461664762768 0 +2312 0.3118390138473546 1.225711787092636 0 +2313 0.2648776171657372 1.074498456311161 0 +2314 0.735122382832928 1.074498456311559 0 +2315 0.8951581107698734 1.836584734264075 0 +2316 0.1217895541052448 1.211672378617253 0 +2317 0.8782282343793661 1.211098546470539 0 +2318 0.06641206891134892 1.172700183373423 0 +2319 0.9335879310887987 1.17270018337351 0 +2320 0.1073717434058908 1.218946756730697 0 +2321 0.8913038602959973 1.217798449821929 0 +2322 0.2846807038366894 1.143647967582996 0 +2323 0.713041527093548 1.143860802479325 0 +2324 0.1268629993010217 1.337553309125638 0 +2325 0.05709561234444471 1.190760650216339 0 +2326 0.9429043876557501 1.190760650216474 0 +2327 0.5520622519351621 1.406305628507964 0 +2328 0.5842457084275658 1.475504564103277 0 +2329 0.3505918093717602 1.293557554188062 0 +2330 0.1916210558857136 1.140032387424628 0 +2331 0.8083789441133791 1.140032387425264 0 +2332 0.2077155698757716 1.025156481557727 0 +2333 0.7922844301232447 1.025156481557845 0 +2334 0.3637298281476182 1.083497409541887 0 +2335 0.5218386483709547 1.395909361987244 0 +2336 0.2463899594886432 1.084139678373507 0 +2337 0.7536100405101218 1.08413967837395 0 +2338 0.5087632245543942 1.034503281659485 0 +2339 0.802096146906212 1.339519855560701 0 +2340 0.4450712517349534 1.072739927785263 0 +2341 0.344292075680827 1.201122594483379 0 +2342 0.2245335632221269 1.278277771774352 0 +2343 0.4981555014409521 1.088601459809012 0 +2344 0.4236870496346242 1.099704839301133 0 +2345 0.7268906318502145 1.356444381904256 0 +2346 0.6580110871678138 1.363469687951121 0 +2347 0.6444483296814207 1.120136138480627 0 +2348 0.206500046888421 1.59263244337669 0 +2349 0.4636924260648623 1.173488488079738 0 +2350 0.2654646572918291 1.008445754448973 0 +2351 0.7345353427068364 1.008445754449022 0 +2352 0.3265014877061418 1.359338834767213 0 +2353 0.6762687079588712 1.393569658200308 0 +2354 0.9811095987413255 1.511835631740009 0 +2355 0.01315927290548044 1.192460494600644 0 +2356 0.9868407270945394 1.192460494600732 0 +2357 0.6952476703046778 1.008855766010172 0 +2358 0.2661990976369464 1.32899360584412 0 +2359 0.4606967727407756 1.080262989742472 0 +2360 0.4179054261309286 1.490960253609345 0 +2361 0.4497968842408223 1.769685215744619 0 +2362 0.3389250621454352 1.388762446921705 0 +2363 0.3814697860675392 1.035982892395799 0 +2364 0.3013584124700316 1.091348106485285 0 +2365 0.6986245748487731 1.091321212329855 0 +2366 0.2767236146962959 1.165620086925194 0 +2367 0.7226534770979616 1.166520336546416 0 +2368 0.5337444050254593 1.33397028841418 0 +2369 0.5959306874797072 1.096252333343265 0 +2370 0.6836804341957428 1.813088233286651 0 +2371 0.8287839974984158 1.519635857113617 0 +2372 0.5998863768721036 1.145069322781776 0 +2373 0.0406490703173942 1.077659850433175 0 +2374 0.9593509296824165 1.077659850433543 0 +2375 0.2190098595493452 1.069222901724268 0 +2376 0.7809901404495685 1.069222901724616 0 +2377 0.08733254541050008 1.008803615701622 0 +2378 0.9126674545891079 1.008803615701655 0 +2379 0.2173543957771154 1.49837315237014 0 +2380 0.6330061775108567 1.188287088854407 0 +2381 0.6308747319545311 1.008514558289734 0 +2382 0.09206982873417487 1.069350357251731 0 +2383 0.9079301712654164 1.069350357252031 0 +2384 0.1516569801493239 1.202556509649534 0 +2385 0.01552004091228306 1.437256683320709 0 +2386 0.8483528092033974 1.20241870995643 0 +2387 0.02977943533127755 1.867048694239952 0 +2388 0.1327707255350447 1.081032376661927 0 +2389 0.8672292744643423 1.081032376662292 0 +2390 0.6143544677023551 1.723287235189883 0 +2391 0.2828958165869668 1.007954474588847 0 +2392 0.7170742505100419 1.007968470418093 0 +2393 0.6816327337084717 1.630045117136917 0 +2394 0.4347966875263482 1.036496886568068 0 +2395 0.6212887283138765 1.301964830951968 0 +2396 0.1470557202360741 1.917220080289103 0 +2397 0.5750963357773513 1.901911764417661 0 +2398 0.5751126276669639 1.035450141720274 0 +2399 0.9868815746977937 1.227526224792475 0 +2400 0.3158062981237815 1.529930065561749 0 +2401 0.5373512268506833 1.153856641137126 0 +2402 0.07488271101506541 1.506248703292401 0 +2403 0.3628903642233461 1.025794691740807 0 +2404 0.1443088065002906 1.024777956481689 0 +2405 0.8556911934990445 1.024777956481807 0 +2406 0.0607819156414147 1.282940049343619 0 +2407 0.6513752964619469 1.294492809119977 0 +2408 0.5128246276479598 1.88282551548083 0 +2409 0.2115606447741488 1.310436033681391 0 +2410 0.1105575221893233 1.095556962196495 0 +2411 0.8894424778101364 1.095556962196898 0 +2412 0.8668423050189283 1.290685897985153 0 +2413 0.8477850056084667 1.291328515433773 0 +2414 0.6576014023897282 1.205460001679072 0 +2415 0.5174404449227227 1.057377587203173 0 +2416 0.5796255608677263 1.313062082509097 0 +2417 0.2297736655304172 1.208372092822526 0 +2418 0.4127515621233034 1.377753413080143 0 +2419 0.7256206039629089 1.439936279134227 0 +2420 0.6556605726084838 1.102288907934563 0 +2421 0.7175689562404489 1.220932072636383 0 +2422 0.697421629061731 1.201172393001228 0 +2423 0.5346853865425205 1.213530776419037 0 +2424 0.4042946220073286 1.094608865799074 0 +2425 0.3802200732768813 1.071136532231312 0 +2426 0.698927220805335 1.318634077608448 0 +2427 0.8963414791753435 1.435000473311314 0 +2428 0.04060830863109199 1.355708508230532 0 +2429 0.483009615102541 1.165931114740444 0 +2430 0.7819834862331816 1.387428856356128 0 +2431 0.4946713975984484 1.077556774412957 0 +2432 0.43579161692004 1.910885478095247 0 +2433 0.3664873227226103 1.618284690680676 0 +2434 0.2660920317846424 1.118521323051379 0 +2435 0.733907968214054 1.118521323051987 0 +2436 0.7333017283096598 1.407803041538581 0 +2437 0.5434344444458639 1.466586446096726 0 +2438 0.1084641515809967 1.488886667711622 0 +2439 0.8333726130297561 1.685906100322729 0 +2440 0.06426240905092909 1.129424987982342 0 +2441 0.935737590948744 1.129424987982568 0 +2442 0.5227111313346383 1.177624183859562 0 +2443 0.288205862710769 1.195401811311246 0 +2444 0.691180416808395 1.455751973782095 0 +2445 0.5137808638311128 1.103952643389808 0 +2446 0.9669772807958988 1.271286970488561 0 +2447 0.1011827234355184 1.133950863803468 0 +2448 0.8988172765641812 1.133950863804081 0 +2449 0.06432379583407943 1.054920096304593 0 +2450 0.9356762041656257 1.054920096304852 0 +2451 0.1671352718783606 1.201382908862429 0 +2452 0.8333496878351739 1.200910990898491 0 +2453 0.8334431353372178 1.353752967968184 0 +2454 0.9826961612826518 1.460882419695907 0 +2455 0.3347234962956788 1.322537733508801 0 +2456 0.1888835345691721 1.247136318413714 0 +2457 0.201199918520275 1.327515173994747 0 +2458 0.047608747939825 1.418705795349814 0 +2459 0.1421131389231776 1.469891553039637 0 +2460 0.4736451880142024 1.26955045356819 0 +2461 0.1864848443756276 1.82580443035625 0 +2462 0.8635862349904041 1.344291048158857 0 +2463 0.607858238172303 1.378161770341 0 +2464 0.2134684806521862 1.043611974452363 0 +2465 0.7865315193467725 1.043611974452588 0 +2466 0.2170697885937288 1.261972679641198 0 +2467 0.6653327885673148 1.112583618089412 0 +2468 0.4028480559693264 1.031980948436563 0 +2469 0.01306918268954506 1.227506249800406 0 +2470 0.5706896709283737 1.051529441131618 0 +2471 0.2940544974538614 1.473889395584197 0 +2472 0.1103949300739344 1.816076851287972 0 +2473 0.4004694185305982 1.081362101846985 0 +2474 0.6116894790062615 1.809535577550265 0 +2475 0.7125372984926814 1.189879436968841 0 +2476 0.4950925463465343 1.131563329329821 0 +2477 0.673600724589354 1.424745730861811 0 +2478 0.7679311319821593 1.245427047958923 0 +2479 0.5278155936671252 1.073725558412694 0 +2480 0.5647537920816906 1.22235090384175 0 +2481 0.3182142201352389 1.038267744136485 0 +2482 0.7307105340819755 1.24460143968555 0 +2483 0.5052220355286432 1.322112889385458 0 +2484 0.2080602466202005 1.449930318978343 0 +2485 0.1223013727918149 1.679223472738413 0 +2486 0.2297431815266326 1.053327412069824 0 +2487 0.7702568184722273 1.053327412070121 0 +2488 0.2914727956908776 1.877361294072467 0 +2489 0.1128295332170542 1.257829635235314 0 +2490 0.5572526768897683 1.068871194445014 0 +2491 0.6886563521083723 1.365225127920008 0 +2492 0.9201258078599812 1.541350921646632 0 +2493 0.7477565761416181 1.920518225563881 0 +2494 0.4592102675916969 1.060675288033551 0 +2495 0.06685791667303886 1.335875473456547 0 +2496 0.6189873652577433 1.481370800431678 0 +2497 0.8561392263921054 1.265784804462159 0 +2498 0.9778842768414369 1.764106022422698 0 +2499 0.9077682474679726 1.326766493657349 0 +2500 0.2400966280348704 1.628466649581014 0 +2501 0.4004307598922787 1.759126097460738 0 +2502 0.2169448201779346 1.13870751439649 0 +2503 0.7830551798210181 1.138707514397156 0 +2504 0.3223386752368323 1.109626179197909 0 +2505 0.5310420778216919 1.096229406795321 0 +2506 0.3066886690121686 1.667638168593698 0 +2507 0.4047946604028866 1.048093302673197 0 +2508 0.02638778293257049 1.139666719507557 0 +2509 0.9736122170674596 1.139666719507826 0 +2510 0.3191513618747654 1.550520679452815 0 +2511 0.1486540545378149 1.381354277263337 0 +2512 0.2658860648783699 1.444301894815109 0 +2513 0.2344685259676118 1.337595098368086 0 +2514 0.3548672646901477 1.042681314115025 0 +2515 0.2549999999993979 1.007287926784018 0 +2516 0.7449999999993338 1.007287926784064 0 +2517 0.5550215240543818 1.792579410126008 0 +2518 0.1259407089873475 1.607450016704592 0 +2519 0.5154191742448895 1.336516639615168 0 +2520 0.3424096883067851 1.892405460799233 0 +2521 0.9105603993720903 1.719417359195687 0 +2522 0.491454738942629 1.20617921794475 0 +2523 0.6732263419553889 1.022299263980984 0 +2524 0.7430580752959772 1.20260102690801 0 +2525 0.1039099014739094 1.193661257526501 0 +2526 0.896090098526272 1.193661257527041 0 +2527 0.6846852872809485 1.224446181225649 0 +2528 0.8207689912389049 1.558269157343574 0 +2529 0.9392746459407867 1.335927085252018 0 +2530 0.379367471238798 1.153223991895915 0 +2531 0.5720940361450669 1.443410919372026 0 +2532 0.7013456790211355 1.152270471296674 0 +2533 0.5298620938251043 1.288745818290119 0 +2534 0.6363029879174498 1.128476598153378 0 +2535 0.6672184715967526 1.008419341751467 0 +2536 0.196585270431983 1.618133493555558 0 +2537 0.5804299184411017 1.686271262535574 0 +2538 0.6931899798368829 1.17652197360088 0 +2539 0.2346353876000118 1.583881108971837 0 +2540 0.08521620556081834 1.027738039394153 0 +2541 0.9147837944387944 1.027738039394278 0 +2542 0.6246996730273499 1.146432601727515 0 +2543 0.4599707566434424 1.5099051811675 0 +2544 0.2792751343594291 1.043557490500691 0 +2545 0.7207256856912051 1.04355939371038 0 +2546 0.3400363126671407 1.23289961771773 0 +2547 0.1499176889434355 1.092036808942738 0 +2548 0.8500823110558688 1.092036808943163 0 +2549 0.855581027742098 1.648764974182349 0 +2550 0.1053949332094417 1.53955918550553 0 +2551 0.8282007383357128 1.252590037115486 0 +2552 0.3099346299457577 1.062399834998713 0 +2553 0.08138930525559313 1.469273180661253 0 +2554 0.07858807124297797 1.258722840546687 0 +2555 0.9235162067448727 1.25774658665901 0 +2556 0.6704309120100591 1.710057776059305 0 +2557 0.2058741041496006 1.058717842698004 0 +2558 0.7941258958493975 1.058717842698295 0 +2559 0.02688037153822537 1.019263096542427 0 +2560 0.973119628461658 1.019263096542486 0 +2561 0.81468299209774 1.376795747251186 0 +2562 0.4034166702609964 1.147140839771551 0 +2563 0.7801865265424012 1.844426025993615 0 +2564 0.6150339681149277 1.00736353804205 0 +2565 0.294938978290965 1.052502766958926 0 +2566 0.7050460714426577 1.052518687096704 0 +2567 0.7319287368217113 1.63574421567549 0 +2568 0.3340946506599562 1.093147791460886 0 +2569 0.4404316102494155 1.052949799364807 0 +2570 0.9047938223845702 1.491835355842626 0 +2571 0.4256619298075464 1.184401828401098 0 +2572 0.6211206450997407 1.330267389266602 0 +2573 0.1250073282127057 1.028011614476925 0 +2574 0.8749926717867289 1.028011614477054 0 +2575 0.3200190013282347 1.781414700543657 0 +2576 0.9189731193720814 1.275265309291993 0 +2577 0.6901067559151041 1.062467578741231 0 +2578 0.304055937200396 1.289722891444562 0 +2579 0.9860693992169491 1.353364625741588 0 +2580 0.3593263150821457 1.342773246238401 0 +2581 0.05944852326034498 1.152965412381895 0 +2582 0.9405514767395645 1.152965412382083 0 +2583 0.7843952779556428 1.882808212907494 0 +2584 0.6324906271196172 1.828195344923558 0 +2585 0.7032001696686101 1.398133290621532 0 +2586 0.06652196976942409 1.835355425494591 0 +2587 0.2097049418753495 1.188455123909301 0 +2588 0.7905936788947983 1.189280018006007 0 +2589 0.5225412693386131 1.600025226039479 0 +2590 0.6798486513412809 1.038107170495391 0 +2591 0.02387478382974286 1.08249634857144 0 +2592 0.9761252161701999 1.082496348571754 0 +2593 0.2779597660864515 1.300678141243776 0 +2594 0.2591217727801293 1.643836903572349 0 +2595 0.7598104551748428 1.551387239951554 0 +2596 0.2889307224182623 1.409949581561286 0 +2597 0.8659438368155949 1.452599915930364 0 +2598 0.4907876541050186 1.352792237830689 0 +2599 0.01498046318300802 1.37349319841058 0 +2600 0.03763922292149573 1.008690344082199 0 +2601 0.9623607770783348 1.008690344082235 0 +2602 0.876632603190035 1.78641928485738 0 +2603 0.8630308744054651 1.562389319726338 0 +2604 0.2933484794348677 1.18082329088673 0 +2605 0.2767919312146016 1.071942282721758 0 +2606 0.3386817151504491 1.716255984530099 0 +2607 0.7232080687840086 1.071942282722145 0 +2608 0.5890315869114644 1.067771595000768 0 +2609 0.7348014888143021 1.228514209363373 0 +2610 0.2496449407004006 1.134574501694504 0 +2611 0.7503550592983742 1.134574501695211 0 +2612 0.6132807059574744 1.924574955876986 0 +2613 0.5201440961598349 1.275999181418699 0 +2614 0.2326648371431266 1.293406394049293 0 +2615 0.1991458628670774 1.96671147504198 0 +2616 0.4374489440809444 1.857404545720575 0 +2617 0.3998859097555322 1.615600570843229 0 +2618 0.02763755847059179 1.188612713552259 0 +2619 0.9723624415294598 1.188612713552409 0 +2620 0.8948036635915393 1.918358328030976 0 +2621 0.6430969430320795 1.022257488351416 0 +2622 0.4219382215270147 1.882488030584234 0 +2623 0.3037267957583709 1.257293440284194 0 +2624 0.576076272208203 1.366954312861611 0 +2625 0.8404191490518897 1.227458673558944 0 +2626 0.2218862152882494 1.019309457166607 0 +2627 0.7781137847106706 1.019309457166717 0 +2628 0.9276243651134165 1.34694280496324 0 +2629 0.06823376491010882 1.199151441126167 0 +2630 0.9317661614507545 1.19915160720702 0 +2631 0.676697511644481 1.923780393053954 0 +2632 0.3950165720325161 1.059971105785633 0 +2633 0.9484162675011533 1.600159769019392 0 +2634 0.698359853853734 1.523096517748169 0 +2635 0.9271563152895147 1.430112539820764 0 +2636 0.4212115752165234 1.110605771996282 0 +2637 0.481729067655641 1.339322306190931 0 +2638 0.410299444455764 1.268669934134591 0 +2639 0.1313749050839675 1.116432713163102 0 +2640 0.8686250949154555 1.116432713163635 0 +2641 0.08552080732061212 1.058498278524766 0 +2642 0.9144791926789948 1.058498278525015 0 +2643 0.3685818410387591 1.266012443924983 0 +2644 0.5024870819690308 1.777413477316763 0 +2645 0.1851803169822588 1.302073384235638 0 +2646 0.5403604092217136 1.260183869263166 0 +2647 0.4093020974519384 1.645491930749867 0 +2648 0.4311431729614566 1.254213630021399 0 +2649 0.2677819516394609 1.173699374978892 0 +2650 0.7322180483592285 1.173699374979808 0 +2651 0.06609118493186687 1.00771389030964 0 +2652 0.9339088150678417 1.007713890309675 0 +2653 0.886333600527577 1.486856373894653 0 +2654 0.1870477402856157 1.189235924520833 0 +2655 0.8129884766171266 1.189430282651496 0 +2656 0.4473228753812691 1.213683908573492 0 +2657 0.2746457085800106 1.531820895213034 0 +2658 0.8504795284220902 1.803595370621843 0 +2659 0.6411313163706881 1.089385539461865 0 +2660 0.1915064933455573 1.019017877247363 0 +2661 0.8084935066535319 1.019017877247449 0 +2662 0.8298899189533036 1.266217949728847 0 +2663 0.670943415912441 1.182607191556009 0 +2664 0.7709272669960461 1.526429200341188 0 +2665 0.785584344950767 1.970392710009836 0 +2666 0.1972581687909536 1.182075555886863 0 +2667 0.8028128642231392 1.182253555053612 0 +2668 0.3821202536900856 1.459636329343728 0 +2669 0.3292816911051026 1.183302337965912 0 +2670 0.3762046127783428 1.110092919710277 0 +2671 0.02490035216207662 1.643795677999869 0 +2672 0.3939766203587988 1.789561675407629 0 +2673 0.6733241855370542 1.166082174356053 0 +2674 0.4237832213186445 1.007298794383973 0 +2675 0.4425854805748365 1.352237802952996 0 +2676 0.6117750087707944 1.406932243873857 0 +2677 0.1492977266574467 1.016045059769873 0 +2678 0.8507022733418605 1.016045059769946 0 +2679 0.7459081625918377 1.360701508648281 0 +2680 0.1202013868247774 1.632031624687146 0 +2681 0.04435793157129748 1.381730065024117 0 +2682 0.4924779926680551 1.411668049949156 0 +2683 0.5455868774917915 1.085322098313106 0 +2684 0.4226062835544963 1.2404640922895 0 +2685 0.03762297543597007 1.262544401207915 0 +2686 0.3414063147641791 1.187075258547122 0 +2687 0.4888055337200645 1.323491481494812 0 +2688 0.2140062695843855 1.007290760395776 0 +2689 0.785993730414567 1.007290760395818 0 +2690 0.0952717258761891 1.238162577061232 0 +2691 0.9059949101832974 1.238901118740743 0 +2692 0.1599095202371173 1.073871276751049 0 +2693 0.8400904797621289 1.073871276751405 0 +2694 0.01854946807793103 1.48230131191092 0 +2695 0.2894496678610404 1.569945309058891 0 +2696 0.3244282302742709 1.007632226875165 0 +2697 0.3267767272415669 1.165379983947205 0 +2698 0.5804611360294702 1.114339465561189 0 +2699 0.7346634671933665 1.540063909171378 0 +2700 0.4787860365311311 1.560280106802425 0 +2701 0.6436781235358668 1.108897743654242 0 +2702 0.1777570062389003 1.02557585838108 0 +2703 0.8222429937602531 1.025575858381215 0 +2704 0.7541539702357625 1.686233058625092 0 +2705 0.4203058672629181 1.514379946323455 0 +2706 0.02534809005594198 1.763874793561482 0 +2707 0.7258186323090416 1.274787962612752 0 +2708 0.4610870895891317 1.973586381790231 0 +2709 0.5006408496116438 1.250595077759769 0 +2710 0.1252708518528679 1.054545958569082 0 +2711 0.8747291481465558 1.054545958569328 0 +2712 0.03938391277717404 1.094740966249867 0 +2713 0.9606160872226537 1.094740966250186 0 +2714 0.5675715044348002 1.338982802992977 0 +2715 0.6642131036752703 1.270936836965853 0 +2716 0.4653577351625374 1.293180948359519 0 +2717 0.5607178726647342 1.038534804026929 0 +2718 0.1413952707015503 1.062774869411188 0 +2719 0.8586047292978228 1.06277486941148 0 +2720 0.2629514090997688 1.099111045321375 0 +2721 0.7370485908989451 1.099111045321879 0 +2722 0.5533474158556826 1.309003220629826 0 +2723 0.4117313843256126 1.168740002490928 0 +2724 0.4460962096700886 1.625092662968165 0 +2725 0.4367187179516349 1.547886036725576 0 +2726 0.4657287356498001 1.052263821581162 0 +2727 0.6582638640048655 1.184514126378541 0 +2728 0.2530147486726955 1.022407860094514 0 +2729 0.7469852513260371 1.022407860094647 0 +2730 0.6286855802512056 1.236472307303276 0 +2731 0.2346870324814782 1.008455640612283 0 +2732 0.7653129675173608 1.008455640612327 0 +2733 0.3623299169758621 1.371269289813307 0 +2734 0.2889156923740188 1.350197530891613 0 +2735 0.2628842651513345 1.233686474352008 0 +2736 0.5827308655895163 1.095931231145731 0 +2737 0.2198562118521974 1.035376208241158 0 +2738 0.7801437881467311 1.035376208241353 0 +2739 0.1649439339150396 1.007097116786803 0 +2740 0.8350560660841868 1.007097116786832 0 +2741 0.4674294458929631 1.368531629431262 0 +2742 0.7510718586353879 1.411701651929033 0 +2743 0.02401251706849928 1.166794279087094 0 +2744 0.9759874829315841 1.166794279087261 0 +2745 0.2466205164482834 1.029667639778234 0 +2746 0.7533794835504892 1.029667639778406 0 +2747 0.8339034125695897 1.874604190131635 0 +2748 0.4670232220185516 1.474249282569385 0 +2749 0.5818996969213007 1.157580528045311 0 +2750 0.4755516073958432 1.045532826559348 0 +2751 0.18185811625555 1.31786302214069 0 +2752 0.3660827041517126 1.290387914974962 0 +2753 0.761347650185163 1.387356050377003 0 +2754 0.1593215058851385 1.10703142280523 0 +2755 0.840678494114118 1.107031422805699 0 +2756 0.3262456057269053 1.023485044590965 0 +2757 0.7503422027858173 1.291267892963433 0 +2758 0.05337380909562552 1.031553237302947 0 +2759 0.9466261909041291 1.031553237303092 0 +2760 0.057469119032688 1.164891440853474 0 +2761 0.9425308809673754 1.164891440853636 0 +2762 0.2172854963499038 1.213468036424039 0 +2763 0.00753977974051773 1.036836690729115 0 +2764 0.992460220259445 1.036836690729158 0 +2765 0.4665512416283742 1.910537931454778 0 +2766 0.3105813620514997 1.333884865997126 0 +2767 0.3083359811803948 1.180650605104522 0 +2768 0.4999545142939948 1.020019218895563 0 +2769 0.375454053643587 1.213565494941158 0 +2770 0.2882740691481924 1.038693200068688 0 +2771 0.7117270581509294 1.03870218211657 0 +2772 0.3734965725812673 1.020574356973204 0 +2773 0.8584488564777401 1.831526508145217 0 +2774 0.6063722870080076 1.861877760775427 0 +2775 0.1048732388192985 1.006396257793335 0 +2776 0.8951267611802314 1.006396257793362 0 +2777 0.7698037716173323 1.446289070704977 0 +2778 0.3150259190505175 1.464130264978701 0 +2779 0.3511073643217986 1.478357842447523 0 +2780 0.2017540524818569 1.017578900664085 0 +2781 0.7982459475171761 1.017578900664174 0 +2782 0.1432206599035693 1.081823017383028 0 +2783 0.8567793400957614 1.081823017383404 0 +2784 0.2467573028157113 1.121479810277247 0 +2785 0.598982477813105 1.623493347318789 0 +2786 0.7532426971830887 1.121479810277866 0 +2787 0.5104761191247543 1.017782964951546 0 +2788 0.08352842493676289 1.272942110041936 0 +2789 0.5079278233240452 1.351475738625013 0 +2790 0.05448194057721629 1.674196219511389 0 +2791 0.2702342992012707 1.358671229552355 0 +2792 0.2584473023736181 1.152693716025776 0 +2793 0.7822432403505836 1.337056146754361 0 +2794 0.741523086286513 1.152741155844497 0 +2795 0.5237021034766426 1.238858713450787 0 +2796 0.5854356284949629 1.236655533432351 0 +2797 0.1964365575924616 1.071869859051953 0 +2798 0.8035634424065857 1.071869859052315 0 +2799 0.5488965021084053 1.288599088065097 0 +2800 0.06948497133683337 1.356538680878103 0 +2801 0.2949810032824935 1.146757639455889 0 +2802 0.5626405882755808 1.144069798178987 0 +2803 0.6883271313792545 1.239393636035811 0 +2804 0.7993223259900448 1.308268471045901 0 +2805 0.5892871855207226 1.020230775547619 0 +2806 0.3801831290786846 1.339837230304242 0 +2807 0.9358442976149552 1.38139197208213 0 +2808 0.2870536564611025 1.028405294063754 0 +2809 0.6590110032183223 1.081164115065105 0 +2810 0.7134521297784242 1.028330391533875 0 +2811 0.7191171460095185 1.561002005161688 0 +2812 0.4157424834940389 1.13143596515865 0 +2813 0.3715396502219074 1.051957329785141 0 +2814 0.5046557810415299 1.122178850554884 0 +2815 0.3162331814826231 1.422801759355729 0 +2816 0.1016589318909385 1.179710114147281 0 +2817 0.8983410681090872 1.17971011414779 0 +2818 0.1596154694115436 1.153170892600329 0 +2819 0.8403845305876794 1.153170892601049 0 +2820 0.6485752951168573 1.312109092438454 0 +2821 0.6717524080245076 1.053674909909382 0 +2822 0.1713853371459996 1.252240846138065 0 +2823 0.4005658952386686 1.409139619352801 0 +2824 0.9294775333219978 1.854771955760222 0 +2825 0.1908950826018478 1.272409381268901 0 +2826 0.6607329680707571 1.061338263785553 0 +2827 0.1334046027866478 1.971905366770341 0 +2828 0.4231755304273396 1.079893895547409 0 +2829 0.1941488857526259 1.36150428900243 0 +2830 0.7796964269440891 1.316692330375459 0 +2831 0.598269665166175 1.273501324314886 0 +2832 0.1026720586457845 1.11481619593721 0 +2833 0.516708826836367 1.25163639701923 0 +2834 0.8973279413537272 1.114816195937673 0 +2835 0.881305893337626 1.249602066224565 0 +2836 0.3331660648725014 1.112853667476421 0 +2837 0.7492168944309157 1.471624278219516 0 +2838 0.3505935001593734 1.172894141054609 0 +2839 0.03900599805737198 1.037871362443797 0 +2840 0.9609940019424514 1.037871362443979 0 +2841 0.1858260091508975 1.41871928032299 0 +2842 0.5687647776811359 1.379257755082687 0 +2843 0.9220580040000598 1.765583076378356 0 +2844 0.9396285639384199 1.498903633006723 0 +2845 0.7769942119766137 1.22737775318183 0 +2846 0.9396922731971658 1.675581473106377 0 +2847 0.9313277656060316 1.968385325334156 0 +2848 0.4195426418798375 1.936359361085945 0 +2849 0.6312927660414346 1.252861168828801 0 +2850 0.3643805930657786 1.193896051494866 0 +2851 0.059393463003176 1.755021404206746 0 +2852 0.2101047399856204 1.147495561611076 0 +2853 0.7898952600133502 1.147495561611751 0 +2854 0.5241869105064323 1.116714258927648 0 +2855 0.4135266998975591 1.016633187570962 0 +2856 0.68641570903661 1.659613183656362 0 +2857 0.9658890197184886 1.342925348269771 0 +2858 0.07115646171733639 1.148546398648356 0 +2859 0.9288435382823026 1.148546398648545 0 +2860 0.2897663234243298 1.168553349863917 0 +2861 0.417534666429404 1.038737586897918 0 +2862 0.2349622537745057 1.148338909913371 0 +2863 0.665876260568999 1.029166616203806 0 +2864 0.7650377462243316 1.148338909914103 0 +2865 0.385957841209587 1.017321545648354 0 +2866 0.8628091854317986 1.323777363883258 0 +2867 0.5951057499927664 1.313800449733704 0 +2868 0.1172413439426848 1.132745435918073 0 +2869 0.8827586560568293 1.132745435918698 0 +2870 0.3820264553449433 1.240819389194221 0 +2871 0.2095753723637706 1.846389486602504 0 +2872 0.7863461830261411 1.210930870721902 0 +2873 0.5715966479904148 1.235382524467846 0 +2874 0.5640454308261659 1.084685283169291 0 +2875 0.1387499972860813 1.127663899273432 0 +2876 0.8612500027133079 1.127663899274012 0 +2877 0.7806620493699954 1.418064635420868 0 +2878 0.629543135234943 1.072551734643087 0 +2879 0.4898458320442233 1.297211485431618 0 +2880 0.08725613884094617 1.383529712448756 0 +2881 0.3384580962492686 1.062041420669449 0 +2882 0.7126536059243005 1.299634188443179 0 +2883 0.7233477148870193 1.860586748210058 0 +2884 0.4751101182558506 1.761839760251274 0 +2885 0.2166022677776669 1.02631066321107 0 +2886 0.7833977322212846 1.026310663211207 0 +2887 0.1074970413413924 1.310477656487091 0 +2888 0.6468514855092317 1.88415519239545 0 +2889 0.6550209969728054 1.044297712223042 0 +2890 0.3096126098389106 1.017393289262932 0 +2891 0.2274158805659109 1.481145629555492 0 +2892 0.5533783639811831 1.101075512822319 0 +2893 0.03606418746939674 1.19884048931426 0 +2894 0.9639358125306372 1.198840489314458 0 +2895 0.05443254946452088 1.805787267380786 0 +2896 0.2498648128212545 1.713725657657329 0 +2897 0.7438871139722667 1.25125253349348 0 +2898 0.07521216225540725 1.309841488193657 0 +2899 0.8064582494878244 1.27344700810216 0 +2900 0.2804391005947892 1.087997788968355 0 +2901 0.7195608994037967 1.087997788968832 0 +2902 0.4849116177332676 1.630282341215658 0 +2903 0.3469888981154782 1.007442197267729 0 +2904 0.5259416593806885 1.02096153025492 0 +2905 0.388925130057464 1.043003179875413 0 +2906 0.03488622832058046 1.296534486954882 0 +2907 0.4986002351729686 1.232704500037788 0 +2908 0.4109275730836957 1.296051242434567 0 +2909 0.8670153686548974 1.361326715179295 0 +2910 0.5693816089716413 1.112654299399059 0 +2911 0.5560366374406496 1.494031332844624 0 +2912 0.7122331619793438 1.826896612592065 0 +2913 0.4074619807988046 1.361064730636741 0 +2914 0.5858001539050828 1.261261927787994 0 +2915 0.1486309772180805 1.217977558481729 0 +2916 0.3803059278206488 1.36928802292461 0 +2917 0.5940556946732789 1.202868739008952 0 +2918 0.7788522726677783 1.478549569425795 0 +2919 0.209847347480915 1.236418908838099 0 +2920 0.06618227292412564 1.119043338400828 0 +2921 0.9338177270755058 1.119043338401132 0 +2922 0.383779909482824 1.118516391900252 0 +2923 0.5906078230829918 1.077531643665177 0 +2924 0.3716903728307409 1.091473085898907 0 +2925 0.3138181900313047 1.166162775024738 0 +2926 0.4503177597531201 1.578903177925705 0 +2927 0.5085934567209156 1.727568685387252 0 +2928 0.4821527048223911 1.064040821624142 0 +2929 0.04920734305025304 1.145969435633829 0 +2930 0.9507926569496949 1.145969435634112 0 +2931 0.5012906419242744 1.030662086614818 0 +2932 0.4549941012133137 1.006546547005247 0 +2933 0.3506546844418877 1.772543853306129 0 +2934 0.6661777840374016 1.22553799261101 0 +2935 0.3982190405345465 1.524002023824426 0 +2936 0.1770758229450258 1.066838406138642 0 +2937 0.8229241770541227 1.066838406138972 0 +2938 0.2647528471061499 1.05679086312177 0 +2939 0.7352471528925172 1.056790863122069 0 +2940 0.3608865379164736 1.494838367608591 0 +2941 0.5298535542892503 1.434262773301899 0 +2942 0.2292489860649035 1.073780207557802 0 +2943 0.7707510139339485 1.073780207558179 0 +2944 0.4926666647029472 1.042995680778128 0 +2945 0.6305094123637933 1.314302286959342 0 +2946 0.6122929134138689 1.236795882378532 0 +2947 0.8568907864384894 1.581635953614845 0 +2948 0.410290126613798 1.066724166509226 0 +2949 0.05499994271878899 1.594983681837827 0 +2950 0.3281937312021035 1.053462741328787 0 +2951 0.7690209952057978 1.202910363052015 0 +2952 0.6498722532733835 1.172450426166187 0 +2953 0.5361555651470896 1.008187105178369 0 +2954 0.02295216849368465 1.711554885079298 0 +2955 0.8095376807231148 1.750902471522841 0 +2956 0.9705954622239099 1.970402740307113 0 +2957 0.04889102228269866 1.493021452578355 0 +2958 0.8048512964483469 1.831204286715235 0 +2959 0.5552149808812128 1.006924991414495 0 +2960 0.08332480401566156 1.076015587247223 0 +2961 0.9166751959839765 1.076015587247557 0 +2962 0.6445181409311241 1.231796750078932 0 +2963 0.1562423358189068 1.8432869454409 0 +2964 0.139783290293122 1.413377267398353 0 +2965 0.5059168037108632 1.210966574162367 0 +2966 0.9627188401443481 1.300879784144581 0 +2967 0.6256103969305474 1.212577837401355 0 +2968 0.6396092692040855 1.280062400062568 0 +2969 0.5108549774949193 1.380762807316125 0 +2970 0.4754842164347899 1.603860222672949 0 +2971 0.5865312105343015 1.213780047669135 0 +2972 0.5197036992944831 1.550057860136427 0 +2973 0.7565197816282374 1.273245964088608 0 +2974 0.669441119550221 1.038203411750297 0 +2975 0.3540322828027791 1.684665699136207 0 +2976 0.6517581883220046 1.008492155829824 0 +2977 0.5691847589677379 1.131926591328444 0 +2978 0.8520749092523603 1.216565017547173 0 +2979 0.245041177210246 1.102009041037153 0 +2980 0.7549588227885721 1.10200904103767 0 +2981 0.1687457570057113 1.038890074445489 0 +2982 0.8312542429934928 1.038890074445692 0 +2983 0.2150117449697836 1.343560298824328 0 +2984 0.5727369439349044 1.212434662436378 0 +2985 0.1486844917117769 1.072846993073355 0 +2986 0.8513155082875328 1.072846993073695 0 +2987 0.05066018734083652 1.111583933031004 0 +2988 0.9493398126589245 1.111583933031389 0 +2989 0.4738127501998672 1.007777170474894 0 +2990 0.4638867003580509 1.23482263867288 0 +2991 0.08509556623336824 1.094025068364532 0 +2992 0.914904433766248 1.094025068364932 0 +2993 0.4083790916147616 1.241960094296454 0 +2994 0.023126928441822 1.10434887292641 0 +2995 0.9768730715581555 1.104348872926719 0 +2996 0.7585948900196794 1.316973963537439 0 +2997 0.5277256008226907 1.817768339721885 0 +2998 0.05277075708106999 1.638569102353637 0 +2999 0.4722958244960483 1.815883283342398 0 +3000 0.5919748108151146 1.248655678130806 0 +3001 0.563904581036356 1.24646745469932 0 +3002 0.5721997142445416 1.066591218563173 0 +3003 0.2411852616459803 1.317872777849692 0 +3004 0.4656511314133543 1.071543853460532 0 +3005 0.8536572713768893 1.485734191864946 0 +3006 0.04386648853438674 1.128024996133643 0 +3007 0.9561335114654953 1.128024996134196 0 +3008 0.6656225556681139 1.072308396739774 0 +3009 0.5346942907787386 1.037653085450848 0 +3010 0.8996766960574626 1.273519081010038 0 +3011 0.3760461421166644 1.14203785168324 0 +3012 0.5923730281933391 1.225773671479444 0 +3013 0.6950838193504395 1.289250989136105 0 +3014 0.9277301935827389 1.410727321862892 0 +3015 0.01425619637161279 1.337993856531098 0 +3016 0.1268847150106371 1.036729374781617 0 +3017 0.8731152849887862 1.03672937478179 0 +3018 0.007184981342944966 1.070446308651112 0 +3019 0.9928150186570717 1.070446308651146 0 +3020 0.08301135678927161 1.619174077059818 0 +3021 0.1350641264306794 1.655505290657749 0 +3022 0.343649248194673 1.031519522871835 0 +3023 0.6561529096541532 1.664717783008989 0 +3024 0.2153408786467667 1.789060710940457 0 +3025 0.5283355554849416 1.626030870171568 0 +3026 0.8086506427207933 1.459174070375985 0 +3027 0.4325026230958671 1.197699402322915 0 +3028 0.3196200499000456 1.064656542761854 0 +3029 0.4766397570759809 1.13736176667146 0 +3030 0.8962631750176243 1.367573939183772 0 +3031 0.5646001166653036 1.09699861929293 0 +3032 0.8283473967654937 1.968756677361399 0 +3033 0.2488027758056946 1.052120662120708 0 +3034 0.7511972241930638 1.052120662120992 0 +3035 0.03449560440918616 1.409590061744054 0 +3036 0.03234385620274027 1.053648608877618 0 +3037 0.9676561437971113 1.053648608877871 0 +3038 0.8243671588058238 1.211170154749401 0 +3039 0.6063319893559447 1.041302717781211 0 +3040 0.7326631503079906 1.971443705262739 0 +3041 0.2448743378295132 1.560307426103444 0 +3042 0.01031025244203183 1.259205503589445 0 +3043 0.2732763841695959 1.824579650613156 0 +3044 0.3949999999989889 1.006186390128424 0 +3045 0.06992465491520286 1.038178687399459 0 +3046 0.9300753450844766 1.038178687399638 0 +3047 0.5691927449047119 1.176963720889049 0 +3048 0.9137031986228519 1.298220106732654 0 +3049 0.5188574978259263 1.365754714061371 0 +3050 0.1808549052854008 1.078985605576947 0 +3051 0.8191450947137375 1.078985605577343 0 +3052 0.4817543709022503 1.886620100613878 0 +3053 0.1430618692927851 1.292639888679988 0 +3054 0.4896555122344977 1.110549679469188 0 +3055 0.4167122512742489 1.092077549886636 0 +3056 0.2477681380125178 1.185940834102218 0 +3057 0.7516176761805692 1.188855558619292 0 +3058 0.525159797985966 1.262896680099059 0 +3059 0.5108484182387665 1.088651374499793 0 +3060 0.09519057953687871 1.105174788481823 0 +3061 0.9048094204626493 1.105174788482245 0 +3062 0.6084193557325153 1.092149451475219 0 +3063 0.1744439120200208 1.189798286279298 0 +3064 0.8256765393983146 1.189815303228186 0 +3065 0.5333200847319234 1.133223623703243 0 +3066 0.1625126094875615 1.126211184181588 0 +3067 0.8374873905116891 1.12621118418218 0 +3068 0.9778092512520943 1.663863982149331 0 +3069 0.9890259381809722 1.259283245499479 0 +3070 0.2483610069204623 1.409895736065413 0 +3071 0.7757032537319577 1.354718911044039 0 +3072 0.5051685427161808 1.160262277088137 0 +3073 0.6015914929550168 1.471833964526196 0 +3074 0.6792252844697816 1.064084293976676 0 +3075 0.9884326960502201 1.313922519630678 0 +3076 0.0139118243533851 1.288121636845902 0 +3077 0.1342071476805902 1.39511707821149 0 +3078 0.3560261102775857 1.019788252760427 0 +3079 0.7806453492297647 1.255856604395591 0 +3080 0.5769885878843717 1.287508155013099 0 +3081 0.1173874186482801 1.084274523900702 0 +3082 0.882612581351178 1.084274523901069 0 +3083 0.00806496745244023 1.134658772172711 0 +3084 0.9919350325475937 1.134658772172714 0 +3085 0.527251628600046 1.064497557856977 0 +3086 0.4389524981478167 1.724078550811674 0 +3087 0.2673056920737841 1.01916137998082 0 +3088 0.7326950108266191 1.019163011303326 0 +3089 0.1196404715671867 1.196978877903997 0 +3090 0.8803732485876892 1.196833089850386 0 +3091 0.3402262158203494 1.613381801607067 0 +3092 0.6327965722852348 1.057805386184732 0 +3093 0.1082870743162082 1.232545634267622 0 +3094 0.8903241465952066 1.232584625306276 0 +3095 0.5160854486318447 1.199201570735223 0 +3096 0.4935952205291088 1.381116981666005 0 +3097 0.4580611159534282 1.354146572321462 0 +3098 0.3203927006214325 1.205041968754728 0 +3099 0.3369285798395966 1.51983270192779 0 +3100 0.5738957072541291 1.080892664656557 0 +3101 0.02564675784061751 1.940935266982317 0 +3102 0.5563469206617435 1.180255253164846 0 +3103 0.5342318724930822 1.177959414086585 0 +3104 0.977851952651616 1.942433433047928 0 +3105 0.9548156334290567 1.555163419917335 0 +3106 0.4935088971581665 1.573002079157671 0 +3107 0.4819207276268959 1.733425113031843 0 +3108 0.3407816120832692 1.103247199885626 0 +3109 0.6916026094480439 1.016549442489436 0 +3110 0.6786146719856003 1.201983593413454 0 +3111 0.3397275553349474 1.405309652147826 0 +3112 0.1168482866720272 1.283593747167385 0 +3113 0.5522251618207119 1.668398118713792 0 +3114 0.01866911726931404 1.541357935534568 0 +3115 0.6571871406462103 1.38011885104343 0 +3116 0.04503158955520244 1.170572547495972 0 +3117 0.9549684104449003 1.170572547496162 0 +3118 0.2557078616171862 1.039402252270771 0 +3119 0.7442921383815413 1.039402252270988 0 +3120 0.5102501236251781 1.072924854548012 0 +3121 0.1830505217902794 1.035977421339592 0 +3122 0.8169494782088537 1.035977421339776 0 +3123 0.7864855977004328 1.584813853419071 0 +3124 0.3836099480954295 1.17658714223066 0 +3125 0.9247170673415271 1.934275735722023 0 +3126 0.8216804848988943 1.579023426114137 0 +3127 0.5375476215549428 1.395942193947957 0 +3128 0.983894979504826 1.616556882338917 0 +3129 0.01361459294112605 1.312162164333579 0 +3130 0.5901184300976519 1.05033213873507 0 +3131 0.3319390836597085 1.291497935268903 0 +3132 0.2692598039677995 1.128877634537583 0 +3133 0.7307401960308807 1.128877634538257 0 +3134 0.4387981964658876 1.450306876884706 0 +3135 0.7807862651967983 1.687060803211409 0 +3136 0.811921678756286 1.246976682626123 0 +3137 0.3082237111666897 1.199540952657979 0 +3138 0.129221549014606 1.707246115945004 0 +3139 0.05753608738565197 1.062546543703425 0 +3140 0.9424639126140871 1.062546543703724 0 +3141 0.6056269987996351 1.224889647719344 0 +3142 0.6171287739428702 1.499791194399139 0 +3143 0.3908909555231866 1.489171294372845 0 +3144 0.6899962074720175 1.151597858236175 0 +3145 0.6519255697344501 1.03693816942329 0 +3146 0.5074293651199127 1.304053821727486 0 +3147 0.5215234172640134 1.047804460135949 0 +3148 0.3328287390886212 1.007314251533086 0 +3149 0.04732195063439883 1.060414287106749 0 +3150 0.9526780493653854 1.06041428710704 0 +3151 0.8867525443896362 1.556301636063413 0 +3152 0.06093920632468015 1.259535880913286 0 +3153 0.9400277719465432 1.258466329961994 0 +3154 0.2727400831869887 1.035021932662409 0 +3155 0.7272610743680831 1.035024619165739 0 +3156 0.8000458441502241 1.552048167523651 0 +3157 0.2626018840923422 1.301730190049869 0 +3158 0.5938962921612817 1.287343204782929 0 +3159 0.6144647121034461 1.054176326377833 0 +3160 0.7109935583627558 1.236642448408669 0 +3161 0.6503770169861024 1.776238969636014 0 +3162 0.3689970102233768 1.419232408619065 0 +3163 0.1991368022996508 1.128158094087197 0 +3164 0.8008631976994559 1.128158094087744 0 +3165 0.4461234879444902 1.251654153102093 0 +3166 0.3488661277688836 1.065419082809585 0 +3167 0.1084650573628514 1.929370864879122 0 +3168 0.5968960135416668 1.182282884876324 0 +3169 0.05138321987055499 1.078420724844972 0 +3170 0.9486167801292066 1.07842072484534 0 +3171 0.0768551969104051 1.044900551095555 0 +3172 0.9231448030892382 1.044900551095754 0 +3173 0.2570569366579989 1.066492380718779 0 +3174 0.7429430633407019 1.066492380719129 0 +3175 0.4462224994270425 1.180969742895069 0 +3176 0.09529286085030653 1.00589644543045 0 +3177 0.9047071391492654 1.005896445430478 0 +3178 0.7456350106586379 1.713519378105063 0 +3179 0.6324965072722788 1.616098206620357 0 +3180 0.0629597511616016 1.4078490409302 0 +3181 0.4833184993769563 1.367211055954118 0 +3182 0.1255715808812676 1.271148283596247 0 +3183 0.6057443555806847 1.24950644111779 0 +3184 0.8357602795041208 1.406631966224829 0 +3185 0.5550842866693007 1.636435289785549 0 +3186 0.09414434791989254 1.790702000193611 0 +3187 0.5157281617783732 1.923307188108359 0 +3188 0.6720638557582501 1.130779821161272 0 +3189 0.328192256142683 1.130808552033188 0 +3190 0.3517434032218137 1.424249783418309 0 +3191 0.3527477330069914 1.120507780423974 0 +3192 0.4872485957573031 1.007282680270751 0 +3193 0.03409965238293022 1.328100681348105 0 +3194 0.0954292114452118 1.504738095527319 0 +3195 0.9603647236363801 1.315972961010941 0 +3196 0.1504729406623461 1.258654812487545 0 +3197 0.1812196332426186 1.149884495876465 0 +3198 0.8187803667565179 1.149884495877156 0 +3199 0.387402898774831 1.655896828773865 0 +3200 0.0833702224214898 1.118761363533847 0 +3201 0.9166297775780697 1.118761363534233 0 +3202 0.4570467116506835 1.13890331288479 0 +3203 0.1798211720443132 1.227337100491445 0 +3204 0.2330543235285779 1.368262934601518 0 +3205 0.6684354299502232 1.244558505905119 0 +3206 0.9630821497747226 1.370609234330091 0 +3207 0.2231974482046011 1.703892597686964 0 +3208 0.3638086633157411 1.79243002479231 0 +3209 0.5144021826391417 1.125798696890056 0 +3210 0.5744828690993622 1.190910489983869 0 +3211 0.3375001410928807 1.587886584278393 0 +3212 0.1987350984166321 1.04293738526427 0 +3213 0.8012649015824096 1.042937385264484 0 +3214 0.2280888770562281 1.084588852068885 0 +3215 0.7719111229426404 1.0845888520693 0 +3216 0.4054739274688711 1.324755863999675 0 +3217 0.06792047649371237 1.554097630831343 0 +3218 0.007535419928601936 1.018047378716409 0 +3219 0.9924645800714075 1.018047378716426 0 +3220 0.3673819377160927 1.398266056710684 0 +3221 0.7818576873512124 1.936563062155973 0 +3222 0.5528943640275946 1.92910980076308 0 +3223 0.5849999999989093 1.005856846430483 0 +3224 0.3943527091754409 1.880650961906487 0 +3225 0.4015953078583649 1.255912512555445 0 +3226 0.1373548290263226 1.007265818576075 0 +3227 0.8626451709730468 1.007265818576111 0 +3228 0.09116023977412796 1.197402322467753 0 +3229 0.9088397602262499 1.197402322468015 0 +3230 0.8808737026395025 1.679065208580525 0 +3231 0.9818451098120242 1.570174690384008 0 +3232 0.6452701898085627 1.512733594267466 0 +3233 0.2109842094649221 1.128432967414724 0 +3234 0.7890157905340743 1.128432967415335 0 +3235 0.599792891143665 1.063632734623389 0 +3236 0.6484123132631934 1.971605866385381 0 +3237 0.2447919070273138 1.926088229783505 0 +3238 0.450307194806208 1.093155611215732 0 +3239 0.6100404642133814 1.681903352546578 0 +3240 0.2514389730132617 1.014925222293766 0 +3241 0.7485610269854809 1.014925222293852 0 +3242 0.100116319480411 1.278917540673539 0 +3243 0.01772922761894232 1.007325404425178 0 +3244 0.982270772380972 1.007325404425215 0 +3245 0.5228728054664999 1.490253936602415 0 +3246 0.9631620618938812 1.259157658753812 0 +3247 0.2884806280357811 1.316593915072292 0 +3248 0.108555964838203 1.763308780820249 0 +3249 0.9110456767109114 1.39566361124855 0 +3250 0.8609988706993663 1.39449186391711 0 +3251 0.6834128035072389 1.02967843855267 0 +3252 0.3942242479494591 1.100336880972016 0 +3253 0.8672750832498555 1.737373605948202 0 +3254 0.3747562945077673 1.525148240497036 0 +3255 0.5800814497723821 1.820990227185569 0 +3256 0.512191942055147 1.441723341921217 0 +3257 0.4685658406491702 1.223155864668977 0 +3258 0.3035246264202507 1.071847717736612 0 +3259 0.6964746773281726 1.071857809090415 0 +3260 0.4082320930339532 1.075297362325028 0 +3261 0.02688986498945056 1.973803112790762 0 +3262 0.6851172043158067 1.164691335073097 0 +3263 0.5173652678789619 1.037638953672481 0 +3264 0.3911657977937508 1.57747666268882 0 +3265 0.437226486899446 1.398532019878076 0 +3266 0.6655516511764876 1.091787882046644 0 +3267 0.6167967266508756 1.062772820990088 0 +3268 0.5115510027143241 1.40779010973734 0 +3269 0.4846200438021683 1.034624527229878 0 +3270 0.5225735131104832 1.007217457510104 0 +3271 0.7365809388968274 1.78872584446839 0 +3272 0.7264550942049537 1.206031009138789 0 +3273 0.3504445707876621 1.862663860251722 0 +3274 0.3176281866336297 1.078751181522546 0 +3275 0.9020423040412049 1.810672121032276 0 +3276 0.5367419398648408 1.975933810218964 0 +3277 0.6817970649120719 1.079050214642001 0 +3278 0.2818390363859189 1.634346310360678 0 +3279 0.1993363667631902 1.089043558599542 0 +3280 0.8006636332358396 1.089043558599996 0 +3281 0.08216408759383684 1.543447877111605 0 +3282 0.4876193332552141 1.39398541827866 0 +3283 0.3021254111464436 1.591664995638674 0 +3284 0.4332148415046728 1.115380684815047 0 +3285 0.8011616831837557 1.227864360594381 0 +3286 0.05150173648886018 1.365751872087153 0 +3287 0.05496532722173433 1.087790175814136 0 +3288 0.9450346727780148 1.087790175814522 0 +3289 0.8046681234373696 1.398158704725539 0 +3290 0.3716515453920619 1.132008949871995 0 +3291 0.4436253645251734 1.308932810813298 0 +3292 0.1567249985220825 1.303126721918028 0 +3293 0.2119612090454667 1.078862919788726 0 +3294 0.788038790953479 1.078862919789108 0 +3295 0.5287483998655658 1.201133640701046 0 +3296 0.1953934959633296 1.800585142953776 0 +3297 0.3329286130332294 1.069965486168997 0 +3298 0.1890305360675689 1.208790671736525 0 +3299 0.9863232835077604 1.417637323875256 0 +3300 0.8111045693236416 1.209109535736351 0 +3301 0.2952620017437567 1.73795060515094 0 +3302 0.5844577581782607 1.125248008426799 0 +3303 0.06699969367602422 1.973950957333384 0 +3304 0.6996120227799911 1.592213307705401 0 +3305 0.2710897475875159 1.212576065116549 0 +3306 0.3405034597220026 1.345869520149519 0 +3307 0.1108030029593558 1.451988335699398 0 +3308 0.500799891083604 1.049420773155815 0 +3309 0.2906510912121534 1.108637813366452 0 +3310 0.7093474260716455 1.108631973383058 0 +3311 0.2010123075764172 1.147487766175482 0 +3312 0.798987692422616 1.14748776617616 0 +3313 0.826688336333459 1.92888481794781 0 +3314 0.9795673785300706 1.87009030098262 0 +3315 0.7905473666463739 1.27220986997835 0 +3316 0.2357693226741448 1.244876444268079 0 +3317 0.2611451541911151 1.025096393635785 0 +3318 0.7388549055781257 1.025096532353825 0 +3319 0.1598032433397236 1.01564159402556 0 +3320 0.8401967566595286 1.015641594025636 0 +3321 0.5482267760596211 1.07091720347627 0 +3322 0.4603265623720626 1.10566782343086 0 +3323 0.8128238314900005 1.233334246915742 0 +3324 0.06918292525897446 1.024830488032454 0 +3325 0.9308170747407107 1.02483048803257 0 +3326 0.4891905190310432 1.501089275758627 0 +3327 0.2088923788488783 1.109401317328674 0 +3328 0.7911076211501032 1.109401317329208 0 +3329 0.4476907357909223 1.236656321651996 0 +3330 0.2384340455037524 1.015645184473918 0 +3331 0.7615659544950655 1.015645184474004 0 +3332 0.1717029994476514 1.76308633455751 0 +3333 0.09878093785477732 1.671811964238785 0 +3334 0.05852527067152707 1.893830306377398 0 +3335 0.2154333678200377 1.118672299555085 0 +3336 0.7845666321789101 1.118672299555677 0 +3337 0.7826168377499634 1.563388436481977 0 +3338 0.2399148794890117 1.139849865553041 0 +3339 0.760085120509796 1.139849865553748 0 +3340 0.3197387254935056 1.015577470125447 0 +3341 0.02290988530190512 1.127767827692133 0 +3342 0.9770901146980855 1.127767827692361 0 +3343 0.9144884833438447 1.580630296320076 0 +3344 0.7582471540832618 1.893180163732064 0 +3345 0.3958976534938686 1.336111057882065 0 +3346 0.2504290210198446 1.19685920954506 0 +3347 0.5972281283801204 1.393815674192034 0 +3348 0.3243972542043328 1.098375867099081 0 +3349 0.4364884558366192 1.176171039439213 0 +3350 0.5491557813727068 1.125180806256856 0 +3351 0.4485899667673183 1.292994584986844 0 +3352 0.4966485986285446 1.191401331987999 0 +3353 0.6769786063985447 1.602502563725125 0 +3354 0.01590092057013676 1.589100026142832 0 +3355 0.6663630627943343 1.40889341389736 0 +3356 0.4465789624835255 1.158041621658539 0 +3357 0.01096305085370147 1.204978893887839 0 +3358 0.9890332695653414 1.204983006097456 0 +3359 0.2181960273169638 1.087167666927751 0 +3360 0.7818039726819552 1.087167666928174 0 +3361 0.3819039224720535 1.678858935696413 0 +3362 0.4240970366724922 1.215193883679644 0 +3363 0.6175372411393172 1.120867798488144 0 +3364 0.4232289133408755 1.067042764364448 0 +3365 0.3552072740681218 1.229404329850605 0 +3366 0.8964261094839023 1.258096658286262 0 +3367 0.2410668958067194 1.35511889244404 0 +3368 0.7410073833120006 1.517210704860221 0 +3369 0.1015642853061831 1.077215086769173 0 +3370 0.8984357146933604 1.077215086769501 0 +3371 0.87423075168225 1.435663082966889 0 +3372 0.2180049918670429 1.227991809881748 0 +3373 0.3454827963716899 1.021250461549208 0 +3374 0.3405572513913834 1.373580185585569 0 +3375 0.9497330244707272 1.627431129941743 0 +3376 0.4843557358232279 1.075498616911013 0 +3377 0.1104334301987898 1.038999631064801 0 +3378 0.8895665698007126 1.038999631064975 0 +3379 0.5371184194812646 1.190643155657833 0 +3380 0.8674604237820186 1.40726502586251 0 +3381 0.9333976026334944 1.282300546644999 0 +3382 0.6635002694408094 1.288088041356226 0 +3383 0.3698955874986868 1.751650569587373 0 +3384 0.2478470676590287 1.266601140011721 0 +3385 0.2885465939407976 1.058533238226147 0 +3386 0.7114521347767127 1.058534591979638 0 +3387 0.6408881521849427 1.425101619183517 0 +3388 0.6205418457006967 1.784662738757029 0 +3389 0.9597931365074216 1.404995181653994 0 +3390 0.3479137315077679 1.048741248520458 0 +3391 0.6281021459750666 1.177526093208538 0 +3392 0.5087762837353165 1.479649815375283 0 +3393 0.6129725745998538 1.192891460410892 0 +3394 0.4843032540716811 1.117013150750152 0 +3395 0.5894942450144165 1.717213425674467 0 +3396 0.2811007451854533 1.328687873866109 0 +3397 0.0481970082316495 1.527638884897945 0 +3398 0.3041919914100624 1.317860170772724 0 +3399 0.465052269653499 1.151583245073708 0 +3400 0.659062180797968 1.436698428999367 0 +3401 0.4047826830865794 1.542762183560312 0 +3402 0.5811751294515943 1.578003582966232 0 +3403 0.2576136794541315 1.495479737346622 0 +3404 0.3261839495667986 1.147107492901612 0 +3405 0.2376404095466362 1.743486228457745 0 +3406 0.3144749045067853 1.146986360641986 0 +3407 0.6721234722177283 1.148186400155432 0 +3408 0.7112372582173553 1.461516486200024 0 +3409 0.5547495100789241 1.740228009198139 0 +3410 0.7014254649630004 1.242934715824348 0 +3411 0.6034081285762425 1.325486171652366 0 +3412 0.6023628438069728 1.00711733848612 0 +3413 0.0174668220678606 1.059153328591893 0 +3414 0.98253317793206 1.059153328592128 0 +3415 0.1001622034396336 1.638145707490015 0 +3416 0.5934395717344421 1.534295943842678 0 +3417 0.3514196151484461 1.035787680836533 0 +3418 0.3353368883367572 1.017092770800198 0 +3419 0.7558068228073598 1.240838779012502 0 +3420 0.3762179157166683 1.006366397263434 0 +3421 0.09814012677165353 1.354464798106319 0 +3422 0.1166734194565906 1.873407271153148 0 +3423 0.2775222016458004 1.67775024304368 0 +3424 0.5090701820652053 1.064101013467267 0 +3425 0.4380390029231114 1.068670241233897 0 +3426 0.2692417742604845 1.18480014255584 0 +3427 0.938878693099089 1.466362381175177 0 +3428 0.3289160207592189 1.480440233983258 0 +3429 0.5233518900161606 1.104746243006703 0 +3430 0.6786716270195868 1.730439760606658 0 +3431 0.4997809480034809 1.060097429096916 0 +3432 0.3429920094868641 1.148653447083821 0 +3433 0.2988580108151219 1.936614550033135 0 +3434 0.5719975625939232 1.459912075440698 0 +3435 0.4051865417124261 1.129081687748491 0 +3436 0.3800172913440857 1.439297311671019 0 +3437 0.5901655016968097 1.642448469414646 0 +3438 0.6150361718738336 1.015579681456306 0 +3439 0.7902205990961959 1.707646183607716 0 +3440 0.2227549278958273 1.42021165067592 0 +3441 0.4847904019058026 1.223755863520104 0 +3442 0.7738480593455063 1.292288261325042 0 +3443 0.2928362794077691 1.069860564226422 0 +3444 0.7071636010856959 1.069861259386334 0 +3445 0.3916900167160449 1.070950199263994 0 +3446 0.03749464110598471 1.068231659119322 0 +3447 0.9625053588938317 1.068231659119643 0 +3448 0.7480293253519303 1.378655208441889 0 +3449 0.4196103399279165 1.550893293224064 0 +3450 0.653602791360656 1.195514677654681 0 +3451 0.6473361992378349 1.408969452274825 0 +3452 0.6268843430737454 1.064253542939533 0 +3453 0.3571204019552967 1.577198709485106 0 +3454 0.1844864296369261 1.090689842400813 0 +3455 0.8155135703622025 1.09068984240127 0 +3456 0.8321671514816793 1.290544088597883 0 +3457 0.7863394973346897 1.749100410726242 0 +3458 0.6571961095490539 1.14874754959908 0 +3459 0.6680400151237824 1.569072758798816 0 +3460 0.4588826252608314 1.039093390957258 0 +3461 0.09515771641627446 1.251167921301461 0 +3462 0.08306683781945828 1.23197070986715 0 +3463 0.9174424294663507 1.231911766594472 0 +3464 0.6973989846567398 1.770303600056921 0 +3465 0.8981056792986919 1.978069544004005 0 +3466 0.01963503176068615 1.045296734671473 0 +3467 0.9803649682392119 1.045296734671636 0 +3468 0.6343198850360702 1.093982585968916 0 +3469 0.846123505726555 1.899741734412523 0 +3470 0.5875650233043492 1.34227845560329 0 +3471 0.1722428243022023 1.293884692361587 0 +3472 0.6558854873807516 1.018190495697559 0 +3473 0.1401014349488895 1.801094660770332 0 +3474 0.3149848617711298 1.808422376880731 0 +3475 0.2709654909876248 1.602613614919684 0 +3476 0.4698008433826563 1.027686334865186 0 +3477 0.4555699947156926 1.022462450882871 0 +3478 0.6501996604148074 1.247416108036392 0 +3479 0.4587301615698488 1.161785863613254 0 +3480 0.8843798766461722 1.606556369100036 0 +3481 0.9206519163356471 1.693860615479304 0 +3482 0.1395514983175823 1.890076788006392 0 +3483 0.1007648067561446 1.087211677028428 0 +3484 0.8992351932434027 1.087211677028789 0 +3485 0.5766536371225803 1.542787593440706 0 +3486 0.9425902390686477 1.790813820424234 0 +3487 0.484412341942826 1.254974000759067 0 +3488 0.5537950841653287 1.021998433999045 0 +3489 0.6753004817709786 1.097568191795797 0 +3490 0.08003973351973072 1.150321960814463 0 +3491 0.9199602664800985 1.150321960814688 0 +3492 0.437772577021237 1.007316262550134 0 +3493 0.1102449168148291 1.031450302135144 0 +3494 0.8897550831846768 1.031450302135283 0 +3495 0.6982254137443059 1.036468820878717 0 +3496 0.9049789089191164 1.893557602454206 0 +3497 0.983779307830536 1.53344595164815 0 +3498 0.3411356427147726 1.245941926817336 0 +3499 0.4380519751604537 1.138637371239702 0 +3500 0.4293840250942337 1.158378521754898 0 +3501 0.2095107000952364 1.201043462151233 0 +3502 0.7919509552403152 1.201240915608389 0 +3503 0.6352028625784758 1.340841067836265 0 +3504 0.2146664341625092 1.92655386427022 0 +3505 0.2069260770694621 1.429597418627997 0 +3506 0.7611595662710799 1.216502897994214 0 +3507 0.4776534665566543 1.202389080691948 0 +3508 0.2902820172938113 1.122729420392723 0 +3509 0.7085040987738541 1.121827602812405 0 +3510 0.3530871567915889 1.088317763317803 0 +3511 0.3349201889869245 1.031312343878436 0 +3512 0.6751625537240049 1.005798773826823 0 +3513 0.7914802485291386 1.235296651115997 0 +3514 0.3168910356000915 1.03025475684214 0 +3515 0.6441582404671261 1.564583774303305 0 +3516 0.8331273470687306 1.847890874385971 0 +3517 0.399519045865631 1.041120517708164 0 +3518 0.03473408805806461 1.162488465326634 0 +3519 0.9652659119420296 1.162488465326853 0 +3520 0.2753178141746124 1.699300463141148 0 +3521 0.7996705151115917 1.42162684192093 0 +3522 0.3948583317449131 1.832898006773385 0 +3523 0.4051899320517516 1.205023038313091 0 +3524 0.1730289932302166 1.055646907007213 0 +3525 0.8269710067689444 1.055646907007487 0 +3526 0.4167386967774511 1.142383814385919 0 +3527 0.2534335141841533 1.211534759049977 0 +3528 0.2892681033400714 1.273049070876271 0 +3529 0.6559020630407286 1.122323379276284 0 +3530 0.6461416050724172 1.94208714482203 0 +3531 0.5653779597327737 1.121405787662119 0 +3532 0.3411153733126749 1.134187790291718 0 +3533 0.8811593514390166 1.320498651465222 0 +3534 0.1627579894207498 1.043410481515311 0 +3535 0.8372420105784895 1.04341048151553 0 +3536 0.3296517228892288 1.26599735329134 0 +3537 0.2377892474125629 1.442383921569851 0 +3538 0.388485899419214 1.217082993152809 0 +3539 0.8140333817965677 1.333993414816485 0 +3540 0.1062417413395645 1.381117748752468 0 +3541 0.2058515616040358 1.040851576815887 0 +3542 0.7941484383949681 1.040851576816092 0 +3543 0.6588642651974014 1.133585379420104 0 +3544 0.2815704390999333 1.444724017359413 0 +3545 0.7317971967093438 1.183826750392547 0 +3546 0.977682835759688 1.790952244804448 0 +3547 0.3646057498401418 1.059750338621733 0 +3548 0.1140906556321777 1.10923611967774 0 +3549 0.8859093443673214 1.109236119678237 0 +3550 0.5737089219458529 1.026701930556001 0 +3551 0.01593804205633383 1.516922257314523 0 +3552 0.3542540793114067 1.057840347089792 0 +3553 0.2854878263631779 1.229561060961588 0 +3554 0.6282629366364416 1.379396311457203 0 +3555 0.9090289363014198 1.25098675650324 0 +3556 0.1741083042007428 1.01860460643868 0 +3557 0.825891695798434 1.018604606438775 0 +3558 0.03370804538886642 1.023953741796655 0 +3559 0.9662919546109878 1.023953741796745 0 +3560 0.6836072807357017 1.508910911481828 0 +3561 0.2817889717361773 1.129942981485395 0 +3562 0.7176589047751682 1.130652108074175 0 +3563 0.4677834778301914 1.112979992944748 0 +3564 0.05558686898080113 1.928352825544404 0 +3565 0.04126891334462752 1.018097398399427 0 +3566 0.9587310866551901 1.018097398399501 0 +3567 0.09700619895850418 1.123835039323161 0 +3568 0.9029938010410837 1.123835039323633 0 +3569 0.5412554796599491 1.483028221533746 0 +3570 0.06977836143942963 1.784494093273558 0 +3571 0.2482739808787649 1.061052950192396 0 +3572 0.7517260191199873 1.061052950192721 0 +3573 0.3016470822365043 1.036493794165518 0 +3574 0.4367080026693275 1.027480258100142 0 +3575 0.2427753571367029 1.383832058237941 0 +3576 0.4697954446095487 1.18416002885769 0 +3577 0.418550494264734 1.72072788459907 0 +3578 0.3767074276250206 1.297085635051434 0 +3579 0.5523045785179248 1.328583603308685 0 +3580 0.7090228145462598 1.626924018112197 0 +3581 0.7928103222533652 1.247212174813187 0 +3582 0.1201350955041923 1.469865911101082 0 +3583 0.4740929977510073 1.244521438086098 0 +3584 0.630647737843554 1.649600152279288 0 +3585 0.5068463572759233 1.276651265597622 0 +3586 0.3721498168015352 1.03775577992918 0 +3587 0.401066927702555 1.016671804325887 0 +3588 0.005923383227509598 1.005914545855086 0 +3589 0.9940766167724477 1.00591454585511 0 +3590 0.6210413740287497 1.036419165428128 0 +3591 0.1238625823073719 1.845542783648374 0 +3592 0.6380740927560531 1.073146361370302 0 +3593 0.09122703911367487 1.452502287491005 0 +3594 0.6139468223323165 1.613123690945158 0 +3595 0.4110692920437905 1.031638099411708 0 +3596 0.1330582078797185 1.097553478406364 0 +3597 0.8669417921196629 1.097553478406802 0 +3598 0.04249420581981359 1.571526887013898 0 +3599 0.983424162642857 1.7359747604416 0 +3600 0.5510487332079945 1.052480995777755 0 +3601 0.2750692880072463 1.507372080548963 0 +3602 0.05207715141902639 1.006663833637992 0 +3603 0.9479228485807419 1.00666383363803 0 +3604 0.1603978431610944 1.359059036118489 0 +3605 0.7981532595091231 1.293389720552514 0 +3606 0.2741965150060367 1.006069577356058 0 +3607 0.7258019266366019 1.006070306001924 0 +3608 0.1544166481291382 1.030787298497688 0 +3609 0.845583351870145 1.030787298497841 0 +3610 0.04499999999991076 1.005181727692826 0 +3611 0.9549999999998793 1.005181727692858 0 +3612 0.255261213941851 1.666555804920243 0 +3613 0.9320632731088294 1.882758610376341 0 +3614 0.8214165569659956 1.362972306855893 0 +3615 0.8098145951361866 1.286315323436256 0 +3616 0.1189674645655133 1.244611184042298 0 +3617 0.8000997346482217 1.917995364246386 0 +3618 0.02216819238028278 1.074351397824639 0 +3619 0.9778318076196503 1.074351397824938 0 +3620 0.06057652630742353 1.071310610022351 0 +3621 0.9394234736923081 1.071310610022691 0 +3622 0.114173890125833 1.005930176213363 0 +3623 0.8858261098736577 1.005930176213386 0 +3624 0.0168750995561915 1.834395284024228 0 +3625 0.8986538148937213 1.456154498699989 0 +3626 0.4321410576495865 1.096459156163836 0 +3627 0.3662009872095671 1.642313958192046 0 +3628 0.4840319615930496 1.929826164855367 0 +3629 0.4198440208489874 1.326853272864602 0 +3630 0.6209757878940695 1.156061567100777 0 +3631 0.4634346414820441 1.382216499943817 0 +3632 0.5372234098869028 1.02926276883579 0 +3633 0.2883335895161532 1.380955355336657 0 +3634 0.07390845062452635 1.28208204792465 0 +3635 0.06134577333507334 1.657024493986289 0 +3636 0.4638553569109516 1.642497218435722 0 +3637 0.07318727077568837 1.006462358097645 0 +3638 0.9268127292239882 1.006462358097674 0 +3639 0.1394636436600802 1.166522500867852 0 +3640 0.8605363563392858 1.166522500868656 0 +3641 0.9118112497793394 1.339165287757585 0 +3642 0.3090180435720458 1.403959173181105 0 +3643 0.6217168144006515 1.079251694787047 0 +3644 0.09064724888580444 1.178623679863882 0 +3645 0.9093527511143016 1.178623679864107 0 +3646 0.3208003819789911 1.217529921408278 0 +3647 0.6928745603043144 1.541725776519078 0 +3648 0.781538321844969 1.790851151988544 0 +3649 0.4951316152892133 0.5030339212978533 0 +3650 0.2886244732561847 0.7156007037294506 0 +3651 0.7129102494425932 0.7140884405189462 0 +3652 0.5028362279978159 0.7804563884614171 0 +3653 0.1649999999996596 0.8349872397416043 0 +3654 0.8349999999995654 0.8349872397408593 0 +3655 0.6948244514151484 0.8581668436046905 0 +3656 0.3021358388535229 0.8588201877135516 0 +3657 0.7458401323067352 0.4625011581215406 0 +3658 0.2483925999474326 0.4697850086330241 0 +3659 0.4263903316078463 0.8798418401842896 0 +3660 0.5749999999988813 0.8790036651228942 0 +3661 0.4113174879493973 0.2576047535418504 0 +3662 0.9049999999997512 0.9049247893465643 0 +3663 0.09499999999982121 0.9049247893469401 0 +3664 0.856209231079759 0.6915727704167853 0 +3665 0.1455292259684953 0.6943359142438685 0 +3666 0.7750747888379776 0.904587420203242 0 +3667 0.2249252111609158 0.9045874202037003 0 +3668 0.5749362622023186 0.6401520365981953 0 +3669 0.4231725631377143 0.6487072992818387 0 +3670 0.7676487163587822 0.231496430181216 0 +3671 0.6197102944137767 0.7738016783877293 0 +3672 0.3807239696609022 0.7752019445502463 0 +3673 0.5974694466505568 0.3307379265962302 0 +3674 0.4949999999987035 0.919157974888827 0 +3675 0.6459644411457188 0.9245255733834724 0 +3676 0.3549645649669458 0.9214844607321835 0 +3677 0.2009354758611708 0.2697683332719191 0 +3678 0.7683108648850818 0.5952571952002692 0 +3679 0.2305668487757493 0.597269547984191 0 +3680 0.845495771981678 0.9364067007132244 0 +3681 0.1545042280175968 0.9364067007135293 0 +3682 0.7149999999992493 0.9341799136392807 0 +3683 0.28499999999931 0.9341799136396252 0 +3684 0.9062209498770519 0.774631996245378 0 +3685 0.09377905012280031 0.7746319962457424 0 +3686 0.3626781676901021 0.5318016578512994 0 +3687 0.7562511088519948 0.793772176441861 0 +3688 0.2436542903674698 0.795551171640378 0 +3689 0.6257012964749211 0.5184769889189909 0 +3690 0.8698790433716355 0.5118555082708378 0 +3691 0.1157981700644633 0.5822914680550753 0 +3692 0.5545973515899792 0.9380214149930235 0 +3693 0.8563853864353832 0.3708125505471475 0 +3694 0.4149999999989309 0.9388963693766798 0 +3695 0.94524644829951 0.9454433778092888 0 +3696 0.05475355170023821 0.9454433778095569 0 +3697 0.4049452164765799 0.3991092806290063 0 +3698 0.1259927821177929 0.4570158420766265 0 +3699 0.4896666308908597 0.8493391618230737 0 +3700 0.5497090931758539 0.1706149798645513 0 +3701 0.6790408133911712 0.6176372252783328 0 +3702 0.3259072895759921 0.625382839186143 0 +3703 0.9281334621414647 0.8401317570596278 0 +3704 0.07186653785839381 0.8401317570599841 0 +3705 0.5040881717607384 0.6906147079459702 0 +3706 0.6356156820135995 0.8611114020578882 0 +3707 0.6049999999989599 0.9502933168442059 0 +3708 0.9009907905490346 0.6053878293494258 0 +3709 0.3659374286579278 0.860716479819049 0 +3710 0.8238596996029721 0.760253126623778 0 +3711 0.1725047735221046 0.762276885081815 0 +3712 0.6880575264864723 0.7883196764072731 0 +3713 0.3129788234815334 0.7883755764708607 0 +3714 0.7954272205075399 0.9505245255190962 0 +3715 0.2045727794914657 0.9505245255193356 0 +3716 0.4358748729283511 0.8112983575217714 0 +3717 0.3061004762108279 0.1516571645800894 0 +3718 0.4454651465872002 0.7431266145830052 0 +3719 0.8951235665832378 0.952551389712281 0 +3720 0.104876433416288 0.9525513897124754 0 +3721 0.4973664589306666 0.6043444702960334 0 +3722 0.635675941920802 0.6953047828117335 0 +3723 0.2903463778211808 0.3516663094691181 0 +3724 0.5636005647979639 0.8128764689249354 0 +3725 0.3631678338440074 0.7009828099912561 0 +3726 0.4650087993149511 0.9552018865863339 0 +3727 0.6749999999991446 0.9551255240219025 0 +3728 0.324999999999193 0.9551255240221453 0 +3729 0.7165942877072025 0.3433047082078004 0 +3730 0.5575658404965225 0.7329484973429717 0 +3731 0.7530698821014418 0.8517336940480875 0 +3732 0.2469301178973254 0.8517336940488369 0 +3733 0.9285652768661607 0.7041780532146942 0 +3734 0.07236531557862763 0.7049504158853144 0 +3735 0.7775720702787963 0.6758952762168193 0 +3736 0.1366028350729405 0.135360653295327 0 +3737 0.8574069800633093 0.8825602793559132 0 +3738 0.1425930199360604 0.8825602793564479 0 +3739 0.5686634993247253 0.4325369528954985 0 +3740 0.2158192146755186 0.700440318206603 0 +3741 0.5155514434375249 0.957428998120037 0 +3742 0.1164327569888408 0.3456839977593948 0 +3743 0.3758001142500348 0.9566022503131829 0 +3744 0.7527511859645537 0.9588800736655889 0 +3745 0.2472488140342155 0.9588800736658142 0 +3746 0.9524010848800437 0.8997866408091254 0 +3747 0.04759891511973552 0.8997866408095306 0 +3748 0.8612551519889815 0.1319248299662935 0 +3749 0.181782084296993 0.5246834197315848 0 +3750 0.8801413916575318 0.2644450571349767 0 +3751 0.421790745351459 0.1383711817579202 0 +3752 0.6772041500205526 0.1344991314131296 0 +3753 0.7036556660790018 0.5458578254283518 0 +3754 0.5283585586688625 0.8798219657305826 0 +3755 0.6639331689519016 0.438299996512328 0 +3756 0.4796526162310633 0.3304786862977649 0 +3757 0.5637996632371463 0.5677674687415111 0 +3758 0.8348563129955622 0.6263902654949128 0 +3759 0.4508393998825335 0.9149167069854778 0 +3760 0.1937231399367003 0.3963219546118056 0 +3761 0.4278398459595389 0.577516079733129 0 +3762 0.7294164162809222 0.8913801902987554 0 +3763 0.2705835837177522 0.8913801902992954 0 +3764 0.07060779360940994 0.6349151642951704 0 +3765 0.8135281130272947 0.8739816373222906 0 +3766 0.1864718869718131 0.8739816373228619 0 +3767 0.665591751369725 0.2518137356741437 0 +3768 0.7670539122833595 0.7381687970643054 0 +3769 0.6872565080401121 0.90177259278346 0 +3770 0.3128751529678904 0.901974716272226 0 +3771 0.3333365632516667 0.4513214142859323 0 +3772 0.2940014017147823 0.5563545863694396 0 +3773 0.9119651076512172 0.4358392627416694 0 +3774 0.1037751011725982 0.2434626961035677 0 +3775 0.8825904570425558 0.8439984571807619 0 +3776 0.1174095429570416 0.8439984571815344 0 +3777 0.6054272041488761 0.9099949909096751 0 +3778 0.1675224668898134 0.6276387001943534 0 +3779 0.6385717793163356 0.9649259206122556 0 +3780 0.2596659911204697 0.6571224768690813 0 +3781 0.3928648897728227 0.9041668459325827 0 +3782 0.7940655524770115 0.5237431836180173 0 +3783 0.5742618506961469 0.9664752325858235 0 +3784 0.07536788005301508 0.515579384356057 0 +3785 0.8255117312674655 0.4468580343445921 0 +3786 0.8248485784112995 0.9664166904418687 0 +3787 0.1751514215878712 0.966416690442044 0 +3788 0.3013227367640799 0.2556473472019965 0 +3789 0.8645213772979725 0.9682359970246354 0 +3790 0.1354786227014135 0.9682359970247754 0 +3791 0.4846287120861147 0.4249780695895251 0 +3792 0.9501429847038053 0.79618164310984 0 +3793 0.04985701529619381 0.796181643110295 0 +3794 0.8643808803855763 0.7966081801209282 0 +3795 0.1355638060890303 0.7968660911323436 0 +3796 0.4228453617372052 0.4755961821361328 0 +3797 0.8097289768620304 0.9177264886096514 0 +3798 0.1902710231370594 0.9177264886100629 0 +3799 0.4344943926561243 0.9679991229802747 0 +3800 0.7049999999992214 0.9678133445421923 0 +3801 0.294999999999281 0.9678133445423693 0 +3802 0.6613582499302223 0.7421878119695458 0 +3803 0.6450937109042678 0.8126747722640224 0 +3804 0.7902564822353814 0.8256733897962364 0 +3805 0.2097435177636063 0.8256733897970749 0 +3806 0.3540920651235021 0.8131714863801713 0 +3807 0.720257669311593 0.8193501602877338 0 +3808 0.278744454409672 0.8204085259931641 0 +3809 0.7260715717287158 0.65662305088958 0 +3810 0.3380381450712668 0.7452961044377397 0 +3811 0.9302562727283465 0.5444078473272418 0 +3812 0.9678359677135614 0.9678834693750559 0 +3813 0.03216403228629287 0.9678834693752107 0 +3814 0.6171666438772465 0.5942990561145115 0 +3815 0.5951215241491643 0.841488833808709 0 +3816 0.9249999999997995 0.9691771808678272 0 +3817 0.07499999999985285 0.9691771808679772 0 +3818 0.4763493687147465 0.885348305559029 0 +3819 0.5285532660738312 0.8357397834812883 0 +3820 0.9436188907219221 0.6516349780992643 0 +3821 0.5447918303283066 0.9699846568893785 0 +3822 0.4043557480384705 0.8417591077774624 0 +3823 0.4049999999989607 0.9702917063411154 0 +3824 0.2395470048806064 0.7425710045535132 0 +3825 0.8680277829141924 0.7431218362877513 0 +3826 0.1303675135481172 0.7414262421750296 0 +3827 0.5427557008437534 0.2584388243689164 0 +3828 0.951851718962846 0.7474464822302712 0 +3829 0.04814828103691262 0.7474464822309445 0 +3830 0.8770792412949472 0.9236344339748748 0 +3831 0.1229207587044854 0.9236344339751844 0 +3832 0.7961445410523822 0.311251754350556 0 +3833 0.7760372495275611 0.3903150853269405 0 +3834 0.7236098808148653 0.7607028599022946 0 +3835 0.4137267449730414 0.7000828130392076 0 +3836 0.7466089352857045 0.9239285263686412 0 +3837 0.2533910647130155 0.9239285263690413 0 +3838 0.9610139135484708 0.8612840077674176 0 +3839 0.0389860864514746 0.8612840077678749 0 +3840 0.5291657478040362 0.9167650420553539 0 +3841 0.8120322410643368 0.7134034415574153 0 +3842 0.3820676197677851 0.6075134610974431 0 +3843 0.4753863532713057 0.8105968310407812 0 +3844 0.5613774318451397 0.49487794408774 0 +3845 0.5835987208003524 0.6883675850041264 0 +3846 0.4496620124782539 0.848215513731984 0 +3847 0.771368009263711 0.1325824442908582 0 +3848 0.854613180076208 0.5680165409472484 0 +3849 0.05324339469079318 0.5787625499386186 0 +3850 0.3680917249003124 0.3285304657587159 0 +3851 0.07314870358487699 0.4038140150719662 0 +3852 0.4896801683500572 0.9716773319678798 0 +3853 0.3163780951507726 0.6743945688169285 0 +3854 0.9247899181541059 0.8753105967699204 0 +3855 0.07521008184553703 0.8753105967702725 0 +3856 0.9230897015045263 0.3278303519808334 0 +3857 0.7733297816745903 0.9728355458975075 0 +3858 0.2266702183242967 0.9728355458976559 0 +3859 0.4905325186655494 0.7358031001216199 0 +3860 0.3491814661591301 0.9719082358767021 0 +3861 0.6539281580892802 0.8873477425520724 0 +3862 0.3460390566922257 0.8874171313347612 0 +3863 0.9690407413969251 0.924746118751727 0 +3864 0.03095925860296628 0.9247461187520987 0 +3865 0.6276193463987503 0.6451641951516576 0 +3866 0.4726448832694249 0.2091531175878388 0 +3867 0.2774037955385593 0.7662193316932696 0 +3868 0.6049826823315074 0.7312853759709507 0 +3869 0.1171244667396665 0.6485435588172355 0 +3870 0.2346426415369918 0.5354934146053882 0 +3871 0.5464335942759053 0.7747979171718952 0 +3872 0.2191427888927727 0.186045390150349 0 +3873 0.226348199313372 0.09110089560914636 0 +3874 0.9204170524390722 0.9331290227463437 0 +3875 0.8918427989320958 0.6564182620814207 0 +3876 0.07958294756057027 0.9331290227466396 0 +3877 0.5727759534019614 0.9111161497353149 0 +3878 0.6819420966563542 0.6802744633419884 0 +3879 0.2116052887953869 0.6505623313846898 0 +3880 0.4743855051414581 0.6494219818844299 0 +3881 0.1859732665107253 0.4638199073645261 0 +3882 0.6831019552237937 0.4981411881327831 0 +3883 0.5261899353738885 0.6460107558012543 0 +3884 0.8182248838015395 0.8004852644754825 0 +3885 0.1808797841266093 0.8000075853328212 0 +3886 0.8905587696235082 0.8761404132810806 0 +3887 0.1094412303760334 0.8761404132816502 0 +3888 0.4592240634908111 0.6996017621850765 0 +3889 0.7312854314423527 0.9717321817389465 0 +3890 0.2687145685562919 0.9717321817391034 0 +3891 0.6151500988895461 0.9737799722415401 0 +3892 0.9056161833773897 0.8121727166327566 0 +3893 0.0943838166226756 0.8121727166331457 0 +3894 0.5964139947465555 0.09146604088779577 0 +3895 0.506673353631782 0.0931235652748683 0 +3896 0.4208273319235493 0.7756038681763548 0 +3897 0.7763692969201188 0.8723433624392942 0 +3898 0.2236307030788141 0.8723433624399329 0 +3899 0.275989832139486 0.6099471607436453 0 +3900 0.6806555650022809 0.824356956760762 0 +3901 0.7211515884186711 0.6072283856949062 0 +3902 0.770856838500092 0.9369655964387337 0 +3903 0.2291431614987754 0.9369655964390768 0 +3904 0.2995306711455051 0.4982552016311874 0 +3905 0.3191308017574142 0.8245094468753111 0 +3906 0.1812052894171816 0.5804763554889556 0 +3907 0.3876430579365246 0.9322186937839707 0 +3908 0.6546789176470527 0.365604784051565 0 +3909 0.9442774505310696 0.4891548680913375 0 +3910 0.6037330416931657 0.8760030756862187 0 +3911 0.8389088785928506 0.9051488575365128 0 +3912 0.161091121406404 0.9051488575369526 0 +3913 0.5344873588691672 0.3784736330348054 0 +3914 0.4015494210549199 0.7399101516384153 0 +3915 0.4723874315943569 0.546647695495009 0 +3916 0.5987772339283716 0.8078037086993788 0 +3917 0.3982968647758967 0.8072806868780432 0 +3918 0.4210818059296881 0.9104668226621264 0 +3919 0.6868353967798447 0.9291318806450595 0 +3920 0.3133716125063806 0.9297010548540732 0 +3921 0.9531283016740071 0.601615445456265 0 +3922 0.5626761204542309 0.8496821802324226 0 +3923 0.4414708587792049 0.9417158736919977 0 +3924 0.9675460547335292 0.8258954400798246 0 +3925 0.0324539452665415 0.8258954400801936 0 +3926 0.2814497900878374 0.417157182152149 0 +3927 0.1250826382746296 0.5293186015734948 0 +3928 0.1769476255748152 0.7186475757768602 0 +3929 0.9210448196398369 0.1881869237486085 0 +3930 0.7917971679822369 0.7762653160077295 0 +3931 0.2103555249655211 0.7765951653249676 0 +3932 0.3532364705802262 0.1983468898055183 0 +3933 0.3530937030899848 0.08579201745327555 0 +3934 0.8949999999997217 0.976294770997749 0 +3935 0.104999999999807 0.9762947709978431 0 +3936 0.2288242487404349 0.3348435826550285 0 +3937 0.3929760491960678 0.8749422514622009 0 +3938 0.04516197948641304 0.668366641318048 0 +3939 0.4700063955197665 0.7749159423477995 0 +3940 0.3425379730539151 0.5792950756644065 0 +3941 0.8018110375928003 0.9751091059680805 0 +3942 0.1981889624062582 0.9751091059682028 0 +3943 0.3790818396725328 0.6537317007277476 0 +3944 0.660834958366359 0.9753348669255453 0 +3945 0.715516373340834 0.4104224142853757 0 +3946 0.05848113365782839 0.4617704235136489 0 +3947 0.5807241435795072 0.9423470173288349 0 +3948 0.3482085860694553 0.391183816390297 0 +3949 0.4903088707995424 0.9436571391010395 0 +3950 0.05763525586117547 0.2940324319541971 0 +3951 0.5444962278403366 0.6959514726691052 0 +3952 0.3490441535762759 0.9425860230813619 0 +3953 0.620547232805049 0.1856387495193579 0 +3954 0.6642277708697455 0.8583498649100529 0 +3955 0.5826535338927147 0.7732921120177205 0 +3956 0.07769759500999719 0.09393096939028349 0 +3957 0.3348364976023889 0.8582279690181107 0 +3958 0.5326474058044592 0.80395688499181 0 +3959 0.0701045633760735 0.1781255038555453 0 +3960 0.8165570019248398 0.9416198694245954 0 +3961 0.1834429980742726 0.9416198694248805 0 +3962 0.4649999999987859 0.9773563295480949 0 +3963 0.624053722819608 0.9386974960475305 0 +3964 0.8449999999995869 0.9777874771794672 0 +3965 0.1549999999996889 0.9777874771795785 0 +3966 0.7524435815208094 0.7001106678710701 0 +3967 0.749528997230915 0.5468488343074716 0 +3968 0.7254939270004099 0.8617903862445928 0 +3969 0.27450607299822 0.8617903862453002 0 +3970 0.6519123606210981 0.7816798503429209 0 +3971 0.66460997957715 0.5778223874071722 0 +3972 0.8352559813665218 0.2010159976029955 0 +3973 0.9386331188501114 0.3834235154859676 0 +3974 0.6848511933763669 0.9773956861446451 0 +3975 0.1819658802735272 0.6821628049613305 0 +3976 0.9491853182037719 0.9795650237413575 0 +3977 0.05081468179599716 0.9795650237414519 0 +3978 0.3464444298436914 0.7801897858183069 0 +3979 0.9037898811988192 0.7360218014908835 0 +3980 0.09133476066318519 0.7370529710083176 0 +3981 0.3148300438636647 0.9785922770944113 0 +3982 0.4385723720112795 0.5249878922157225 0 +3983 0.6140151709784849 0.4567487060084635 0 +3984 0.8198662273904778 0.663765593350356 0 +3985 0.5493094379728428 0.8962497178983865 0 +3986 0.5481579202118432 0.6091403413767789 0 +3987 0.136805770058462 0.3976067784538805 0 +3988 0.2003602797483222 0.741464831887564 0 +3989 0.449552352917812 0.6156866242806219 0 +3990 0.6538338586789421 0.9433639064821979 0 +3991 0.4724454130763751 0.930181302231268 0 +3992 0.9168735851548003 0.08154510520896407 0 +3993 0.4263247628428187 0.3437997297618366 0 +3994 0.5250470169266888 0.4644989142298308 0 +3995 0.5241988755829053 0.9788953096104701 0 +3996 0.9388335296434006 0.9199725084444028 0 +3997 0.06116647035632636 0.9199725084447776 0 +3998 0.3836865411847476 0.978418578355855 0 +3999 0.7097390757618174 0.9075335946972667 0 +4000 0.2902609242367218 0.9075335946977523 0 +4001 0.8078856255198641 0.560785750602893 0 +4002 0.6311826055631086 0.8988274543016862 0 +4003 0.5291040925343674 0.7442036669385633 0 +4004 0.7895357646898007 0.6333944670848419 0 +4005 0.5043229919422062 0.8232918074274702 0 +4006 0.9645542000929698 0.6873818475444158 0 +4007 0.7093818579090103 0.1998306855753584 0 +4008 0.817312533223256 0.0763104559294886 0 +4009 0.7211920553034565 0.2765128821850641 0 +4010 0.1045016299822327 0.6836477120168121 0 +4011 0.5934016151322565 0.9783136699040823 0 +4012 0.2530404397524282 0.6927362582101269 0 +4013 0.5020192269822026 0.8932369018502502 0 +4014 0.7267790888599116 0.07621511994400353 0 +4015 0.8357006539495749 0.8608413962695657 0 +4016 0.1642993460496671 0.8608413962702156 0 +4017 0.7549381729174602 0.9798486679108018 0 +4018 0.2450618270813166 0.9798486679109171 0 +4019 0.3221335758301973 0.71127256682436 0 +4020 0.9767801339172379 0.9464474185312483 0 +4021 0.02321986608265552 0.9464474185315113 0 +4022 0.03510793832173042 0.7146399421618292 0 +4023 0.5310201529988398 0.9398343821624919 0 +4024 0.3040335315306726 0.7440358868866173 0 +4025 0.7256638451292878 0.5131429463324011 0 +4026 0.450884069495847 0.887880672280936 0 +4027 0.1404441900112984 0.292893795100662 0 +4028 0.6051226495039908 0.2702066890632027 0 +4029 0.6245405756697463 0.8331667819524549 0 +4030 0.3740270651896885 0.482767246039739 0 +4031 0.8948792006130712 0.7060170203332713 0 +4032 0.8510036084490654 0.3142815868935936 0 +4033 0.8780290078219277 0.8970285657248318 0 +4034 0.1219709921775037 0.897028565725295 0 +4035 0.3776920384400134 0.8312978100422318 0 +4036 0.5217653188690962 0.5428047309558556 0 +4037 0.8083411724126399 0.8466945988892474 0 +4038 0.1916588275864309 0.8466945988899407 0 +4039 0.3710933166086729 0.8865426419426667 0 +4040 0.1709284603443829 0.3400879153048332 0 +4041 0.7304222902648517 0.9537611250385332 0 +4042 0.2695777097337914 0.9537611250387831 0 +4043 0.616701106779838 0.4051094877200854 0 +4044 0.760597449504012 0.823815148382288 0 +4045 0.2394025504948221 0.8238151483831697 0 +4046 0.70023936449538 0.885299734007549 0 +4047 0.2997541015713867 0.8853067990347929 0 +4048 0.8649562915958634 0.9455194359678181 0 +4049 0.13504370840352 0.9455194359680623 0 +4050 0.8464510154484939 0.9577920130232931 0 +4051 0.153548984550803 0.9577920130234968 0 +4052 0.6909802103208807 0.7563943368492488 0 +4053 0.6746583939477759 0.3097922701641638 0 +4054 0.4653931509652491 0.2725611634256091 0 +4055 0.9742631554277045 0.8851746742297567 0 +4056 0.02573684457225862 0.8851746742301216 0 +4057 0.1655824595434258 0.2256039434254096 0 +4058 0.8704700192242447 0.4647885051350603 0 +4059 0.05521997116950423 0.3490463552934598 0 +4060 0.9471418445432391 0.2780602820843013 0 +4061 0.9079525829009025 0.8545294707958382 0 +4062 0.09204741709884703 0.8545294707963534 0 +4063 0.7576556720569849 0.8883005133851498 0 +4064 0.2423443279418391 0.8883005133857096 0 +4065 0.3823821655854145 0.5735711725136273 0 +4066 0.7974349020288207 0.8999337737578619 0 +4067 0.2025650979701839 0.8999337737583413 0 +4068 0.7152918078423299 0.7871226391309929 0 +4069 0.1417246818594895 0.06825715186294318 0 +4070 0.9264985356925385 0.9018192982049517 0 +4071 0.07350146430712162 0.9018192982053652 0 +4072 0.749519569103445 0.6335700494691513 0 +4073 0.8241594595282118 0.2621746194822492 0 +4074 0.5507871165470715 0.8700512602225086 0 +4075 0.5092414204691827 0.9357249608961486 0 +4076 0.680044873749719 0.7190672069907369 0 +4077 0.3693384260898727 0.7310026456206432 0 +4078 0.8304380897379404 0.4921945420040005 0 +4079 0.7931823468661678 0.9313279321707053 0 +4080 0.2068176531328262 0.9313279321710427 0 +4081 0.8611134226038442 0.8584049973495407 0 +4082 0.1388865773955487 0.8584049973502361 0 +4083 0.2735622613126485 0.3014304754792097 0 +4084 0.8537809566034509 0.7673508636177419 0 +4085 0.1460749507846286 0.7677270434442931 0 +4086 0.4672664617845406 0.468505371266777 0 +4087 0.6687391834199609 0.9191348962990784 0 +4088 0.3295286953357598 0.9189494977259469 0 +4089 0.896177673755532 0.565747373405344 0 +4090 0.5041050539021672 0.9822450425579017 0 +4091 0.6042858736192473 0.553687609888421 0 +4092 0.3951448024543263 0.9516765628852387 0 +4093 0.234317439844356 0.4230437345274692 0 +4094 0.5422284215259245 0.3262431394770985 0 +4095 0.8613947015174612 0.8222253710108369 0 +4096 0.1386052984819151 0.8222253710116627 0 +4097 0.9693595232429085 0.771577761770567 0 +4098 0.0307015817501409 0.7714399503855089 0 +4099 0.6947070100591117 0.9505319614252726 0 +4100 0.3053496473777573 0.9504187208782864 0 +4101 0.04052299530249664 0.5415663871479356 0 +4102 0.837847517007542 0.7341421855185098 0 +4103 0.3629267507178361 0.9818631538622864 0 +4104 0.03989874246352883 0.6134302441052675 0 +4105 0.7530683153811095 0.7625040937587992 0 +4106 0.5129499351880757 0.8581812192630389 0 +4107 0.5618147855922505 0.9824201967693187 0 +4108 0.2961620851092936 0.643809887970449 0 +4109 0.8356453498485782 0.5346303506010788 0 +4110 0.6790217475576487 0.877470256977592 0 +4111 0.9685995814597967 0.7190246785389344 0 +4112 0.3203451920146463 0.8775443870667532 0 +4113 0.152097110669405 0.4916027572177032 0 +4114 0.2185388766157459 0.4997246267070515 0 +4115 0.5982748955245324 0.9308147683294072 0 +4116 0.6360105500651638 0.9824691143577043 0 +4117 0.7889763322100682 0.4773232421416736 0 +4118 0.664784977976852 0.0678096324797476 0 +4119 0.7784266716413926 0.8482980248759897 0 +4120 0.2215733283575073 0.8482980248767409 0 +4121 0.9826766411859073 0.9827112450896717 0 +4122 0.01732335881401648 0.9827112450896797 0 +4123 0.4158862670462219 0.06531174341464539 0 +4124 0.8548875776205234 0.6560501245142085 0 +4125 0.4232485507790545 0.9827133671899215 0 +4126 0.8679514502116198 0.4186203838149137 0 +4127 0.2857749042594009 0.06563539253413279 0 +4128 0.8602422762969811 0.9086108725982511 0 +4129 0.1397577237023721 0.9086108725986387 0 +4130 0.4735233156227197 0.9073993299340167 0 +4131 0.3336823060364046 0.9821394160542336 0 +4132 0.452290271387019 0.3864884702798327 0 +4133 0.1035594595201337 0.6155783396978679 0 +4134 0.2407484597185398 0.2334195549816942 0 +4135 0.897230901368592 0.9323771494624625 0 +4136 0.1027690986309371 0.9323771494627427 0 +4137 0.6620381309879446 0.5394802410139503 0 +4138 0.8769173897430906 0.9814510083478871 0 +4139 0.1230826102563553 0.9814510083479681 0 +4140 0.3815878523538027 0.4388253737063962 0 +4141 0.1524273685825279 0.6603207406625053 0 +4142 0.6313745357945908 0.7487661614674604 0 +4143 0.8733080293537445 0.6246886341650479 0 +4144 0.9329626620355295 0.7692085526097406 0 +4145 0.06703733796432974 0.7692085526102221 0 +4146 0.1126178001660977 0.7148592657260624 0 +4147 0.3507043658025388 0.2759577611615795 0 +4148 0.7365480540803954 0.7342978823617738 0 +4149 0.2850496441467325 0.6821333664749 0 +4150 0.4351028611644084 0.4351583705713032 0 +4151 0.4812561517566297 0.1549539867072043 0 +4152 0.5817201901258277 0.6010840407883881 0 +4153 0.4488700650611264 0.9830852143403759 0 +4154 0.3664458188078803 0.938801628714077 0 +4155 0.2864723655052417 0.7952884532590866 0 +4156 0.9148803679000146 0.9513694453003954 0 +4157 0.08511963209958326 0.9513694453006001 0 +4158 0.6481087552590663 0.8411446835747254 0 +4159 0.3516452214278706 0.8411302147311492 0 +4160 0.4261539156132824 0.8539506870707509 0 +4161 0.9789879930217859 0.9054594636494556 0 +4162 0.02101200697831327 0.9054594636497532 0 +4163 0.7970725257150095 0.7480507602707177 0 +4164 0.6239561498962085 0.9183842989649225 0 +4165 0.08567710266744501 0.5555756361155488 0 +4166 0.9319489926008352 0.8138102092908305 0 +4167 0.06805100739921652 0.8138102092911406 0 +4168 0.4144667904904701 0.2056947392925472 0 +4169 0.7149999999992495 0.9827415931578174 0 +4170 0.2849999999993101 0.982741593157912 0 +4171 0.2616565246991721 0.5751602696945131 0 +4172 0.3247807326931682 0.5299340318428443 0 +4173 0.9122001489041095 0.9820094049903503 0 +4174 0.08779985109549929 0.9820094049904297 0 +4175 0.347176469727653 0.6559806936917936 0 +4176 0.8220598734827319 0.4000501291896271 0 +4177 0.4453469392568887 0.788214287023689 0 +4178 0.1486179248388603 0.5930188929197613 0 +4179 0.9561798483004957 0.4489129240204565 0 +4180 0.7818349722419444 0.7062122249717073 0 +4181 0.2025833254783888 0.6210048928004108 0 +4182 0.9201140635103675 0.676251434332563 0 +4183 0.2475305143277344 0.3795114002983948 0 +4184 0.7037418639541988 0.4524303643089364 0 +4185 0.5501786654921997 0.9173706031202171 0 +4186 0.4697420949965335 0.8636983115383005 0 +4187 0.5580501019953795 0.9568497289430657 0 +4188 0.653041187425465 0.6684380225676578 0 +4189 0.4189470857173174 0.9574438514246758 0 +4190 0.3121607265807631 0.5899502794574656 0 +4191 0.4954205747884621 0.8719822753036138 0 +4192 0.3746001987168552 0.9138713197218982 0 +4193 0.9642427727747984 0.567449305173046 0 +4194 0.3308461375764 0.9368270220730066 0 +4195 0.5532560507595492 0.6623870694946646 0 +4196 0.46947858533257 0.8358417473975678 0 +4197 0.07678573368741082 0.6698713127203624 0 +4198 0.9406697144130838 0.135919380670786 0 +4199 0.9111822936040488 0.5119950407053048 0 +4200 0.6117501189139222 0.6754370909944122 0 +4201 0.148800994187358 0.5580918393546355 0 +4202 0.03944298110645466 0.4999360485796459 0 +4203 0.4043861484784972 0.9219950972566929 0 +4204 0.8177682260848396 0.9823603729776671 0 +4205 0.1822317739143021 0.9823603729777572 0 +4206 0.05018573287253508 0.2333541202418692 0 +4207 0.8792964947067313 0.7722314518378967 0 +4208 0.1210312750670137 0.7757781122401488 0 +4209 0.5212378253639011 0.7153401793001432 0 +4210 0.3993189523506581 0.5092643407741604 0 +4211 0.6215447929455843 0.9558615499438374 0 +4212 0.7817899106112969 0.4334925735279735 0 +4213 0.3209330122588003 0.3145276898322378 0 +4214 0.2608269827239185 0.5071001087932713 0 +4215 0.9766587151824272 0.7986238105878593 0 +4216 0.02334128481753584 0.7986238105882302 0 +4217 0.5256761037587305 0.5787894945510511 0 +4218 0.8178026128082712 0.899194814775815 0 +4219 0.1821973871908463 0.8991948147763119 0 +4220 0.5876489163598397 0.8960129626470158 0 +4221 0.2354219329630357 0.6304638051482453 0 +4222 0.1088497966177338 0.4925824156507881 0 +4223 0.2890603050486202 0.4573119855372815 0 +4224 0.4347170268060512 0.6794816080849942 0 +4225 0.9463337944630184 0.8781899975460656 0 +4226 0.05366620553670987 0.8781899975465519 0 +4227 0.5781537401078798 0.2197283733095203 0 +4228 0.2717949900413541 0.7405866294768793 0 +4229 0.7785837982243997 0.8025389755972611 0 +4230 0.2190172555565114 0.8008042063326757 0 +4231 0.6249857477072267 0.8004556778475509 0 +4232 0.8154028290314947 0.8225068767308984 0 +4233 0.1845971709676346 0.822506876731719 0 +4234 0.3666236668192 0.1422922928571595 0 +4235 0.8084459013379517 0.6015972105669998 0 +4236 0.5774078150218241 0.375580701333 0 +4237 0.9661265115387374 0.9841005147175761 0 +4238 0.0338734884611159 0.9841005147176254 0 +4239 0.7768425360144945 0.9542419905654701 0 +4240 0.2231574639844001 0.9542419905657221 0 +4241 0.7274601784845142 0.9187425015230839 0 +4242 0.272539821514108 0.9187425015235092 0 +4243 0.7123039187862135 0.843576073033442 0 +4244 0.2891750433666406 0.8412353002808484 0 +4245 0.7649557352010862 0.3470911339511453 0 +4246 0.4144061693469608 0.6196748796052526 0 +4247 0.5284318275921717 0.4189717085079954 0 +4248 0.1581858591539055 0.7405140104941563 0 +4249 0.2356182000751463 0.7685307557620108 0 +4250 0.8404689079172426 0.8114271582676238 0 +4251 0.1595310920820464 0.8114271582684899 0 +4252 0.3749058911679697 0.800217907204281 0 +4253 0.4101036052345142 0.8923386518629746 0 +4254 0.7282028726225347 0.6855942601453904 0 +4255 0.8128317701772946 0.3546456262646864 0 +4256 0.8826181543782359 0.9656653926308252 0 +4257 0.1173818456212346 0.9656653926309833 0 +4258 0.9681012241022898 0.6287981430492779 0 +4259 0.9622928521181487 0.5224470399746449 0 +4260 0.6927129276204577 0.6504456434991349 0 +4261 0.3872156631590173 0.6857063390311052 0 +4262 0.8330713946194136 0.8835088728666287 0 +4263 0.1669286053798003 0.8835088728671758 0 +4264 0.1589882140904168 0.4317466522737323 0 +4265 0.8609270414630412 0.9846156340177163 0 +4266 0.1390729585363213 0.984615634017788 0 +4267 0.5913896038992233 0.8633620682394447 0 +4268 0.72725250426397 0.5723162240926558 0 +4269 0.5777770824084649 0.9836421937203268 0 +4270 0.5328575653224693 0.9570776422950392 0 +4271 0.7873034218702757 0.9833672010215657 0 +4272 0.2126965781286913 0.9833672010216515 0 +4273 0.6441606398056978 0.6132322795170921 0 +4274 0.6994356293452143 0.8096871781219145 0 +4275 0.1226475246850834 0.1875480366001286 0 +4276 0.8284606224841331 0.9248379800449589 0 +4277 0.1715393775150499 0.9248379800453225 0 +4278 0.215151586117989 0.5659056360359447 0 +4279 0.5909625304182651 0.9603385785395139 0 +4280 0.952147064860504 0.9608393396282813 0 +4281 0.04785293513927594 0.9608393396284717 0 +4282 0.2892931448533498 0.203819110741244 0 +4283 0.8837864673712319 0.8181226502148615 0 +4284 0.1162135326284134 0.818122650215849 0 +4285 0.4524714056928162 0.9660606611347801 0 +4286 0.7500348566670829 0.6702660646340582 0 +4287 0.8984699849189154 0.3884363547467543 0 +4288 0.6120136152325861 0.855481988792079 0 +4289 0.7123982478825868 0.9512484434322225 0 +4290 0.2876017521159564 0.95124844343249 0 +4291 0.3251735374695774 0.7645749675843103 0 +4292 0.6987176572202061 0.9833749515446357 0 +4293 0.2323036375657582 0.6713241195754749 0 +4294 0.6706938876578555 0.9374421594994932 0 +4295 0.6680525837539829 0.8042179040513306 0 +4296 0.3323808225580119 0.8035858973424583 0 +4297 0.4296280512866321 0.9272315192418585 0 +4298 0.9839692389031088 0.9627670939033381 0 +4299 0.01603076109681119 0.9627670939033469 0 +4300 0.9762271832776135 0.844602191326422 0 +4301 0.02377281672242474 0.8446021913268096 0 +4302 0.7363329351765777 0.8371095671086237 0 +4303 0.2636670648221165 0.8371095671094548 0 +4304 0.3606825405886664 0.7575201954927218 0 +4305 0.7422803808432308 0.8741983428270844 0 +4306 0.2577196191555026 0.8741983428277326 0 +4307 0.9307468199854612 0.9845839230804445 0 +4308 0.06925318001422211 0.9845839230805181 0 +4309 0.03066018468121775 0.6425451600761815 0 +4310 0.583584840411836 0.746125640291881 0 +4311 0.572195197005028 0.5315011239661203 0 +4312 0.6408093900688562 0.7218411301887434 0 +4313 0.4697951054252912 0.5877864378428547 0 +4314 0.8093931937911109 0.9601833427440208 0 +4315 0.1906068062079767 0.9601833427442276 0 +4316 0.4788135554551597 0.984507925044958 0 +4317 0.3385109887976677 0.4964301806522455 0 +4318 0.9127156321561187 0.6348008950957074 0 +4319 0.4369107942813762 0.7169337049851341 0 +4320 0.579938791559432 0.7175566233038171 0 +4321 0.7607839706411667 0.5034019375886101 0 +4322 0.2363149133897059 0.715485310265731 0 +4323 0.9071960248454136 0.8855578923401635 0 +4324 0.09280397515411964 0.8855578923406052 0 +4325 0.6091701709748906 0.7035264650707285 0 +4326 0.6429030743141277 0.4862127562180408 0 +4327 0.6988582300841595 0.5826643179188586 0 +4328 0.464147177301004 0.7253598773937149 0 +4329 0.3005270216020079 0.8120587996798611 0 +4330 0.300607789766402 0.9843239788964718 0 +4331 0.2456284629751048 0.140025942446175 0 +4332 0.4778640197923424 0.6789772247115572 0 +4333 0.5015117095401601 0.6618453099726923 0 +4334 0.5469573884852025 0.05836509929272661 0 +4335 0.9242334835857872 0.5823619041976059 0 +4336 0.4427068940723775 0.8678953605069092 0 +4337 0.03897824405264215 0.4255207633722623 0 +4338 0.839508223742877 0.7867970397521789 0 +4339 0.1606641257020042 0.7869872849403499 0 +4340 0.746695672353308 0.9047276844559351 0 +4341 0.2533043276454708 0.9047276844564223 0 +4342 0.7948208858180777 0.8625473633462948 0 +4343 0.2051791141809537 0.8625473633469221 0 +4344 0.5235787250849806 0.2114317069170367 0 +4345 0.38655707458157 0.8532201153420796 0 +4346 0.7411135888878527 0.8109425605399417 0 +4347 0.258886411110892 0.8109425605409118 0 +4348 0.3907323827744286 0.7148311098325104 0 +4349 0.5115005885700075 0.9112587614801924 0 +4350 0.3591099259743124 0.9015542273498706 0 +4351 0.9199724311661232 0.7938573842643601 0 +4352 0.08002756883399992 0.7938573842648261 0 +4353 0.9074424394777332 0.9662350089353547 0 +4354 0.09255756052184506 0.9662350089354927 0 +4355 0.7445598049645732 0.9415364299399196 0 +4356 0.2554401950341465 0.9415364299402307 0 +4357 0.09079282021182447 0.4394015518659876 0 +4358 0.8688124431831207 0.05587203788803644 0 +4359 0.5449999999988019 0.9855055569334812 0 +4360 0.970718127536738 0.6579886322986841 0 +4361 0.6270462974900015 0.8781641155471279 0 +4362 0.5759608309224681 0.8309285141630248 0 +4363 0.5091879395726132 0.2903089476269688 0 +4364 0.9049666550446075 0.831357416884376 0 +4365 0.09503334495522955 0.8313574168849251 0 +4366 0.4047605200544121 0.9852089478933519 0 +4367 0.7839481847743417 0.1853380952839349 0 +4368 0.6553758021859476 0.95976128939006 0 +4369 0.9530227302202041 0.8425431732731207 0 +4370 0.4898214436049057 0.7605839124387881 0 +4371 0.04697726977979349 0.8425431732735029 0 +4372 0.4226325673020617 0.8315699086329623 0 +4373 0.5503768242921083 0.8295909368041694 0 +4374 0.8895908001284538 0.7949901540555262 0 +4375 0.1104091998714518 0.7949901540561788 0 +4376 0.5300357933614327 0.5085734678144831 0 +4377 0.5930058750112064 0.1473401049883523 0 +4378 0.5648937154855328 0.789753139041754 0 +4379 0.1921525717553448 0.1380332274773228 0 +4380 0.6037688203934459 0.6264619259630432 0 +4381 0.3573165084085756 0.6268086383554263 0 +4382 0.6793492651449903 0.3967190097693571 0 +4383 0.4100546746864584 0.543175586984796 0 +4384 0.02481889649770756 0.7408862262109449 0 +4385 0.8823497211045771 0.9407385491438378 0 +4386 0.1176502788948721 0.9407385491440795 0 +4387 0.910398456065494 0.4752131980958018 0 +4388 0.6382512685484949 0.5629308340229312 0 +4389 0.983274353118995 0.8659010068470642 0 +4390 0.01672564688104667 0.8659010068473254 0 +4391 0.80359815729717 0.6892955454444958 0 +4392 0.9613529693410883 0.9400784811749527 0 +4393 0.03864703065873431 0.9400784811752438 0 +4394 0.5465440712398143 0.1152066563339837 0 +4395 0.9530129424304521 0.2219299265352334 0 +4396 0.9376239441990601 0.8586393446916988 0 +4397 0.06237605580059076 0.858639344692042 0 +4398 0.9310885812739986 0.953167967930412 0 +4399 0.06891141872568041 0.953167967930638 0 +4400 0.4368637400556633 0.900440676107684 0 +4401 0.5263685173136283 0.6745922987678168 0 +4402 0.932969170187985 0.7289481443605363 0 +4403 0.06721887853042244 0.730926206687617 0 +4404 0.3978626110153731 0.3001717868011036 0 +4405 0.1365114717813342 0.6216478897856069 0 +4406 0.7097882301942846 0.7396670020981297 0 +4407 0.7634901223069601 0.9198848337795423 0 +4408 0.2365098776918438 0.9198848337799556 0 +4409 0.9555969088656413 0.343167279548561 0 +4410 0.073521086194719 0.6053575833081043 0 +4411 0.7408817106852263 0.9848919984122476 0 +4412 0.259118289313472 0.9848919984123321 0 +4413 0.3467405722761419 0.7215469229889513 0 +4414 0.4991594070126318 0.9562564100269246 0 +4415 0.2993212860776926 0.7699112619390476 0 +4416 0.5692511537537276 0.9280866937020332 0 +4417 0.4961243376742727 0.8008597257421526 0 +4418 0.3591880362722107 0.9569904603465522 0 +4419 0.4855167214747754 0.7111180581948667 0 +4420 0.1429375181241524 0.7195379585894548 0 +4421 0.7377233863352015 0.7806642483221269 0 +4422 0.4940638999692694 0.3833932484941977 0 +4423 0.9756477061154386 0.7395627253130794 0 +4424 0.848501248433761 0.6009274416264685 0 +4425 0.5986209570029333 0.4957019118453793 0 +4426 0.4551462373220299 0.8174222746511651 0 +4427 0.6497251240118871 0.9852841310816947 0 +4428 0.772837444919662 0.2765357722692596 0 +4429 0.8319219429830258 0.9852312018038476 0 +4430 0.1680780570161887 0.9852312018039197 0 +4431 0.9838784262275327 0.9314167121411563 0 +4432 0.01612157377246597 0.9314167121415271 0 +4433 0.7892111868021847 0.9657754207795983 0 +4434 0.2107888131967959 0.9657754207797598 0 +4435 0.8299224244287199 0.6931099927529414 0 +4436 0.03553274085104305 0.3851073447217034 0 +4437 0.3828717557928699 0.3660470602145655 0 +4438 0.8607544447388072 0.9277356076050532 0 +4439 0.1392455552605421 0.9277356076053742 0 +4440 0.5320184694095568 0.8610594270077749 0 +4441 0.9196226908645392 0.9147463999850767 0 +4442 0.0803773091351562 0.9147463999854427 0 +4443 0.4607625308949944 0.5000828750898957 0 +4444 0.4994923380289608 0.6335840511710834 0 +4445 0.8689006087936391 0.715816020847875 0 +4446 0.6549047042722501 0.9056033193793724 0 +4447 0.7367859782813511 0.3771964966871399 0 +4448 0.6793901441409342 0.8436778598440744 0 +4449 0.3204894920243718 0.845131813416279 0 +4450 0.1835536431381338 0.6506583751830796 0 +4451 0.4183302060291356 0.7974950109419057 0 +4452 0.8929287800356238 0.7556929126216591 0 +4453 0.1053229141234123 0.7550045511323797 0 +4454 0.8811536865799884 0.2109621857113673 0 +4455 0.02478730192561753 0.6877491647591362 0 +4456 0.6720622581486468 0.985675867582708 0 +4457 0.881667249253515 0.6774313806213659 0 +4458 0.885735952061109 0.3445037663599173 0 +4459 0.4819246219540796 0.9569915920145833 0 +4460 0.6059368427425051 0.9859146385147458 0 +4461 0.4218249740480245 0.7512429267474314 0 +4462 0.347991275404802 0.9852700731640898 0 +4463 0.3100790472046395 0.9623724181092579 0 +4464 0.03077689675695584 0.5815712977010579 0 +4465 0.7695755707637613 0.9836357870623891 0 +4466 0.2304244292351001 0.983635787062479 0 +4467 0.8310285978986405 0.9520822175565333 0 +4468 0.1689714021005676 0.9520822175567816 0 +4469 0.7232264259265574 0.1493028537238696 0 +4470 0.3337784025460912 0.6922721991271411 0 +4471 0.4010649640659603 0.7630875734780288 0 +4472 0.3335750069720571 0.8977851369565717 0 +4473 0.320151516785479 0.4166539826071847 0 +4474 0.04525146285377688 0.1285307964486906 0 +4475 0.7029506534282881 0.9187611718790711 0 +4476 0.2970493465702106 0.9187611718794991 0 +4477 0.577458411552247 0.4650794872317074 0 +4478 0.7772780608337554 0.5637406236661064 0 +4479 0.6274458713373718 0.294737887195841 0 +4480 0.3402308032768444 0.9583271934154453 0 +4481 0.9655372861193436 0.4114729141677723 0 +4482 0.6048178866894602 0.754874035520825 0 +4483 0.2649953211046795 0.7854024814047691 0 +4484 0.5633763085672839 0.7581249308719005 0 +4485 0.6663946055386091 0.692684598080342 0 +4486 0.6898119723667749 0.9623822172674116 0 +4487 0.6633144207879084 0.2044185710599025 0 +4488 0.8915783682334831 0.9150835949353375 0 +4489 0.1084216317660134 0.9150835949356887 0 +4490 0.5656089150251524 0.3000870950981298 0 +4491 0.5240067500661805 0.7672921248304236 0 +4492 0.5880271998280873 0.9171836962947247 0 +4493 0.4418618076910997 0.766331950247692 0 +4494 0.8172304924097237 0.1443674750316388 0 +4495 0.5884288835025486 0.6603790974821879 0 +4496 0.1002129555984499 0.3779090475430751 0 +4497 0.4575145703654934 0.9403124906981405 0 +4498 0.870179726730081 0.5470319090912135 0 +4499 0.4696374371038621 0.7492340541591153 0 +4500 0.673769236679059 0.7707740597298745 0 +4501 0.5318576114014157 0.8986761314127332 0 +4502 0.5218613209853941 0.6181098395527759 0 +4503 0.1974524171120151 0.4282689812763747 0 +4504 0.4017515156303268 0.7851060138691734 0 +4505 0.04780323507972768 0.05487422002550797 0 +4506 0.4114716683571265 0.8655213683461609 0 +4507 0.7910539450715225 0.912265047637396 0 +4508 0.2089460549274409 0.9122650476378141 0 +4509 0.45455549125573 0.3061929954949973 0 +4510 0.955744098942764 0.9128874289312698 0 +4511 0.04425590105702777 0.9128874289316753 0 +4512 0.5651286167332699 0.8948699796928105 0 +4513 0.878761267586768 0.5892746125547498 0 +4514 0.1251918291821691 0.6675057899906389 0 +4515 0.4682984991708331 0.05055942938849233 0 +4516 0.8094355736479262 0.7797749969701746 0 +4517 0.1885456046065702 0.7789615847900669 0 +4518 0.4338480018221658 0.986550330973456 0 +4519 0.1051969979247443 0.3025397346545027 0 +4520 0.6145913437833852 0.937200431935502 0 +4521 0.8941486672735088 0.2960100276686933 0 +4522 0.7621025870996359 0.8701676938050237 0 +4523 0.2378974128992097 0.8701676938056849 0 +4524 0.6491833491120912 0.8691898579101669 0 +4525 0.7764985243626041 0.7581235582925057 0 +4526 0.9600903262589857 0.3059469331223119 0 +4527 0.8714236141350642 0.8705709423447079 0 +4528 0.1285763858643948 0.8705709423453192 0 +4529 0.3549997451643404 0.8687730289245701 0 +4530 0.6130778212997431 0.8929830465773411 0 +4531 0.4057401835730334 0.5876591652920559 0 +4532 0.9190243706037935 0.7559928109199173 0 +4533 0.07969592902632916 0.7570260689636483 0 +4534 0.268702415266308 0.5334974601228191 0 +4535 0.6231628467544305 0.2280738463357483 0 +4536 0.6148255008929835 0.3646583908409751 0 +4537 0.3327181895470448 0.3533069664297089 0 +4538 0.9315597177054287 0.9349740308664207 0 +4539 0.06844028229425707 0.9349740308667263 0 +4540 0.7023863291171075 0.7747467373391873 0 +4541 0.767563421434027 0.04335424820394286 0 +4542 0.1923738814054475 0.05048551798667247 0 +4543 0.2601403702200449 0.718238224122644 0 +4544 0.4524304607593893 0.6542358273700979 0 +4545 0.6684396524880638 0.8959450415307103 0 +4546 0.7423766989101752 0.3131965571740003 0 +4547 0.8025376525927528 0.8044176377594576 0 +4548 0.1973709869909074 0.8043688949906381 0 +4549 0.5514882302802985 0.6297953184120207 0 +4550 0.6025963756044175 0.8247121502737602 0 +4551 0.3928311769916887 0.9655965867857617 0 +4552 0.3819947944702387 0.7511370645146794 0 +4553 0.6218994549638804 0.9867217772533503 0 +4554 0.1067019149185636 0.05008365196551715 0 +4555 0.7448933133641312 0.9692132325529367 0 +4556 0.2551066866345851 0.9692132325531059 0 +4557 0.7049906672730077 0.2362403419329754 0 +4558 0.09229352345904224 0.6459327625225481 0 +4559 0.7188993472467858 0.9657002055969738 0 +4560 0.281093764314615 0.9656842186376928 0 +4561 0.4031792880669763 0.6409170383114769 0 +4562 0.4606803108629366 0.8998680736464936 0 +4563 0.4144422508924542 0.6721841764260461 0 +4564 0.5072947509921949 0.8396711887019627 0 +4565 0.2031565039787224 0.2282659276279122 0 +4566 0.730299327131943 0.9354447150784463 0 +4567 0.2697006728666984 0.9354447150787927 0 +4568 0.736110509560569 0.4207020054368987 0 +4569 0.714874794388057 0.6329404695623139 0 +4570 0.1919318159283765 0.3130196081427881 0 +4571 0.8011639175620224 0.6536288128406776 0 +4572 0.7789131635887725 0.8923394662573898 0 +4573 0.2210868364101498 0.8923394662579125 0 +4574 0.6522519173120341 0.6415391168732191 0 +4575 0.3256457593821224 0.9687195795588424 0 +4576 0.704293724296881 0.6980033347395105 0 +4577 0.7626264473571067 0.9665297123582485 0 +4578 0.2373735526417199 0.9665297123584335 0 +4579 0.2567150268995104 0.7615333333404951 0 +4580 0.2344645676509308 0.2949113594955596 0 +4581 0.6895207255428494 0.5180353900545109 0 +4582 0.4477248849025197 0.5511916270674926 0 +4583 0.458512750639854 0.09976236982341606 0 +4584 0.4381236946706226 0.2366187113686198 0 +4585 0.4703157961268539 0.6192038404373763 0 +4586 0.2188710135633744 0.4566059262066102 0 +4587 0.4485772014173951 0.1691320569358384 0 +4588 0.5009078481490166 0.2484561439201259 0 +4589 0.3010730508605822 0.695893693097698 0 +4590 0.5461573224448751 0.9512366431236191 0 +4591 0.817588029087444 0.7393026443411698 0 +4592 0.8035574359172624 0.9390239340707808 0 +4593 0.1964425640817874 0.9390239340710785 0 +4594 0.05377553902574608 0.6962102147243189 0 +4595 0.3575446973412431 0.6718384418780827 0 +4596 0.3936506552509297 0.8234267869553715 0 +4597 0.2019640801178211 0.7187358848503024 0 +4598 0.5980960474222152 0.7841559973351409 0 +4599 0.2000091004688817 0.6753463507162136 0 +4600 0.4946847496913059 0.9864622573437717 0 +4601 0.6981958160668515 0.8296921636075698 0 +4602 0.7250150708036874 0.9859629153449846 0 +4603 0.2749849291949257 0.9859629153450645 0 +4604 0.07941762321906853 0.4861383029383231 0 +4605 0.9644133904028225 0.9543010805490126 0 +4606 0.03558660959703946 0.9543010805492369 0 +4607 0.8461682838489979 0.9172448967858231 0 +4608 0.1538317161502788 0.9172448967862012 0 +4609 0.6583659327926346 0.9270635972431075 0 +4610 0.4429428010036467 0.8330283988417559 0 +4611 0.1888064620639478 0.4945501051057486 0 +4612 0.6631198990868146 0.8267140111677714 0 +4613 0.1840426968084858 0.7398133751899683 0 +4614 0.6335251775883236 0.1202161583586886 0 +4615 0.3367450146974876 0.826951304483424 0 +4616 0.616428729744779 0.04644741922359286 0 +4617 0.7733635198042366 0.6458078120245725 0 +4618 0.7211984903358652 0.8820832976046572 0 +4619 0.2788015096627712 0.8820832976052714 0 +4620 0.4791534119443885 0.787578150364989 0 +4621 0.162536170231705 0.3735201396869742 0 +4622 0.4309681104357922 0.9548491726490913 0 +4623 0.9376731744549708 0.966396171876972 0 +4624 0.06232682554474425 0.9663961718771367 0 +4625 0.1696840762533181 0.176595857913435 0 +4626 0.3709442894793484 0.2431212833787154 0 +4627 0.8045832888637388 0.989374059602862 0 +4628 0.1954167111353216 0.9893740596029115 0 +4629 0.7944195507668462 0.8800493777629592 0 +4630 0.2055804492321648 0.8800493777635386 0 +4631 0.2118768661757405 0.541004832766492 0 +4632 0.9337206777816904 0.6190329004581647 0 +4633 0.3233376376651838 0.5578462939970079 0 +4634 0.5139802863288074 0.9694212852097804 0 +4635 0.1656291894651775 0.6956296088971279 0 +4636 0.4871582255075413 0.9260467105996614 0 +4637 0.08785490363086111 0.5806506545499504 0 +4638 0.4894000631092195 0.5764959551055086 0 +4639 0.1976614433930418 0.7617886042226099 0 +4640 0.3029328830809087 0.8365365813296465 0 +4641 0.7688121921477635 0.7755390215497001 0 +4642 0.6737545422116287 0.9672155947472447 0 +4643 0.267394030215762 0.6288909262158033 0 +4644 0.6064630045692776 0.9657102705349869 0 +4645 0.6398808037930525 0.9493605958438921 0 +4646 0.3125833889387641 0.10839828534683 0 +4647 0.9443246291098051 0.8213818853687735 0 +4648 0.0556753708902047 0.8213818853691165 0 +4649 0.8515242230834098 0.8419582861881788 0 +4650 0.1484757769158916 0.841958286188924 0 +4651 0.5717865089234286 0.9531005438444464 0 +4652 0.2426695765718246 0.04826575958911149 0 +4653 0.4734524130993858 0.9418956252865138 0 +4654 0.4897820688570365 0.8280755129462247 0 +4655 0.09882246878988105 0.1339258624876183 0 +4656 0.03634324117345915 0.3184878662393518 0 +4657 0.3737585788213664 0.9700197811360203 0 +4658 0.6829676893902019 0.7370922600338261 0 +4659 0.04077267648994397 0.2630329368382108 0 +4660 0.343616855403062 0.6031794897426037 0 +4661 0.5813878641110238 0.8001235296171295 0 +4662 0.5864782415471743 0.5751817370522 0 +4663 0.7609643196880868 0.9426518533527931 0 +4664 0.239035680310721 0.9426518533531025 0 +4665 0.5422980710746017 0.7202354270875634 0 +4666 0.1764786830590726 0.6051687894537738 0 +4667 0.890843946629132 0.8562218752622501 0 +4668 0.1091560533704969 0.8562218752628983 0 +4669 0.8877760725127395 0.728646069155289 0 +4670 0.4479592964604158 0.9277338408656963 0 +4671 0.6278304184349093 0.9703980071566377 0 +4672 0.8217129226401849 0.861886585195078 0 +4673 0.1782870773589861 0.8618865851957012 0 +4674 0.0922954587565132 0.7146573383997523 0 +4675 0.6452412588685267 0.7572654487724414 0 +4676 0.2186900212288417 0.3669804641294163 0 +4677 0.6243541570411193 0.4339104362760116 0 +4678 0.83777548351273 0.5839086172065586 0 +4679 0.3455099528682801 0.9091510094998272 0 +4680 0.383703095754286 0.9451462378648988 0 +4681 0.3212793524608306 0.6503362796174167 0 +4682 0.4004672814002893 0.9384855423848155 0 +4683 0.5519806990747315 0.8021602196877113 0 +4684 0.7788397127860316 0.9217230683022447 0 +4685 0.221160287212863 0.9217230683026205 0 +4686 0.3457546923314817 0.9310873864003271 0 +4687 0.5722852877663713 0.8598796120811396 0 +4688 0.6874945940947382 0.3638331845871921 0 +4689 0.5090506451233625 0.8784735388166433 0 +4690 0.5479808399402115 0.5375866836472826 0 +4691 0.5219087240804288 0.8236005122856793 0 +4692 0.5425099358730595 0.9300225465712653 0 +4693 0.4907260774864399 0.9040897167538066 0 +4694 0.9005109503369915 0.5326836724779357 0 +4695 0.983269406890333 0.8220426412891244 0 +4696 0.01673059310975603 0.8220426412890948 0 +4697 0.4754761064838336 0.5276316190376414 0 +4698 0.3903250466780014 0.889951621884964 0 +4699 0.9506880020002371 0.9306407753960131 0 +4700 0.04931199799953104 0.9306407753963561 0 +4701 0.3018522923177177 0.3888463629861081 0 +4702 0.3839839453798468 0.03665051767711594 0 +4703 0.8883539441947487 0.9872728831254562 0 +4704 0.1116460558047455 0.9872728831255082 0 +4705 0.286330095349761 0.5822026134988346 0 +4706 0.5393782117661581 0.7521160984954444 0 +4707 0.208811572854605 0.5924179073997022 0 +4708 0.7939853943914685 0.7235596100738861 0 +4709 0.2210470374894082 0.7594670820354784 0 +4710 0.03603616253243968 0.1880924726119536 0 +4711 0.3036796513565139 0.5220898252418664 0 +4712 0.5154613282918912 0.9883354811796519 0 +4713 0.6421464707708889 0.9341440850859943 0 +4714 0.117452466995229 0.5507304602602908 0 +4715 0.6667936216912146 0.4601533587484602 0 +4716 0.5531844556502952 0.3985222892166186 0 +4717 0.3168893924154402 0.9428790527534245 0 +4718 0.5204551633336221 0.9264992532641136 0 +4719 0.3022006552686977 0.6212168087779859 0 +4720 0.9152424296816811 0.2344292618557473 0 +4721 0.3760773062836893 0.9878999879005104 0 +4722 0.7837266766510144 0.9432940125264874 0 +4723 0.2162733233479274 0.9432940125267799 0 +4724 0.4076799512619956 0.4437178662111513 0 +4725 0.4975859594470461 0.4761749825917119 0 +4726 0.324463251956238 0.04499581125375135 0 +4727 0.4146976236798355 0.7246908303003929 0 +4728 0.9538862700152066 0.04633049007705144 0 +4729 0.3774636998957664 0.8716225704949093 0 +4730 0.9583353223241859 0.1653748879855031 0 +4731 0.9015805130137894 0.9862109090065347 0 +4732 0.09841948698576823 0.9862109090065951 0 +4733 0.414401146771723 0.8157852015133236 0 +4734 0.9203846424827297 0.8262823021023205 0 +4735 0.07961535751721931 0.8262823021027366 0 +4736 0.9061103537776959 0.1512129276506391 0 +4737 0.318637931874537 0.7309484800611064 0 +4738 0.9757102624061534 0.6070918659185583 0 +4739 0.2601411949091204 0.4320170794257248 0 +4740 0.7029467824269312 0.666954002396377 0 +4741 0.8715399292135444 0.9537452019357051 0 +4742 0.1284600707858677 0.9537452019359143 0 +4743 0.03660690144360458 0.4699482155651072 0 +4744 0.02115234061974883 0.6692755019580447 0 +4745 0.9392678820399233 0.6857310314867427 0 +4746 0.3739279011555624 0.4088167583692774 0 +4747 0.9530437810158608 0.9878883726563873 0 +4748 0.04695621898392399 0.987888372656445 0 +4749 0.8383715861939796 0.9651150884316164 0 +4750 0.1616284138052659 0.9651150884317923 0 +4751 0.9041974549634386 0.9435387285717887 0 +4752 0.09580254503611618 0.9435387285720216 0 +4753 0.4729540853753477 0.9707305604282104 0 +4754 0.7447637073575042 0.6046028284871913 0 +4755 0.5903072527419406 0.8809361827323285 0 +4756 0.7067970866651814 0.8649089851688362 0 +4757 0.2930248105820971 0.8667797075364094 0 +4758 0.1668991986014853 0.2583439151100742 0 +4759 0.1159014052448029 0.4208624844767714 0 +4760 0.8423494568515422 0.7131331252418645 0 +4761 0.7506363308139662 0.1986024027847505 0 +4762 0.6992252775687888 0.6117943730113155 0 +4763 0.5680277529825999 0.7009693496938558 0 +4764 0.1847974711280001 0.7018055607606748 0 +4765 0.4586745832089438 0.9857874070075663 0 +4766 0.7069727181665433 0.4806830738716628 0 +4767 0.3229818500318972 0.9870453585554235 0 +4768 0.7263537345733269 0.5370698933246615 0 +4769 0.2522338917591772 0.6037235717123212 0 +4770 0.3706660890842341 0.590267948045446 0 +4771 0.8532324282846449 0.8967909500031076 0 +4772 0.1467675717146815 0.8967909500035701 0 +4773 0.7720480490902275 0.09989864346685573 0 +4774 0.9502876830119171 0.705325885770417 0 +4775 0.462039299277943 0.8767269808360537 0 +4776 0.1838676898238972 0.1058650212504526 0 +4777 0.9717567890806549 0.09477842776969694 0 +4778 0.9874823599908193 0.918832877969032 0 +4779 0.01251764000922085 0.918832877969071 0 +4780 0.6426485491875844 0.7952646019017354 0 +4781 0.3898005155208747 0.1084151561917851 0 +4782 0.9701357849872999 0.4739650487699505 0 +4783 0.0977519534936709 0.5245453271723145 0 +4784 0.9071216418035936 0.917995343198596 0 +4785 0.09287835819602877 0.917995343198915 0 +4786 0.6464134764729039 0.9714459192604341 0 +4787 0.2634062269380283 0.3349741214895251 0 +4788 0.5453065797168508 0.849228923250815 0 +4789 0.3243487085257435 0.2162313851964586 0 +4790 0.7004522986424968 0.3086582563520808 0 +4791 0.6904468816706001 0.9166571339239435 0 +4792 0.3094264538322506 0.9173364158356385 0 +4793 0.5351297449746113 0.9897865846011558 0 +4794 0.4591462733673363 0.7986743435425099 0 +4795 0.46624237337618 0.3514937657393399 0 +4796 0.4498796212907062 0.9491382590605051 0 +4797 0.3948725543899022 0.9894898432300012 0 +4798 0.08416083710533308 0.3291235883042632 0 +4799 0.6434825029665128 0.4017990504140753 0 +4800 0.9132336404005781 0.712345722184566 0 +4801 0.154011185808148 0.5336151742399392 0 +4802 0.3184332630961052 0.4709599927192966 0 +4803 0.1755076067365019 0.5517458006067848 0 +4804 0.6817007472810082 0.9450435357394182 0 +4805 0.8249884979852271 0.9109757754319345 0 +4806 0.1750115020139618 0.9109757754323851 0 +4807 0.8415933286254386 0.7524374246490647 0 +4808 0.7577450468202758 0.7184948859545455 0 +4809 0.8947739750908076 0.8936729836457905 0 +4810 0.1052260249087004 0.8936729836461729 0 +4811 0.6932236066475181 0.03473555838166742 0 +4812 0.5234212839220425 0.7867992677044451 0 +4813 0.8547459436581936 0.9650644923130818 0 +4814 0.1452540563411435 0.9650644923132412 0 +4815 0.97870877781248 0.6998854029806129 0 +4816 0.1558351086076337 0.4607026532243549 0 +4817 0.6989510646762392 0.8971903548871293 0 +4818 0.3010679240579274 0.8972323457263673 0 +4819 0.7013210049668487 0.9366044382436403 0 +4820 0.2986789950316359 0.9366044382439699 0 +4821 0.2266617024085076 0.7300499024592004 0 +4822 0.753107886442509 0.5729437332047816 0 +4823 0.6579763470566573 0.5041898843185321 0 +4824 0.8534118492987305 0.2359225900825024 0 +4825 0.08787294656800879 0.2120803019339342 0 +4826 0.2566664254068449 0.1780281697207023 0 +4827 0.8610660654085907 0.9569944779369624 0 +4828 0.1389339345907797 0.9569944779371602 0 +4829 0.5168416413228664 0.8957043087359037 0 +4830 0.6849406413491419 0.9919741862487816 0 +4831 0.7369806690829535 0.7154714355237344 0 +4832 0.6352713520513373 0.3361783905295457 0 +4833 0.6631799426860425 0.8755872493841583 0 +4834 0.3343288417891963 0.8757371426646688 0 +4835 0.9212291821833167 0.4057688694454099 0 +4836 0.864533335745074 0.1749122852578967 0 +4837 0.8336401401452128 0.9351325024402659 0 +4838 0.1663598598539914 0.9351325024405801 0 +4839 0.9105719078738415 0.6933988211279581 0 +4840 0.1424700919425121 0.3244341106681659 0 +4841 0.3581436736382321 0.796085658259623 0 +4842 0.9866134916948113 0.8930276506698603 0 +4843 0.01338650830528441 0.8930276506700876 0 +4844 0.8854192215159641 0.4876464359684089 0 +4845 0.5112520014175465 0.7590561206453793 0 +4846 0.6739313214184883 0.5969003856142566 0 +4847 0.3962959242549647 0.1634103260995631 0 +4848 0.8418447288494723 0.6762392938320727 0 +4849 0.9812569543096901 0.7848086677942459 0 +4850 0.01881372307979026 0.784729680474942 0 +4851 0.5137882628568271 0.3448366643845642 0 +4852 0.6887412027995981 0.2799340431496175 0 +4853 0.3622576993715632 0.5558428502585545 0 +4854 0.8056540770659428 0.2255853336345931 0 +4855 0.7189541380423627 0.8983786304157029 0 +4856 0.2810458619562458 0.8983786304162266 0 +4857 0.4071422309509173 0.9066984365929293 0 +4858 0.3794908868929149 0.815528868683733 0 +4859 0.3906917424510144 0.9182645475537514 0 +4860 0.7643327580337487 0.8396289482675536 0 +4861 0.2356672419650704 0.8396289482683506 0 +4862 0.594179502331774 0.9422974148993919 0 +4863 0.2381319771190976 0.6541169956965004 0 +4864 0.04976822784603793 0.6470641056222776 0 +4865 0.2696311499596786 0.2655317962671416 0 +4866 0.6855808341411013 0.4264429487141561 0 +4867 0.2792984786222473 0.4855304016234051 0 +4868 0.8653692909073772 0.8937983944388876 0 +4869 0.1346307090919995 0.8937983944393508 0 +4870 0.4646445080823403 0.9171635523180393 0 +4871 0.3390732559792228 0.1653333860733532 0 +4872 0.8818116651006314 0.09635827041908013 0 +4873 0.0710724602790857 0.2589720601952441 0 +4874 0.9669330412288966 0.8970193946804021 0 +4875 0.03306695877102058 0.897019394680634 0 +4876 0.8581159660750072 0.4888105791675406 0 +4877 0.343137009468495 0.4136362236236475 0 +4878 0.4300069976316885 0.9407615544179262 0 +4879 0.92183722061317 0.3566452204022475 0 +4880 0.5411570884081236 0.8832889544571457 0 +4881 0.3804137415704192 0.8985971720481861 0 +4882 0.5884998556684197 0.8189499213621407 0 +4883 0.6210106433351182 0.7201595945534632 0 +4884 0.9392482389685999 0.8913670476919378 0 +4885 0.06075176103109051 0.8913670476923846 0 +4886 0.5973277905118165 0.4385653140347797 0 +4887 0.6437692556791206 0.5921337346343518 0 +4888 0.580827871199326 0.8463249746306249 0 +4889 0.0207555340205806 0.5614069667224633 0 +4890 0.5676780410388665 0.5864898067351718 0 +4891 0.409165948070006 0.9508379929917182 0 +4892 0.9120701699761391 0.8688189869949596 0 +4893 0.0879298300234842 0.8688189869954061 0 +4894 0.8216741780674429 0.6430362163340165 0 +4895 0.9567557391353608 0.8142238572030772 0 +4896 0.04324426086468629 0.814223857203475 0 +4897 0.8452598851269453 0.9919788388723468 0 +4898 0.1547401148723363 0.9919788388723856 0 +4899 0.3012535695097676 0.7270220639585969 0 +4900 0.08519945312496757 0.6879541386102408 0 +4901 0.1212305375370554 0.6058311120064905 0 +4902 0.6798516998739077 0.8621277019237192 0 +4903 0.5063825376103249 0.7303727346379085 0 +4904 0.5173529196371808 0.8098411763964857 0 +4905 0.319858397357064 0.8614580706638379 0 +4906 0.5831218997312944 0.1823005388706544 0 +4907 0.5844274985768679 0.9257511830330689 0 +4908 0.4329034356593415 0.9135254494244904 0 +4909 0.9882447928851326 0.9515333211752529 0 +4910 0.01175520711475586 0.9515333211753346 0 +4911 0.7614647789325117 0.9072063927657334 0 +4912 0.2385352210663179 0.9072063927662035 0 +4913 0.6555658412948502 0.1712422902539469 0 +4914 0.2269349892538937 0.7851895024128966 0 +4915 0.2689394213876476 0.1062987817639553 0 +4916 0.7741688335458601 0.6170553067630911 0 +4917 0.8504232472537413 0.868568429519886 0 +4918 0.1495767527456071 0.8685684295205204 0 +4919 0.5553371157468618 0.9668903932523448 0 +4920 0.9504543417442475 0.7792295477871676 0 +4921 0.04955584242121347 0.7792065792234086 0 +4922 0.6390229153025938 0.8868952957083898 0 +4923 0.4393717364242948 0.6384980245982943 0 +4924 0.792000395902256 0.5886133219622913 0 +4925 0.8381583179030774 0.4219285671945029 0 +4926 0.9593761323240499 0.8843205818270767 0 +4927 0.04062386767575279 0.8843205818274329 0 +4928 0.5562683127146044 0.8834025456384866 0 +4929 0.8244651952184097 0.29510496941279 0 +4930 0.4270495583709386 0.6016844574337572 0 +4931 0.7709771901304896 0.691126737716119 0 +4932 0.6740535670200983 0.6627558843658486 0 +4933 0.7935021997556228 0.8408471559206453 0 +4934 0.2064978002433695 0.8408471559214012 0 +4935 0.5016369650488244 0.9700546122985526 0 +4936 0.5181429392166683 0.9452174919567924 0 +4937 0.5617586118445117 0.3533195127368686 0 +4938 0.9391004011153563 0.9037031976277033 0 +4939 0.06089959888436425 0.903703197628116 0 +4940 0.3612740057620218 0.9704312148077653 0 +4941 0.9357428002652518 0.5218856282729798 0 +4942 0.6289323365825634 0.8162332087032099 0 +4943 0.6636577287111055 0.8422217773575574 0 +4944 0.8389930540837744 0.3486254496723106 0 +4945 0.5521091244585765 0.4716962774820758 0 +4946 0.0160768216810224 0.7567231012665407 0 +4947 0.5327758515931108 0.9693305123988698 0 +4948 0.06140322785685506 0.55434875509074 0 +4949 0.5949999999989318 0.9896743306675176 0 +4950 0.8526507761503672 0.9459727691155227 0 +4951 0.1473492238489647 0.9459727691157815 0 +4952 0.6059897866569937 0.648221616418463 0 +4953 0.1147971940073089 0.7334704318800198 0 +4954 0.5583796942184404 0.9064835979423049 0 +4955 0.3363217241385607 0.842436546283304 0 +4956 0.03850236423959316 0.09223241709515365 0 +4957 0.423912494962583 0.3739676787543106 0 +4958 0.122613343865234 0.6948602717497976 0 +4959 0.01739095052503276 0.7240122910365234 0 +4960 0.6596385946464987 0.9884823983635385 0 +4961 0.891609952070811 0.6351941172933716 0 +4962 0.9701233425486937 0.3855839624186008 0 +4963 0.6608684790487522 0.7237568407611457 0 +4964 0.8506599925225098 0.2774471178430595 0 +4965 0.9575392037037951 0.9719460787129743 0 +4966 0.04246079629601784 0.9719460787131006 0 +4967 0.4165234454691434 0.9685284732413898 0 +4968 0.6126997242297176 0.918753344013894 0 +4969 0.9243124297470835 0.9450027394415761 0 +4970 0.07568757025256428 0.9450027394418223 0 +4971 0.469412428443719 0.9873305421820943 0 +4972 0.9206785601418177 0.9883261835303713 0 +4973 0.07932143985782412 0.9883261835304251 0 +4974 0.8120596512818863 0.9716240029911875 0 +4975 0.1879403487172224 0.9716240029913346 0 +4976 0.770818961999802 0.5407847038476805 0 +4977 0.6780513723973082 0.556559581606751 0 +4978 0.8978800267028546 0.9650858097316245 0 +4979 0.1021199732966838 0.9650858097317708 0 +4980 0.2814583273623882 0.6605158687020138 0 +4981 0.6976630200450493 0.7251208411348475 0 +4982 0.9840376089994251 0.7566061775203701 0 +4983 0.2858278448269874 0.7508807873504714 0 +4984 0.4967057804983742 0.5403417806675415 0 +4985 0.0502412847724172 0.7290836029317831 0 +4986 0.4619733789950513 0.6833897821083876 0 +4987 0.1265196311941812 0.1052868787407596 0 +4988 0.5078650324906274 0.920853151620471 0 +4989 0.6384852374803074 0.9066750780921067 0 +4990 0.7364731746683442 0.9634558221396033 0 +4991 0.26352682533033 0.9634558221398006 0 +4992 0.6891160658765612 0.095586999814881 0 +4993 0.5037471252528016 0.03896728383413605 0 +4994 0.7409006006397647 0.1146974479522675 0 +4995 0.5846151771762893 0.4074213038568516 0 +4996 0.4356922089734407 0.2825480949955279 0 +4997 0.5657721700122448 0.6792269593696305 0 +4998 0.3290380934332648 0.7877825393167952 0 +4999 0.6008386672399046 0.5294596771608022 0 +5000 0.8349443019474909 0.1155078734206416 0 +5001 0.5023860274722214 0.4469952352949974 0 +5002 0.2703961986714706 0.7021330932908022 0 +5003 0.8131925906621872 0.5408623304963612 0 +5004 0.1297273817789141 0.3724489656835632 0 +5005 0.4246599612086099 0.892802538746626 0 +5006 0.7763100154696981 0.8175158354587705 0 +5007 0.224388566535772 0.8143499829202114 0 +5008 0.7387215804611236 0.8599480188863123 0 +5009 0.2612784195375815 0.8599480188870301 0 +5010 0.8738488187496469 0.9103083738585536 0 +5011 0.1261511812497844 0.9103083738589435 0 +5012 0.7640515782274189 0.9545568547767385 0 +5013 0.2359484217714112 0.9545568547769883 0 +5014 0.831373130403257 0.558973945333673 0 +5015 0.8680757780772883 0.7609818948504242 0 +5016 0.1294638476459006 0.7621854941318609 0 +5017 0.3110613243373024 0.9887124541688382 0 +5018 0.9220427250238703 0.8606626323998143 0 +5019 0.07795727497578882 0.8606626324000337 0 +5020 0.9417861678840085 0.9882404659601929 0 +5021 0.05821383211572397 0.9882404659602515 0 +5022 0.9508270654451244 0.6682004222911797 0 +5023 0.3576787744724399 0.880599975592869 0 +5024 0.539802939757584 0.559770182072023 0 +5025 0.9510671300938625 0.7283624091990097 0 +5026 0.3640675996448079 0.7801075237679895 0 +5027 0.7261385643689831 0.9048692713818269 0 +5028 0.2738614356296784 0.904869271382306 0 +5029 0.6894460039748181 0.8872028865297157 0 +5030 0.9767714993954091 0.5425049972617094 0 +5031 0.9890027316946549 0.989000540458386 0 +5032 0.01099726830529886 0.9890005404584415 0 +5033 0.2625865754587793 0.6781752340475971 0 +5034 0.6179101965904941 0.9044299794826774 0 +5035 0.8132547235347167 0.9300743709896309 0 +5036 0.1867452764643688 0.9300743709899744 0 +5037 0.524406284522958 0.6934598319220648 0 +5038 0.3782615092491156 0.6349084305757908 0 +5039 0.6626652689566008 0.9506616219228358 0 +5040 0.6357162801957256 0.7785853647002019 0 +5041 0.8079114243299492 0.4258195863764619 0 +5042 0.310669965047068 0.8874551173656591 0 +5043 0.5549999999988277 0.9901655800605581 0 +5044 0.4959856217483723 0.9347314385464558 0 +5045 0.8299251139348738 0.8494739936103051 0 +5046 0.1700748860643388 0.8494739936109762 0 +5047 0.9081341703779142 0.04199459703658354 0 +5048 0.4142142758511766 0.9901135727327277 0 +5049 0.6378346716925686 0.2716722621385447 0 +5050 0.3673172576599544 0.9254441912547576 0 +5051 0.341527304482369 0.7627282999896445 0 +5052 0.4572721953121752 0.4155414208131247 0 +5053 0.5079572227263804 0.9500590199160572 0 +5054 0.2376816224658554 0.5742879074884594 0 +5055 0.9745244879306684 0.9902246194537165 0 +5056 0.02547551206921556 0.9902246194537441 0 +5057 0.6470587007778921 0.8555032461852675 0 +5058 0.5673889778672723 0.9406226592572706 0 +5059 0.6337581749228091 0.8463703739453378 0 +5060 0.5680323270783914 0.619191751873434 0 +5061 0.3538035277627635 0.8554430117307273 0 +5062 0.9014051075500746 0.6745583420229271 0 +5063 0.362466098917026 0.5049490863164018 0 +5064 0.3032603398106136 0.2865897644662442 0 +5065 0.1668815528163587 0.4039936364586142 0 +5066 0.1149500146128309 0.2772232090223813 0 +5067 0.1038851676812076 0.4651185606369614 0 +5068 0.4167324326882833 0.9260644692142805 0 +5069 0.7260181865851827 0.8040003642686325 0 +5070 0.3667160608091209 0.8457082816651672 0 +5071 0.3375061969047695 0.9705560191777511 0 +5072 0.7709624176420664 0.860802271390925 0 +5073 0.2290375823568365 0.8608022713916104 0 +5074 0.3960363219438788 0.3418465616041335 0 +5075 0.8119044025164397 0.6225464764590295 0 +5076 0.7444478833547234 0.6530663121773012 0 +5077 0.9900870695089854 0.9740975766235083 0 +5078 0.009912930491006593 0.9740975766234434 0 +5079 0.6376626905082672 0.5421582446319432 0 +5080 0.882375713780329 0.4401770692029364 0 +5081 0.4233996334594649 0.501888588002483 0 +5082 0.5428061534853096 0.81528977011626 0 +5083 0.8418724173188554 0.4677704237995647 0 +5084 0.4991339399869228 0.1840936993494534 0 +5085 0.8145705633159045 0.4724900903893299 0 +5086 0.8794684170086874 0.8824090096761323 0 +5087 0.1205315829908034 0.882409009676679 0 +5088 0.8050354954308878 0.4975883164856864 0 +5089 0.539473507225385 0.9071666360462252 0 +5090 0.361841210997004 0.4619573963603034 0 +5091 0.6331763645938775 0.6755800527522283 0 +5092 0.3859019818705427 0.5452656141405366 0 +5093 0.7404097078117062 0.749567729670761 0 +5094 0.02426725050262713 0.5169077631239762 0 +5095 0.7350939361304537 0.2515185926560914 0 +5096 0.6944706543320254 0.8731269822252588 0 +5097 0.7549999999993506 0.9903290090863985 0 +5098 0.2449999999994267 0.9903290090864517 0 +5099 0.3049534398688937 0.8734395338209101 0 +5100 0.935015700045758 0.4650474016749379 0 +5101 0.9681883080967127 0.496159786458995 0 +5102 0.7574164732983483 0.9304000256103756 0 +5103 0.2425835267004221 0.9304000256107443 0 +5104 0.6679466562036168 0.7865025630812479 0 +5105 0.8676661591069351 0.8445424800436135 0 +5106 0.1323338408925055 0.8445424800443757 0 +5107 0.3965123040782078 0.9774344107467947 0 +5108 0.4633280914129501 0.9659574602560177 0 +5109 0.7434656305206264 0.8237742245075967 0 +5110 0.2564873184514615 0.8238014769213915 0 +5111 0.9875230391491112 0.877410239057554 0 +5112 0.01247696085091714 0.8774102390575679 0 +5113 0.9344352611065331 0.7862586582770836 0 +5114 0.06556643625437983 0.7862548301835087 0 +5115 0.07285218411704038 0.3743053252397239 0 +5116 0.5690688878614443 0.9884829867286287 0 +5117 0.918905279245612 0.6006463948797403 0 +5118 0.4884531609779322 0.8842874628335226 0 +5119 0.9385202869210686 0.426289076893779 0 +5120 0.3158454751715092 0.8108558668298599 0 +5121 0.2342772624585029 0.6977847790370839 0 +5122 0.1375560793509955 0.2412083549386412 0 +5123 0.8449277634710357 0.5122831048780057 0 +5124 0.3046490019366623 0.9736185977841556 0 +5125 0.4752514563070881 0.8493880381711767 0 +5126 0.8542636486616962 0.6358716960267065 0 +5127 0.159698607478097 0.6789674547320546 0 +5128 0.643179236437199 0.4570935370095192 0 +5129 0.9144916963961325 0.894988459585855 0 +5130 0.08550830360344575 0.8949884595862676 0 +5131 0.9794660158838493 0.6753535209176129 0 +5132 0.8759631735047175 0.8567867564461413 0 +5133 0.1240368264947878 0.8567867564468286 0 +5134 0.1065252412336773 0.6639520236739958 0 +5135 0.2729260486338548 0.8062375519545395 0 +5136 0.8247815631215808 0.873716394453576 0 +5137 0.1752184368776253 0.8737163944541487 0 +5138 0.1897958296536132 0.3628880831336247 0 +5139 0.2499765241256236 0.7778883417090875 0 +5140 0.4071588647271394 0.8786305850592516 0 +5141 0.9128290240514687 0.841612734318911 0 +5142 0.08717097594838139 0.8416127343193748 0 +5143 0.02021287514756727 0.6235310925027717 0 +5144 0.6833829303666863 0.809024993201573 0 +5145 0.7853851154229555 0.3637018413143718 0 +5146 0.9813855232682474 0.5824742374836429 0 +5147 0.6102487421769622 0.8404201126373591 0 +5148 0.8733887577610135 0.6452625804511727 0 +5149 0.6608307860632888 0.3404079451449157 0 +5150 0.7983154869289883 0.789749236217539 0 +5151 0.2007968431690567 0.788833209365527 0 +5152 0.2073358737309552 0.4751016105422445 0 +5153 0.4803674957188557 0.8717115947124536 0 +5154 0.4426179569882082 0.4599504285728154 0 +5155 0.3619259225591073 0.8272109728864515 0 +5156 0.3554589461253074 0.9900837727039768 0 +5157 0.7767623535846901 0.990415880856788 0 +5158 0.223237646414211 0.9904158808568384 0 +5159 0.3975313790813489 0.4854341553029497 0 +5160 0.7150576304248653 0.9214683325151571 0 +5161 0.2849423695736952 0.9214683325155684 0 +5162 0.8543899416175985 0.4433571639152616 0 +5163 0.5819498798337325 0.9738230202218257 0 +5164 0.8063587237214788 0.7648135803400234 0 +5165 0.6958502305517058 0.8432078684934278 0 +5166 0.8360303725091969 0.04260653122301998 0 +5167 0.02621771837397401 0.3610286017234519 0 +5168 0.8696606899499334 0.9876609965077148 0 +5169 0.1303393100494757 0.9876609965077693 0 +5170 0.3341959893916868 0.9486358002402255 0 +5171 0.7436449067316085 0.4855718594521251 0 +5172 0.3569968154737739 0.9340834567269148 0 +5173 0.9681340456894977 0.9120110262325437 0 +5174 0.03186595431037328 0.9120110262330162 0 +5175 0.5435345226335198 0.4426095664459463 0 +5176 0.7487429352657344 0.5232106718544247 0 +5177 0.8207130038585 0.9548641209837042 0 +5178 0.179286996140646 0.9548641209839337 0 +5179 0.1584010394322435 0.7570371930364312 0 +5180 0.836825997525934 0.7723228680179753 0 +5181 0.2218523669649008 0.3962223316466019 0 +5182 0.7949999999994575 0.9908505882277465 0 +5183 0.204999999999543 0.9908505882277991 0 +5184 0.5417726202450382 0.7377555063450446 0 +5185 0.4383769047755908 0.8865817051417482 0 +5186 0.574555457092024 0.253403247818946 0 +5187 0.4621625070830343 0.440425029850484 0 +5188 0.9654227948826408 0.7877030491989589 0 +5189 0.03457720511725808 0.7877030491994333 0 +5190 0.1299790940145652 0.5034814486219871 0 +5191 0.4324054644828936 0.6996879538674258 0 +5192 0.1503559531774301 0.6394734883506403 0 +5193 0.2158534875305875 0.631746834386633 0 +5194 0.7090517307547576 0.3877709622683964 0 +5195 0.5858872264027336 0.9518754441734321 0 +5196 0.8565320932108919 0.7289850511565991 0 +5197 0.6136706840905868 0.8112392689471736 0 +5198 0.238115062702037 0.5139247698001013 0 +5199 0.8479069533546687 0.8549830104588492 0 +5200 0.1520930466446317 0.8549830104595373 0 +5201 0.5998767784867676 0.8904142414672902 0 +5202 0.5393277206267002 0.2916538515410138 0 +5203 0.805406002837185 0.8880715436557264 0 +5204 0.1945939971618714 0.8880715436562626 0 +5205 0.7772375961066424 0.8326297504502471 0 +5206 0.2228788342266912 0.8321021083611582 0 +5207 0.7668174442982527 0.8953508027249155 0 +5208 0.2331825557006116 0.8953508027254293 0 +5209 0.3424333137446891 0.5447217240797586 0 +5210 0.8205157561758523 0.837770214397819 0 +5211 0.1794842438232944 0.8377702143985475 0 +5212 0.8830028126541827 0.9533135146173488 0 +5213 0.1169971873452824 0.953313514617556 0 +5214 0.6946959043004026 0.9732307495146565 0 +5215 0.9360700638310563 0.7541472982841549 0 +5216 0.06392993616873585 0.7541472982846772 0 +5217 0.9398624986830005 0.5679549047713051 0 +5218 0.604177370866272 0.9764943476788297 0 +5219 0.8075491772361133 0.9048501113102634 0 +5220 0.1924508227629801 0.904850111310748 0 +5221 0.6228517738349927 0.6153168780852104 0 +5222 0.6326261579810137 0.928989566485664 0 +5223 0.7325960785849788 0.6219702714708674 0 +5224 0.8655585003149177 0.7778912400931604 0 +5225 0.9725535201360531 0.2644936684104823 0 +5226 0.1340196201633001 0.7789068587190143 0 +5227 0.9123430118126139 0.6563632945374235 0 +5228 0.3066298334747891 0.4362124759365882 0 +5229 0.2876192961424149 0.7338896847984326 0 +5230 0.4899992370050863 0.8142186915778594 0 +5231 0.706640242026236 0.9896319271960345 0 +5232 0.4303730967458493 0.7334833483198295 0 +5233 0.4767325465510325 0.9188784391144473 0 +5234 0.1380501193463946 0.5770252616307264 0 +5235 0.7632434635873423 0.8070239328148443 0 +5236 0.2372674749412016 0.80792183957368 0 +5237 0.255890201332829 0.4069164996566152 0 +5238 0.9282844235472367 0.9234016550842052 0 +5239 0.07171557645245262 0.9234016550845409 0 +5240 0.06528799927785493 0.4321214479949496 0 +5241 0.1766576888140433 0.289418804722693 0 +5242 0.7381690690418989 0.7955703565711139 0 +5243 0.617133428762052 0.8683853705007987 0 +5244 0.6939368945041369 0.1655306827226897 0 +5245 0.9260218840901469 0.3042453150095754 0 +5246 0.4481709195167204 0.5725819029032552 0 +5247 0.3728307874487243 0.7130280791519489 0 +5248 0.3897098822756728 0.839463962290024 0 +5249 0.3997821941353723 0.8555453845629071 0 +5250 0.1734993245506493 0.7763202093516812 0 +5251 0.742090131877999 0.9527379781504277 0 +5252 0.2579098681207102 0.9527379781506824 0 +5253 0.4821141852373999 0.2993129867789612 0 +5254 0.6720144972011768 0.7522723838228981 0 +5255 0.2330008762300516 0.2650899754366022 0 +5256 0.3725386845480658 0.3006344296584365 0 +5257 0.9042231491361261 0.7906231814785331 0 +5258 0.09577685086426178 0.7906231814790546 0 +5259 0.7939879977744374 0.2530369670517942 0 +5260 0.4536162473940435 0.8629012401679013 0 +5261 0.5212963154573466 0.1479593060513403 0 +5262 0.3246227488556793 0.926806955121945 0 +5263 0.8295458623780985 0.822029597332318 0 +5264 0.1704541376211094 0.8220295973331414 0 +5265 0.8558333757387951 0.8100727688163639 0 +5266 0.1441666242605573 0.8100727688171691 0 +5267 0.5196161522255479 0.4857737107830746 0 +5268 0.9843223995624026 0.7258518574591921 0 +5269 0.7018759523124585 0.7939921553216581 0 +5270 0.676016027205901 0.9285733367812452 0 +5271 0.9121452537933256 0.1154766126173065 0 +5272 0.755506620061819 0.7468307549357028 0 +5273 0.791575985934839 0.6088052663168417 0 +5274 0.2932798691915852 0.3224156276309679 0 +5275 0.5014369278155451 0.7134163020473379 0 +5276 0.82055080693794 0.5168836380138582 0 +5277 0.387533404737324 0.4621781094202846 0 +5278 0.05128400282736953 0.6287660496602137 0 +5279 0.03460714025316028 0.7533105507590314 0 +5280 0.3547544968696508 0.7399693958856419 0 +5281 0.2917601711017395 0.8254443557111342 0 +5282 0.9726322943127157 0.9357436505850862 0 +5283 0.02736770568715017 0.9357436505854155 0 +5284 0.4319654918597311 0.4059044408715901 0 +5285 0.6374361150961025 0.8284247037188236 0 +5286 0.5842379231280559 0.9913808476309784 0 +5287 0.7318062065405314 0.04257993922016536 0 +5288 0.02560615814477491 0.4468887657156778 0 +5289 0.4986757965944968 0.8595530560050555 0 +5290 0.3208581990273301 0.7499468631500931 0 +5291 0.3667655241511759 0.9508356120394291 0 +5292 0.4438340101402932 0.9597111088665262 0 +5293 0.7215801773459848 0.9436219837406786 0 +5294 0.2784198226526156 0.9436219837409818 0 +5295 0.9724657072513837 0.9580652277035442 0 +5296 0.02753429274847044 0.9580652277037225 0 +5297 0.8743623928258926 0.6977804221688909 0 +5298 0.7390161943571905 0.9136827936003996 0 +5299 0.2609838056415124 0.913682793600846 0 +5300 0.6323683379588645 0.7650808499292807 0 +5301 0.5235770841298011 0.9644236794299238 0 +5302 0.3322781282562632 0.246424902754788 0 +5303 0.3362405006770613 0.6713257412845458 0 +5304 0.9653690432395339 0.752528991473117 0 +5305 0.06287379901263582 0.6823045802867499 0 +5306 0.5372380963099356 0.7899851607455221 0 +5307 0.488660190545861 0.7758712787315541 0 +5308 0.8295298767544619 0.6054598431927647 0 +5309 0.09861230779935171 0.4038324746533998 0 +5310 0.4260518047415123 0.9922554152506118 0 +5311 0.5479763164510143 0.5863650408115094 0 +5312 0.6156685722985329 0.9472141273537935 0 +5313 0.7439761071343213 0.8897848336536878 0 +5314 0.2932919100414421 0.989676164650255 0 +5315 0.4563707391893222 0.7578789286387759 0 +5316 0.2560238928644302 0.8897848336542448 0 +5317 0.8717969861646168 0.9339535054886334 0 +5318 0.1282030138347887 0.9339535054889141 0 +5319 0.8361768973837429 0.6554329636143147 0 +5320 0.7721624882666293 0.4588009708542097 0 +5321 0.5629026383329533 0.8713537182590174 0 +5322 0.8477826548123145 0.8253913162917281 0 +5323 0.1522173451869763 0.8253913162925205 0 +5324 0.7076512537799944 0.7577794910488506 0 +5325 0.04985800291065232 0.5187901115382257 0 +5326 0.1969458240082952 0.6379959699686648 0 +5327 0.8739637297515515 0.8301474550132382 0 +5328 0.1260362702480043 0.8301474550141574 0 +5329 0.2411084893359467 0.4915948658299173 0 +5330 0.05406934188593593 0.710873543811207 0 +5331 0.5205186921204459 0.8697505543382205 0 +5332 0.2992074363023617 0.7843096476177206 0 +5333 0.8391046103578389 0.9468483478565857 0 +5334 0.1608953896414053 0.9468483478568449 0 +5335 0.1326735152528321 0.4791030194502448 0 +5336 0.5782782945324014 0.03281011326078123 0 +5337 0.4331656003184197 0.8416986674405361 0 +5338 0.1193585575141014 0.627472096040024 0 +5339 0.1595749620294631 0.7225253270156037 0 +5340 0.5389371993396629 0.9785569788626045 0 +5341 0.8078987044531767 0.950450476079024 0 +5342 0.1921012955458976 0.9504504760792704 0 +5343 0.8332403724215742 0.9742950945472981 0 +5344 0.1667596275776417 0.9742950945474309 0 +5345 0.3005307110320618 0.6645627141193889 0 +5346 0.5528369841890404 0.200441119057688 0 +5347 0.333818693788437 0.9918800823870025 0 +5348 0.7984870750002189 0.4524640829390401 0 +5349 0.7043617156350563 0.9566814952842739 0 +5350 0.2956689779394535 0.9566667840744669 0 +5351 0.8501845749080758 0.5479999732698959 0 +5352 0.9667778087269882 0.8723416609109442 0 +5353 0.03322219127293674 0.8723416609113666 0 +5354 0.397527838157975 0.6587464652802268 0 +5355 0.2834394819298297 0.6294922007435116 0 +5356 0.9178851767126699 0.5634088981991857 0 +5357 0.3226749168688524 0.8925151407023098 0 +5358 0.4027322168879597 0.9595759795357398 0 +5359 0.9416535657805366 0.9564428482482203 0 +5360 0.05834643421919553 0.956442848248432 0 +5361 0.5626690688892846 0.9183533116767988 0 +5362 0.5040859806015298 0.9916483304279144 0 +5363 0.8242849437424929 0.9906661568585273 0 +5364 0.1757150562566803 0.990666156858572 0 +5365 0.4325924217735703 0.7997492653317997 0 +5366 0.7997594736677044 0.9647470368919362 0 +5367 0.2002405263313317 0.9647470368921155 0 +5368 0.748687952595754 0.3997769667168176 0 +5369 0.9911302423176741 0.9390922546065326 0 +5370 0.008869757682275665 0.9390922546065725 0 +5371 0.5714276628474043 0.9780006191820558 0 +5372 0.4433513220044225 0.9910327184680642 0 +5373 0.02015509372546234 0.6011519107966657 0 +5374 0.1439101602146169 0.7508992823778862 0 +5375 0.6200939568871903 0.495286374946537 0 +5376 0.7274671818591365 0.848618449177415 0 +5377 0.2727440984472645 0.8482840530705651 0 +5378 0.6432544585052481 0.9900823207530784 0 +5379 0.3153442691296976 0.694139756825239 0 +5380 0.9128592016723825 0.2650902204886492 0 +5381 0.159984940955406 0.5758437202644342 0 +5382 0.7294863198714179 0.4465398443906924 0 +5383 0.03461466629849055 0.1569858678871573 0 +5384 0.3613033254546371 0.6445112137838246 0 +5385 0.1334747748295909 0.02819049858993528 0 +5386 0.01790504874113764 0.702903562862193 0 +5387 0.9638436100438381 0.8493952299419711 0 +5388 0.03615638995619053 0.8493952299423869 0 +5389 0.5104005688117166 0.5621606324279075 0 +5390 0.8485868936240687 0.3966638118287534 0 +5391 0.5822303777291926 0.551840157152456 0 +5392 0.3896076587326887 0.7913513153744456 0 +5393 0.6557923262270001 0.5578656295603011 0 +5394 0.6595613792812094 0.03087241957436808 0 +5395 0.455504869897236 0.832624089615408 0 +5396 0.430714586001322 0.9776977862790156 0 +5397 0.799015161172609 0.1139131715989302 0 +5398 0.3851924111465771 0.7342781241716263 0 +5399 0.9034115375009615 0.5855272665524046 0 +5400 0.9764633969399683 0.9714069577921862 0 +5401 0.02353660305993209 0.9714069577922384 0 +5402 0.9531856159126337 0.5451151946066675 0 +5403 0.5487345072633101 0.961641795492898 0 +5404 0.8550343707089232 0.991776536605103 0 +5405 0.1449656292904133 0.991776536605143 0 +5406 0.4095949693588038 0.8289658212092419 0 +5407 0.4707303367122314 0.2409402960610944 0 +5408 0.5116778845128261 0.5209975387284586 0 +5409 0.948700266946599 0.8652870429023096 0 +5410 0.05129973305320887 0.865287042902818 0 +5411 0.9557371753874487 0.9505996627925604 0 +5412 0.04426282461235116 0.9505996627928017 0 +5413 0.1900236045152789 0.2014261015874716 0 +5414 0.2516284256076846 0.5518628555944721 0 +5415 0.9049794834358502 0.956094044602073 0 +5416 0.0950205165637143 0.9560940446022459 0 +5417 0.7681526419839217 0.8822088838987264 0 +5418 0.2318473580149775 0.882208883899302 0 +5419 0.5517268935602417 0.9778392527422712 0 +5420 0.6095762548360281 0.5757632011835339 0 +5421 0.2782029378296607 0.2333285166087189 0 +5422 0.6038489335833827 0.7696910382109408 0 +5423 0.4554255657372077 0.9750238720835673 0 +5424 0.9217295542616711 0.7784756679481339 0 +5425 0.07827044573818411 0.7784756679486401 0 +5426 0.0569601898251524 0.6001080891940431 0 +5427 0.4534125120337798 0.1302057070658049 0 +5428 0.6785963509219842 0.9114897634988686 0 +5429 0.3214061824293293 0.9117030942611279 0 +5430 0.4479623742868082 0.8064744358316329 0 +5431 0.8700984782890788 0.8137393843248892 0 +5432 0.1298923027896278 0.8137823694942454 0 +5433 0.4070815336303174 0.5654014298713061 0 +5434 0.7982598870229242 0.920321011049468 0 +5435 0.2017401129760916 0.9203210110498637 0 +5436 0.3857889824962508 0.9568775252875303 0 +5437 0.8848042540411134 0.9750300667917142 0 +5438 0.1151957459583681 0.9750300667918295 0 +5439 0.7253672985631581 0.7444894453126124 0 +5440 0.7527173491819946 0.7796494565293146 0 +5441 0.9872643412536091 0.8360765319164613 0 +5442 0.0127356587464564 0.8360765319165909 0 +5443 0.5287487670019972 0.6004036303680786 0 +5444 0.4808491252312598 0.8967814592917207 0 +5445 0.8678887159904536 0.9773520719736983 0 +5446 0.1321112840089478 0.9773520719737979 0 +5447 0.8192413871692132 0.3270026798228309 0 +5448 0.8638986199260621 0.6770711066966006 0 +5449 0.656204751589869 0.9171708035957218 0 +5450 0.5613968859314671 0.7178427538203647 0 +5451 0.3162860952187156 0.9534833546138048 0 +5452 0.9243821805439771 0.8876907521736959 0 +5453 0.07561781945555764 0.8876907521741054 0 +5454 0.4439904574488259 0.4837494057208029 0 +5455 0.9812861975764479 0.6444857608277688 0 +5456 0.5040518698055525 0.4072939322662622 0 +5457 0.9220248530003212 0.9789342745811602 0 +5458 0.07797514699932542 0.9789342745812564 0 +5459 0.3362454457205817 0.1364889235546019 0 +5460 0.6646363417622405 0.9616263158970001 0 +5461 0.8354770044636219 0.916642079652676 0 +5462 0.5124672831166733 0.3170587371434307 0 +5463 0.1645229955356069 0.9166420796530689 0 +5464 0.6238916654382763 0.1531285795124489 0 +5465 0.7258991531483955 0.7750745506790402 0 +5466 0.3547141826196981 0.9792354562160113 0 +5467 0.8244141452760534 0.786149925585413 0 +5468 0.973824239619818 0.1984025237068864 0 +5469 0.5355102918854342 0.8715862303386365 0 +5470 0.3992839138922143 0.423239544475723 0 +5471 0.8206785076320313 0.8855775897074072 0 +5472 0.179321492367065 0.8855775897079745 0 +5473 0.8306744156839141 0.3751187999339283 0 +5474 0.9783512938703238 0.4346122874217232 0 +5475 0.9172992289072569 0.9621424837448881 0 +5476 0.08270077109235154 0.9621424837450498 0 +5477 0.4001678712280089 0.230635202175927 0 +5478 0.4292998355157529 0.8671609473071182 0 +5479 0.1701821508099538 0.6634286421819208 0 +5480 0.247214064599999 0.6690028371423605 0 +5481 0.474156470872927 0.6968213298219663 0 +5482 0.4883150042224449 0.3577933131781256 0 +5483 0.412271820788034 0.978136483673458 0 +5484 0.5185841181777961 0.8460022047843235 0 +5485 0.3637151209785919 0.912414423065845 0 +5486 0.9875734095010726 0.8542684724506094 0 +5487 0.01242659049910741 0.8542684724511194 0 +5488 0.100511394919102 0.6996254430150955 0 +5489 0.7503382237584979 0.8380481260152999 0 +5490 0.2496577753026152 0.8380504433981615 0 +5491 0.2014169844112082 0.3377436573696709 0 +5492 0.5531569511646668 0.8565583799784826 0 +5493 0.4447277549192254 0.9718957447137397 0 +5494 0.4614441745561382 0.6355003880692289 0 +5495 0.6847274382406103 0.6980859559490433 0 +5496 0.7980349165654693 0.2830942889728254 0 +5497 0.1290944461567794 0.7254461656483194 0 +5498 0.6472823288500297 0.7401083712785121 0 +5499 0.5862164631575041 0.7872753559023691 0 +5500 0.2170874585175655 0.716929277910235 0 +5501 0.1654909251600364 0.5085407896377312 0 +5502 0.3427872021021098 0.5200518285611331 0 +5503 0.8931274780412557 0.4136760383474667 0 +5504 0.8826239133720408 0.6091383870402014 0 +5505 0.05512825854499203 0.4838924275225751 0 +5506 0.6025994566539512 0.8644099993815014 0 +5507 0.2025651896243367 0.517104509009425 0 +5508 0.6851286599849921 0.9544998592213767 0 +5509 0.9320254351915518 0.9125040260230997 0 +5510 0.06797456480816653 0.9125040260234771 0 +5511 0.6095727311115193 0.7955262168751213 0 +5512 0.6022291934170609 0.6079738681031719 0 +5513 0.5980513429054879 0.7158983730613524 0 +5514 0.7234828937860174 0.9749331108982547 0 +5515 0.2765112018378619 0.9749194077902736 0 +5516 0.8241442473431402 0.7222453924264128 0 +5517 0.08634811767546006 0.6246035470102169 0 +5518 0.2556039592254978 0.7331266849260504 0 +5519 0.8754091968977979 0.5683376994277278 0 +5520 0.5519899413063067 0.5151485986008262 0 +5521 0.3430120655897429 0.9180536178825442 0 +5522 0.7055621899557852 0.5036702695973312 0 +5523 0.1955162804181866 0.5593828193001724 0 +5524 0.3600993968138387 0.6084896762581748 0 +5525 0.6309560170600991 0.9903573671516475 0 +5526 0.4488138620908716 0.9019382044842005 0 +5527 0.8299395747802094 0.8958353723292591 0 +5528 0.1700604252189947 0.895835372329749 0 +5529 0.771397184777298 0.9626497230096579 0 +5530 0.228602815221576 0.9626497230098636 0 +5531 0.7065210512995371 0.9776079155013749 0 +5532 0.8932936812599979 0.9413711074049326 0 +5533 0.1067063187395054 0.941371107405171 0 +5534 0.8980455169959847 0.843831670788858 0 +5535 0.1019544830037617 0.8438316707894635 0 +5536 0.8050067055518557 0.8326398088189563 0 +5537 0.1949932944472085 0.832639808819734 0 +5538 0.3396222096135629 0.4743375182876715 0 +5539 0.7546081962905744 0.1609839255644582 0 +5540 0.646367974758885 0.8990595550920751 0 +5541 0.5698755214619183 0.6606633870827534 0 +5542 0.1018274594523262 0.5950627439094738 0 +5543 0.2943039602534593 0.03313300207850058 0 +5544 0.2936310974782322 0.9777487270260797 0 +5545 0.4138212484669979 0.853749800033322 0 +5546 0.7987998981243964 0.7035997931868684 0 +5547 0.6201333796481213 0.6897487412572012 0 +5548 0.6009772632235473 0.6898912965369468 0 +5549 0.0882474807336209 0.3552069909803561 0 +5550 0.6143653959373696 0.9918316291630067 0 +5551 0.7912958077068686 0.3379126920930478 0 +5552 0.6499788438696997 0.6847590643604184 0 +5553 0.6327737113553942 0.956018515036325 0 +5554 0.8142949455562949 0.990409154555366 0 +5555 0.1857050544428209 0.990409154555411 0 +5556 0.4490198137376751 0.7273791444548212 0 +5557 0.7859054755000703 0.9018702341464622 0 +5558 0.2140945244988759 0.9018702341469291 0 +5559 0.3662989776733219 0.9899456238814075 0 +5560 0.5978325853579562 0.3032378723962288 0 +5561 0.5630154741940725 0.834949414765835 0 +5562 0.4532040188948471 0.775278687603895 0 +5563 0.697491071819567 0.6316999923397607 0 +5564 0.765887355442626 0.4817344895192572 0 +5565 0.5643632399795069 0.7735864450170581 0 +5566 0.7630030612773886 0.9764162541827136 0 +5567 0.2369969387214363 0.9764162541828451 0 +5568 0.4861044648225901 0.9910605548669137 0 +5569 0.5440187388397529 0.679466649092621 0 +5570 0.7664265480015803 0.3185765770388265 0 +5571 0.5707127519308206 0.3287573528605409 0 +5572 0.735527211140387 0.5894881064469477 0 +5573 0.4652586864521719 0.8879547084384811 0 +5574 0.7428285016305737 0.6855814511632351 0 +5575 0.3767599687823334 0.9349228122196115 0 +5576 0.3966783031688147 0.6993529464389833 0 +5577 0.6299201480454028 0.08746983622959485 0 +5578 0.3205470307177469 0.509284833171848 0 +5579 0.3521598484829305 0.3649425332737182 0 +5580 0.9386405262629913 0.9767560094307524 0 +5581 0.06135947373672658 0.9767560094308649 0 +5582 0.2451734544584768 0.3551138205655557 0 +5583 0.9906167689414833 0.9054532307891855 0 +5584 0.009383231058563705 0.9054532307891696 0 +5585 0.8865601448130269 0.9280841893294803 0 +5586 0.1134398551864527 0.9280841893297784 0 +5587 0.5225160948168954 0.9051365041407811 0 +5588 0.8794828897303075 0.9905552958070397 0 +5589 0.1205171102691472 0.9905552958070787 0 +5590 0.9510112255093535 0.7623564390258363 0 +5591 0.04899668659908214 0.7624599022489653 0 +5592 0.731113380295755 0.2216943434317518 0 +5593 0.7042869216244008 0.5678088629612119 0 +5594 0.918296938923728 0.80999636280986 0 +5595 0.08170306107631969 0.8099963628102523 0 +5596 0.9734387484768483 0.330816886964073 0 +5597 0.7225660869521737 0.7289274327375396 0 +5598 0.6379930068830233 0.8743322142146083 0 +5599 0.04134040972553626 0.563531191320163 0 +5600 0.2416144533652757 0.2049782977121427 0 +5601 0.8903307821610366 0.83159361138696 0 +5602 0.1096692178386882 0.8315936113876854 0 +5603 0.5742191367664858 0.7323936820953709 0 +5604 0.4307607965198856 0.03492660532162211 0 +5605 0.2829940031220662 0.5146474639777092 0 +5606 0.6157212794759834 0.742869901313584 0 +5607 0.02295083619549485 0.4067945811825622 0 +5608 0.2762487276516506 0.3906565698017028 0 +5609 0.3476739243606682 0.3071742442054349 0 +5610 0.8560265446014178 0.7529779244282659 0 +5611 0.078454428380867 0.5379034559996492 0 +5612 0.8453343505435607 0.8819958745556085 0 +5613 0.154665649455739 0.8819958745561592 0 +5614 0.1549117642048917 0.6123324107586591 0 +5615 0.9047360963435397 0.9750734105147547 0 +5616 0.0952639036560315 0.9750734105148575 0 +5617 0.02485109251083974 0.2899634880629488 0 +5618 0.4798874025895896 0.4886179221020566 0 +5619 0.307553803437068 0.5707564723501792 0 +5620 0.5244685195060483 0.9918272270684152 0 +5621 0.5357562856066952 0.6609737936555258 0 +5622 0.6950816584228044 0.991538335237184 0 +5623 0.6881609861511118 0.774288212906092 0 +5624 0.7351223828329303 0.9255015436884411 0 +5625 0.2648776171657347 0.925501543688836 0 +5626 0.3844940081412865 0.9918572373248629 0 +5627 0.104841889231163 0.1634152657378594 0 +5628 0.8782104458943975 0.7883276213819681 0 +5629 0.1217717656205278 0.7889014535299383 0 +5630 0.9335879310885734 0.8272998166261402 0 +5631 0.06641206891143331 0.8272998166264541 0 +5632 0.4584009204248881 0.9282631364137195 0 +5633 0.4960860681864642 0.9778873734090581 0 +5634 0.8926282565937668 0.7810532432688617 0 +5635 0.1086961397042765 0.7822015501782453 0 +5636 0.715319296161902 0.8563520324162497 0 +5637 0.2869584729050301 0.8561391975214327 0 +5638 0.8731370006986421 0.6624466908729536 0 +5639 0.9429043876555258 0.8092393497831563 0 +5640 0.05709561234453187 0.8092393497835376 0 +5641 0.4479377480630258 0.593694371490467 0 +5642 0.4848540082160493 0.8609454062589457 0 +5643 0.415754291572059 0.524495435895465 0 +5644 0.6494081906263591 0.7064424458104452 0 +5645 0.8083789441133744 0.8599676125747259 0 +5646 0.1916210558857173 0.8599676125753584 0 +5647 0.792284430123237 0.97484351844215 0 +5648 0.2077155698757742 0.9748435184422732 0 +5649 0.636270171850507 0.91650259045765 0 +5650 0.478161351628365 0.6040906380114676 0 +5651 0.7536100405101145 0.9158603216260431 0 +5652 0.2463899594886387 0.9158603216264947 0 +5653 0.1979038530928969 0.6604801444407856 0 +5654 0.5544801722847624 0.9274499912239706 0 +5655 0.6557079243174428 0.7988774055155315 0 +5656 0.775466436776811 0.7217222282242217 0 +5657 0.5763129503630114 0.9002951606983298 0 +5658 0.2731093681482079 0.6435556180974022 0 +5659 0.5309213678141723 0.9280610103125875 0 +5660 0.3419889128291569 0.6365303120478183 0 +5661 0.7934999531109665 0.4073675566198928 0 +5662 0.5363075739331393 0.8265115119200217 0 +5663 0.7345353427068382 0.9915542455509796 0 +5664 0.2654646572918293 0.9915542455510284 0 +5665 0.673498512292387 0.640661165231164 0 +5666 0.3237312920371785 0.6064303417992554 0 +5667 0.0188904012586162 0.4881643682618284 0 +5668 0.986840727094501 0.8075395053988763 0 +5669 0.01315927290552379 0.8075395053990693 0 +5670 0.733800902361639 0.6710063941543147 0 +5671 0.5820945738670994 0.5090397463907573 0 +5672 0.5502031157503957 0.2303147842513927 0 +5673 0.6610749378533124 0.6112375530763443 0 +5674 0.6185302139304856 0.9640171076040016 0 +5675 0.6986415875284411 0.9086518935142287 0 +5676 0.3013608599444918 0.9087461176206528 0 +5677 0.7232763853023411 0.8343799130739408 0 +5678 0.2773465229006703 0.8334796634544416 0 +5679 0.4662555949707989 0.6660297115845553 0 +5680 0.316319565802419 0.1869117667150414 0 +5681 0.1712160025009183 0.4803641428891834 0 +5682 0.9593509296824188 0.9223401495664639 0 +5683 0.04064907031739734 0.9223401495668508 0 +5684 0.7809901404495652 0.9307770982753808 0 +5685 0.2190098595493483 0.930777098275726 0 +5686 0.9126674545891106 0.9911963842983404 0 +5687 0.08733254541049518 0.9911963842983812 0 +5688 0.7826456042217502 0.5016268476264603 0 +5689 0.3669954571119478 0.8117113537338474 0 +5690 0.9079301712654129 0.9306496427479585 0 +5691 0.09206982873418536 0.9306496427482477 0 +5692 0.848343019849975 0.797443490349548 0 +5693 0.984479959087691 0.5627433166781165 0 +5694 0.1516471907959069 0.7975812900444379 0 +5695 0.9702205646687428 0.1329513057597193 0 +5696 0.3994118808700374 0.8950313412379606 0 +5697 0.8672292744643417 0.9189676233377002 0 +5698 0.1327707255350525 0.9189676233380514 0 +5699 0.3856455322968532 0.2767127648113841 0 +5700 0.7171041834116039 0.9920455254111091 0 +5701 0.2828845085984948 0.9920528983201806 0 +5702 0.3183672662906253 0.3699548828646443 0 +5703 0.5652047437355159 0.9635038682834358 0 +5704 0.3787112716857889 0.6980351690481456 0 +5705 0.8529442797658244 0.08277991971001927 0 +5706 0.4249036642187699 0.09808823558435482 0 +5707 0.425113256323624 0.9645103179311729 0 +5708 0.01311842530219071 0.7724737752075255 0 +5709 0.6841937018737366 0.4700699344350898 0 +5710 0.9251172889849526 0.4937512967062907 0 +5711 0.6371096357747819 0.9742053082590525 0 +5712 0.8556911934990434 0.9752220435181923 0 +5713 0.1443088065002922 0.9752220435183079 0 +5714 0.9392180843585147 0.7170599506555986 0 +5715 0.3245709269867547 0.9785831457316732 0 +5716 0.3486247035365549 0.7055071908804142 0 +5717 0.4871753723415304 0.1171744845165799 0 +5718 0.7884393552248558 0.6895639663170379 0 +5719 0.8894424778101472 0.9044430378030883 0 +5720 0.1105575221893087 0.9044430378034706 0 +5721 0.1331576949810652 0.7093141020158765 0 +5722 0.152214994391188 0.7086714845677322 0 +5723 0.3423985976085572 0.7945399983220308 0 +5724 0.4203744391332991 0.6869379174903053 0 +5725 0.7702263344684953 0.7916279071764292 0 +5726 0.5872484378754894 0.6222465869208643 0 +5727 0.2743793960346719 0.5600637208659758 0 +5728 0.2824310437581604 0.7790679273646406 0 +5729 0.3025783709367531 0.7988276069997851 0 +5730 0.4653146134565291 0.7864692235816284 0 +5731 0.5957053779905515 0.9053911342004082 0 +5732 0.6197799267211501 0.9288634677683001 0 +5733 0.3010727791933318 0.6813659223930525 0 +5734 0.1036585208243812 0.5649995266905909 0 +5735 0.9593916913688569 0.6442914917684753 0 +5736 0.5163656339564909 0.8335644992680263 0 +5737 0.2180165137655565 0.6125711436457545 0 +5738 0.5642083830749228 0.08911452190210944 0 +5739 0.6335126772728986 0.3817153093189032 0 +5740 0.733907968214052 0.8814786769480133 0 +5741 0.2660920317846421 0.881478676948618 0 +5742 0.2666982716877803 0.5921969584636639 0 +5743 0.4565655555525419 0.5334135539030858 0 +5744 0.8915358484190428 0.5111133322870078 0 +5745 0.1666273869692737 0.3140938996803629 0 +5746 0.9357375909487601 0.8705750120172491 0 +5747 0.06426240905089375 0.870575012017592 0 +5748 0.477726833745713 0.8235813610470327 0 +5749 0.3821138342579893 0.9654638141507843 0 +5750 0.7117941372878264 0.8045981886876605 0 +5751 0.3496566335994697 0.9618524638623698 0 +5752 0.3088195831889372 0.5442480262142994 0 +5753 0.03302271920423716 0.7287130295118605 0 +5754 0.8988172765641084 0.8660491361958964 0 +5755 0.1011827234355179 0.8660491361965285 0 +5756 0.9356762041656268 0.9450799036951482 0 +5757 0.06432379583407653 0.9450799036954112 0 +5758 0.8328647281208765 0.7986170911366302 0 +5759 0.1666503121640761 0.7990890091024248 0 +5760 0.1665568646619832 0.6462470320333548 0 +5761 0.01730383871726389 0.5391175803055884 0 +5762 0.4911781353708693 0.9622231139097221 0 +5763 0.6652765037026522 0.6774622664899423 0 +5764 0.8111164654299874 0.7528636815850559 0 +5765 0.798800081478778 0.6724848260035462 0 +5766 0.9523912520600085 0.5812942046490402 0 +5767 0.85788686107659 0.5301084469586086 0 +5768 0.5263548119830593 0.730449546430344 0 +5769 0.8135151556243996 0.1741955696415289 0 +5770 0.1364137650088493 0.6557089518425971 0 +5771 0.3921417618247485 0.6218382296567389 0 +5772 0.7865315193467698 0.9563880255474124 0 +5773 0.2134684806521884 0.956388025547636 0 +5774 0.7829302114052632 0.7380273203574916 0 +5775 0.3343248874522498 0.8869320910840024 0 +5776 0.5971519440285791 0.9680190515632603 0 +5777 0.9869308173104048 0.7724937501990174 0 +5778 0.7059455025447856 0.5261106044132892 0 +5779 0.4207333508141078 0.9482312270342557 0 +5780 0.8896050699271094 0.1839231487121193 0 +5781 0.5995305814673159 0.9186378981525803 0 +5782 0.3883105209905833 0.1904644224526155 0 +5783 0.287462701505919 0.8101205630321379 0 +5784 0.3263992754062334 0.5752542691373633 0 +5785 0.2320688680167728 0.7545729520423226 0 +5786 0.5184837287018034 0.9172160245785843 0 +5787 0.4352462079156247 0.7776490961601032 0 +5788 0.681785779863135 0.9617322558633097 0 +5789 0.2692894659167162 0.7553985603155705 0 +5790 0.4947779644675904 0.6778871106131925 0 +5791 0.7919397533795589 0.5500696810187932 0 +5792 0.8776986272069293 0.3207765272598251 0 +5793 0.7702568184722193 0.9466725879298774 0 +5794 0.2297431815266432 0.9466725879301743 0 +5795 0.7085272043045806 0.1226387059284735 0 +5796 0.8871704667827915 0.7421703647636975 0 +5797 0.3113436478892448 0.6347748720807382 0 +5798 0.50020612946761 0.908944852134233 0 +5799 0.07987419213962249 0.4586490783559408 0 +5800 0.2522434238575103 0.07948177443351009 0 +5801 0.5415786053037565 0.9407960622614164 0 +5802 0.9331420833268562 0.6641245265424456 0 +5803 0.3810126347414035 0.5186291995675811 0 +5804 0.1438607736078048 0.7342151955389079 0 +5805 0.3355149208449427 0.9277555878076584 0 +5806 0.02211572315856301 0.2358939775783405 0 +5807 0.09223175253205791 0.6732335063434889 0 +5808 0.7599033719639825 0.3715333504150437 0 +5809 0.5995692400997168 0.2408739025300914 0 +5810 0.7830551798210126 0.8612924856028388 0 +5811 0.2169448201779424 0.8612924856035027 0 +5812 0.6776613247615246 0.890373820801498 0 +5813 0.6933113309810272 0.3323618314027602 0 +5814 0.5952053395950058 0.9519066973265372 0 +5815 0.9736122170673833 0.8603332804919868 0 +5816 0.02638778293263773 0.8603332804923969 0 +5817 0.6808486381224306 0.4494793205437941 0 +5818 0.8513459454615592 0.6186457227348777 0 +5819 0.7341139351207745 0.5556981051826374 0 +5820 0.7655314740312021 0.6624049016300149 0 +5821 0.6451327353080236 0.9573186858847409 0 +5822 0.7449999999993338 0.9927120732159392 0 +5823 0.2549999999993979 0.9927120732159823 0 +5824 0.4449784759399323 0.2074205898756936 0 +5825 0.8740592910126415 0.3925499832940853 0 +5826 0.484580825750938 0.6634833603835271 0 +5827 0.6575903116893793 0.1075945392018394 0 +5828 0.4391007508986882 0.8569704027041999 0 +5829 0.08943960062781542 0.2805826408067499 0 +5830 0.5085452610560132 0.7938207820548214 0 +5831 0.2569419247028543 0.7973989730929767 0 +5832 0.8960900985259521 0.8063387424727755 0 +5833 0.1039099014740091 0.8063387424734364 0 +5834 0.3153147127174971 0.7755538187753493 0 +5835 0.1792310087597208 0.4417308426595597 0 +5836 0.06072535405899064 0.6640729147489484 0 +5837 0.6206325287592378 0.8467760081032563 0 +5838 0.4622092110676207 0.8487781567703898 0 +5839 0.4279059638538463 0.556589080626524 0 +5840 0.2986543209773786 0.847729528704124 0 +5841 0.4701379061707204 0.7112541817151093 0 +5842 0.8034147295675705 0.3818665064415744 0 +5843 0.4195700815575562 0.31372873746437 0 +5844 0.3068100201616368 0.8234780264000474 0 +5845 0.76536461239919 0.4161188910239795 0 +5846 0.9147837944387931 0.9722619606057226 0 +5847 0.0852162055608176 0.9722619606058439 0 +5848 0.5400292433539486 0.490094818833005 0 +5849 0.7207248656391616 0.9564425094990727 0 +5850 0.2792743143073836 0.9564406062898528 0 +5851 0.6599636873311245 0.7671003822809508 0 +5852 0.8500823110558664 0.9079631910568343 0 +5853 0.1499176889434395 0.9079631910572471 0 +5854 0.144418972257271 0.3512350258205863 0 +5855 0.8946050667908398 0.4604408144929691 0 +5856 0.1717992616636571 0.7474099628857297 0 +5857 0.6900653700526629 0.9376001650009549 0 +5858 0.9186106947445905 0.5307268193373686 0 +5859 0.921411928757037 0.7412771594526796 0 +5860 0.07648379325506376 0.7422534133409329 0 +5861 0.3295690879899254 0.2899422239441532 0 +5862 0.7941258958493993 0.9412821573017069 0 +5863 0.2058741041496009 0.9412821573019844 0 +5864 0.9731196284616547 0.9807369034574984 0 +5865 0.02688037153823319 0.9807369034575448 0 +5866 0.1853170079013104 0.6232042527506025 0 +5867 0.5965833297369094 0.852859160227655 0 +5868 0.2198134734566503 0.1555739740111867 0 +5869 0.7050610217075344 0.9474972330407966 0 +5870 0.2949564484938552 0.947471642689616 0 +5871 0.2680712631760345 0.3642557843263953 0 +5872 0.6659053493383351 0.906852208538613 0 +5873 0.559582504054297 0.9472262052749172 0 +5874 0.3202374067131224 0.96212631921998 0 +5875 0.09520617761490985 0.5081646441595635 0 +5876 0.5743380701902594 0.8155981715978979 0 +5877 0.3788793548987375 0.6697326107327828 0 +5878 0.8749926717867279 0.9719883855229426 0 +5879 0.125007328212707 0.9719883855230687 0 +5880 0.6799809986706793 0.2185852994509519 0 +5881 0.08102688062798041 0.7247346907080441 0 +5882 0.6959440627980849 0.7102771085540105 0 +5883 0.01393060078296705 0.6466353742591123 0 +5884 0.6406736849166699 0.6572267537602462 0 +5885 0.9405514767394725 0.8470345876176629 0 +5886 0.0594485232603594 0.8470345876180176 0 +5887 0.2156047220440743 0.1171917870968121 0 +5888 0.3675093728813748 0.1718046550766263 0 +5889 0.2967998303279936 0.6018667093799732 0 +5890 0.3081716571855894 0.9397050566521117 0 +5891 0.9334780302306691 0.1646445745051381 0 +5892 0.3657940250776894 0.8727138066672783 0 +5893 0.7902950581236463 0.8115448760897821 0 +5894 0.2094063211042025 0.8107199819949026 0 +5895 0.4858912704661862 0.9136013004892511 0 +5896 0.477458730661367 0.3999747739663564 0 +5897 0.976125216170173 0.91750365142822 0 +5898 0.02387478382978671 0.9175036514285241 0 +5899 0.7220402339121654 0.6993218587547123 0 +5900 0.7408782272172971 0.3561630964232372 0 +5901 0.240189544823903 0.4486127600517274 0 +5902 0.7110692775805528 0.5900504184368129 0 +5903 0.1340561631839129 0.5474000840717419 0 +5904 0.4077354001266836 0.9312696471709843 0 +5905 0.525464565562591 0.9523664692890907 0 +5906 0.5092123458915061 0.6472077621671612 0 +5907 0.9850195368169783 0.6265068015884395 0 +5908 0.3969208562913407 0.9286027602275783 0 +5909 0.9623607770783329 0.991309655917764 0 +5910 0.03763922292149697 0.991309655917797 0 +5911 0.1233673968097447 0.2135807151456949 0 +5912 0.1369691255938854 0.4376106802763087 0 +5913 0.7066515205636987 0.8191767091122729 0 +5914 0.723208068784003 0.9280577172778528 0 +5915 0.6613182848443586 0.2837440154635884 0 +5916 0.2767919312145935 0.9280577172782347 0 +5917 0.265198511184416 0.7714857906376555 0 +5918 0.750355059298372 0.8654254983047884 0 +5919 0.2496449407003984 0.8654254983054921 0 +5920 0.439053657320135 0.9322964016033675 0 +5921 0.3917395593863565 0.9418817592297308 0 +5922 0.3867192940402129 0.075425044124037 0 +5923 0.4798559038361584 0.7240008185817973 0 +5924 0.4490751758047421 0.8759868703503105 0 +5925 0.7673351628557599 0.7065936059491414 0 +5926 0.8008541371329791 0.03328852495823897 0 +5927 0.5625510559105686 0.1425954542760814 0 +5928 0.6001140902385795 0.3843994291584766 0 +5929 0.3484151502694347 0.8994812124838365 0 +5930 0.97236244152937 0.8113872864472376 0 +5931 0.02763755847065458 0.8113872864475333 0 +5932 0.1051963364094066 0.08164167196955435 0 +5933 0.5780617784668967 0.1175119694131741 0 +5934 0.5072176073548792 0.9619091011785712 0 +5935 0.6962732042401358 0.7427065597143415 0 +5936 0.4239237277882271 0.6330456871361846 0 +5937 0.3404190062889704 0.9401052355688574 0 +5938 0.1595808509474345 0.7725413264421446 0 +5939 0.7781137847106661 0.9806905428332851 0 +5940 0.2218862152882485 0.9806905428333886 0 +5941 0.07237563488626353 0.6530571950377947 0 +5942 0.9317662350899292 0.8008485588733055 0 +5943 0.06823383854971179 0.8008483927929941 0 +5944 0.3233024883520073 0.07621960694554006 0 +5945 0.6049834279654349 0.940028894214041 0 +5946 0.05158373249865376 0.3998402309829594 0 +5947 0.3016401461451921 0.4769034822517369 0 +5948 0.3420058071031243 0.9785473060589752 0 +5949 0.07284368471032507 0.5698874601806692 0 +5950 0.578788424781387 0.8893942280030481 0 +5951 0.5182709323407245 0.6606776938068708 0 +5952 0.589700555541551 0.7313300658649046 0 +5953 0.8686250949154513 0.8835672868363571 0 +5954 0.1313749050839766 0.8835672868368744 0 +5955 0.9144791926789964 0.9415017214749696 0 +5956 0.08552080732060202 0.9415017214752124 0 +5957 0.6314181589591346 0.7339875560741045 0 +5958 0.4975129180236609 0.2225865226868212 0 +5959 0.8148196830168506 0.6979266157629154 0 +5960 0.4596395907747728 0.7398161307389599 0 +5961 0.5906979025430606 0.3545080692510018 0 +5962 0.5688568270355644 0.745786369977856 0 +5963 0.5394530512486402 0.9188565391701985 0 +5964 0.7322180483592269 0.8263006250201956 0 +5965 0.2677819516394559 0.8263006250210895 0 +5966 0.9339088150678342 0.9922861096903196 0 +5967 0.06609118493186165 0.9922861096903597 0 +5968 0.1136663994720509 0.5131436261076319 0 +5969 0.4732608652174386 0.9610678497214648 0 +5970 0.8129522597134929 0.8107640754782732 0 +5971 0.1870115233819858 0.81056971734937 0 +5972 0.5526771246162976 0.7863160914254096 0 +5973 0.725354291418228 0.4681791047836801 0 +5974 0.1495204715769518 0.1964046293829141 0 +5975 0.8084935066535299 0.9809821227525511 0 +5976 0.1915064933455585 0.9809821227526392 0 +5977 0.1701100810460653 0.7337820502724637 0 +5978 0.3290565840859141 0.8173928084449686 0 +5979 0.2290727330028929 0.4735707996617625 0 +5980 0.2144156550494219 0.02960728998999813 0 +5981 0.8027418312081038 0.8179244441122672 0 +5982 0.1971871357759242 0.8177464449472398 0 +5983 0.6178797463087852 0.5403636706571301 0 +5984 0.670718308893248 0.8166976620330939 0 +5985 0.623795387219708 0.8899070802891178 0 +5986 0.9750996478380473 0.3562043219994103 0 +5987 0.6060233796328509 0.2104383245883918 0 +5988 0.3266758144612943 0.8339178256448804 0 +5989 0.5762167786791453 0.9927012056159867 0 +5990 0.5574145194242478 0.6477621970465243 0 +5991 0.3882249912262127 0.593067756123303 0 +5992 0.8507022733418599 0.9839549402300524 0 +5993 0.1492977266574481 0.9839549402301297 0 +5994 0.379590257427455 0.8458689080427849 0 +5995 0.2540918374068041 0.6392984913533328 0 +5996 0.8797986131751181 0.3679683753114548 0 +5997 0.9556420684286639 0.6182699349748231 0 +5998 0.507522007331726 0.5883319500496261 0 +5999 0.3669615586924611 0.9625121653156957 0 +6000 0.5773937164428997 0.7595359077096012 0 +6001 0.9623770245639214 0.7374555987913516 0 +6002 0.6585936852341076 0.8129247414519322 0 +6003 0.5111944662766876 0.6765085185032176 0 +6004 0.7859937304145656 0.9927092396041839 0 +6005 0.2140062695843854 0.9927092396042214 0 +6006 0.9047282741236936 0.7618374229382117 0 +6007 0.09400508981689661 0.7610988812589408 0 +6008 0.4877051489401004 0.981257921883385 0 +6009 0.8400904797621292 0.9261287232485922 0 +6010 0.1599095202371158 0.926128723248941 0 +6011 0.9814505319220542 0.5176986880877729 0 +6012 0.3315676704501845 0.9617105671580536 0 +6013 0.7105503321369375 0.4300546909360749 0 +6014 0.6755717697240684 0.992367773124794 0 +6015 0.6732232727567716 0.8346200160518531 0 +6016 0.2653365328047783 0.4599360908307733 0 +6017 0.3842604141680298 0.9100568192953374 0 +6018 0.5212139634614129 0.4397198931965354 0 +6019 0.8222429937602591 0.9744241416187831 0 +6020 0.1777570062389003 0.9744241416189194 0 +6021 0.2458460297637566 0.3137669413778819 0 +6022 0.579694132734485 0.485620053675856 0 +6023 0.3583942299401184 0.9460742529461267 0 +6024 0.9746519099441702 0.2361252064380428 0 +6025 0.2741813676895234 0.7252120373885802 0 +6026 0.5389129104064975 0.02641361821164382 0 +6027 0.499359150385416 0.7494049222389207 0 +6028 0.8747291481465567 0.9454540414306687 0 +6029 0.1252708518528662 0.9454540414309053 0 +6030 0.9606160872226495 0.9052590337497591 0 +6031 0.03938391277717437 0.9052590337501273 0 +6032 0.4324284955643811 0.6610171970054517 0 +6033 0.3357868963228318 0.7290631630345411 0 +6034 0.534642264835455 0.706819051638236 0 +6035 0.8586047292978233 0.9372251305885142 0 +6036 0.1413952707015403 0.9372251305888047 0 +6037 0.737048590898945 0.9008889546781209 0 +6038 0.2629514090997688 0.900888954678623 0 +6039 0.4466525841454734 0.6909967793747119 0 +6040 0.5882686156722914 0.8312599975081422 0 +6041 0.5539037903242234 0.3749073370304704 0 +6042 0.5632812820447248 0.452113963273801 0 +6043 0.5354172468099235 0.9478317280038863 0 +6044 0.3417361359934372 0.8154858736224386 0 +6045 0.7469852513260367 0.9775921399053573 0 +6046 0.2530147486726942 0.9775921399054848 0 +6047 0.5069849080877348 0.8676018051971637 0 +6048 0.3713144197467877 0.7635276926974567 0 +6049 0.7653129675173599 0.9915443593876709 0 +6050 0.2346870324814776 0.9915443593877172 0 +6051 0.6376700830224332 0.6287307101860051 0 +6052 0.7110843076245685 0.6498024691067386 0 +6053 0.7371157348474366 0.7663135256467741 0 +6054 0.7801437881467291 0.9646237917586475 0 +6055 0.2198562118521989 0.9646237917588385 0 +6056 0.8350560660841873 0.9929028832131668 0 +6057 0.1649439339150396 0.992902883213197 0 +6058 0.5325705541058079 0.6314683705676722 0 +6059 0.2489281413638863 0.588298348073478 0 +6060 0.9759874829314902 0.8332057209124479 0 +6061 0.02401251706857941 0.833205720912702 0 +6062 0.7533794835504859 0.9703323602215927 0 +6063 0.3811624496743616 0.9227509386027708 0 +6064 0.2466205164482812 0.9703323602217651 0 +6065 0.1660965874313645 0.1253958098709973 0 +6066 0.5329767779797843 0.5257507174322078 0 +6067 0.8181418837435779 0.6821369778577213 0 +6068 0.6339172958458963 0.7096120850238526 0 +6069 0.2386523498123639 0.6126439496252499 0 +6070 0.840678494114118 0.8929685771942868 0 +6071 0.1593215058851523 0.8929685771947551 0 +6072 0.6737543942714278 0.9765149554089092 0 +6073 0.249657797212896 0.7087321070379677 0 +6074 0.946626190904131 0.9684467626969058 0 +6075 0.05337380909562391 0.9684467626970573 0 +6076 0.94253088096721 0.8351085591460683 0 +6077 0.05746911903274707 0.8351085591464276 0 +6078 0.7827145036490796 0.7865319635749157 0 +6079 0.9924602202594454 0.9631633092707892 0 +6080 0.007539779740514728 0.9631633092707489 0 +6081 0.5334487583651037 0.08946206854258755 0 +6082 0.6894186379469862 0.6661151340012738 0 +6083 0.6916640188181041 0.8193493948944759 0 +6084 0.6245459463545125 0.7864345050577258 0 +6085 0.7117259308503492 0.9613067999310975 0 +6086 0.2882730949050722 0.9612972305285632 0 +6087 0.6265034274168045 0.9794256430266859 0 +6088 0.1415511435222283 0.1684734918578223 0 +6089 0.3936277129866246 0.138122239226607 0 +6090 0.3035191994010185 0.991871606663514 0 +6091 0.8951267611802318 0.9936037422066379 0 +6092 0.1048732388192967 0.9936037422066649 0 +6093 0.2301962283808523 0.5537109292981514 0 +6094 0.6849740809481368 0.53586973501941 0 +6095 0.648892635677049 0.5216421575519716 0 +6096 0.7982459475171733 0.982421099335826 0 +6097 0.2017540524818577 0.9824210993359128 0 +6098 0.85677934009576 0.9181769826165878 0 +6099 0.1432206599035732 0.9181769826169642 0 +6100 0.753242697183084 0.878520189722136 0 +6101 0.4010175221881389 0.3765066526817589 0 +6102 0.2467573028157132 0.878520189722755 0 +6103 0.4175406268011867 0.9006141271660033 0 +6104 0.9164715750631049 0.7270578899573277 0 +6105 0.4920721766717148 0.6485242613722678 0 +6106 0.9455180594229355 0.3258037804881802 0 +6107 0.5126553370038303 0.9786720747303744 0 +6108 0.7297657007974148 0.641328770445992 0 +6109 0.7415526976250986 0.8473062839734422 0 +6110 0.2177567596484214 0.6629438532471479 0 +6111 0.2584769137122045 0.8472588441562796 0 +6112 0.4762978965207471 0.7611412865492767 0 +6113 0.4145643715031359 0.7633444665688245 0 +6114 0.8035634424065891 0.9281301409476823 0 +6115 0.1964365575924535 0.9281301409480363 0 +6116 0.4511034978896756 0.7114009119380598 0 +6117 0.9305150286630632 0.6434613191208091 0 +6118 0.7050189967160302 0.8532423605433292 0 +6119 0.3116728686190677 0.7606063639647452 0 +6120 0.2006776740089859 0.6917315289554939 0 +6121 0.4123890621395721 0.9164689045175711 0 +6122 0.6198168709202319 0.6601627696951616 0 +6123 0.06415570238450652 0.6186080279189353 0 +6124 0.7129463435374412 0.9715947059360859 0 +6125 0.2865848597557287 0.9717007536138151 0 +6126 0.2808828539877822 0.4389979948397529 0 +6127 0.5842575165038532 0.8685640348407331 0 +6128 0.4109017492923664 0.9618436270439571 0 +6129 0.6284603497761718 0.9480426702145747 0 +6130 0.6837668185152687 0.5771982406426943 0 +6131 0.8983410681088493 0.8202898858520401 0 +6132 0.101658931891008 0.8202898858526577 0 +6133 0.8403845305876942 0.8468291073989506 0 +6134 0.1596154694115428 0.8468291073996581 0 +6135 0.3514247048817024 0.6878909075615158 0 +6136 0.8286146628532224 0.74775915386074 0 +6137 0.5994341047606676 0.590860380648361 0 +6138 0.0705224666787935 0.1452280442414606 0 +6139 0.8091049173971572 0.7275906187298408 0 +6140 0.866595397213899 0.02809463322952799 0 +6141 0.5768244695703487 0.9201061044522033 0 +6142 0.8058511142465226 0.6384957109955478 0 +6143 0.2203035730548622 0.6833076696259877 0 +6144 0.4017303348316094 0.7264986756852039 0 +6145 0.388543626409067 0.8639597222088391 0 +6146 0.5410634153904144 0.9618542500399609 0 +6147 0.3447734367147904 0.9927855543965766 0 +6148 0.8973279413537358 0.8851838040622987 0 +6149 0.4832911731607651 0.7483636029796277 0 +6150 0.102672058645772 0.8851838040627591 0 +6151 0.1186941066627285 0.7503979337760223 0 +6152 0.6668339351257925 0.8871463325229625 0 +6153 0.250783105567388 0.5283757217832104 0 +6154 0.4768660897437963 0.9925798044187932 0 +6155 0.6494064998388401 0.8271058589444203 0 +6156 0.960994001942449 0.9621286375560276 0 +6157 0.03900599805737477 0.9621286375562085 0 +6158 0.8141739908486749 0.5812807196745918 0 +6159 0.4312352223162026 0.6207422449152583 0 +6160 0.07794199600031501 0.2344169236235391 0 +6161 0.4393343537440644 0.9797101529591542 0 +6162 0.3610023733517941 0.8920735867844714 0 +6163 0.06037143606145581 0.5010963669953038 0 +6164 0.2230057880223868 0.7726222468193082 0 +6165 0.06030772680310362 0.3244185268954665 0 +6166 0.06867223439416163 0.03161467466601323 0 +6167 0.5804573581167721 0.06364063891340119 0 +6168 0.3687072339564204 0.7471388311721157 0 +6169 0.6356194069323952 0.8061039485041007 0 +6170 0.4654783357601118 0.9455406282670094 0 +6171 0.9406065369970951 0.2449785957933524 0 +6172 0.7898952600133466 0.8525044383882412 0 +6173 0.2101047399856279 0.8525044383889124 0 +6174 0.5864733001002883 0.9833668124289462 0 +6175 0.3135842909621652 0.3403868163461301 0 +6176 0.4182873415163392 0.841948998694046 0 +6177 0.03411098028126403 0.6570746517310893 0 +6178 0.9288435382823192 0.8514536013512092 0 +6179 0.07115646171729698 0.8514536013515622 0 +6180 0.7102336765742419 0.8314466501351953 0 +6181 0.5824653335684215 0.9612624131018678 0 +6182 0.7650377462243295 0.8516610900858951 0 +6183 0.2349622537745091 0.8516610900866263 0 +6184 0.6140421587884111 0.9826784543515501 0 +6185 0.1371908145675958 0.6762226361180055 0 +6186 0.4048942500074748 0.686199550265696 0 +6187 0.8827586560568216 0.8672545640812841 0 +6188 0.1172413439426994 0.8672545640819133 0 +6189 0.4711417240742283 0.8963930030879652 0 +6190 0.6179735446526763 0.75918061080497 0 +6191 0.7904246276360621 0.1536105133948216 0 +6192 0.2136538169728937 0.7890691292790731 0 +6193 0.4284033520069242 0.7646174755338483 0 +6194 0.8612500027132991 0.8723361007259691 0 +6195 0.1387499972860968 0.8723361007265521 0 +6196 0.2193379506288386 0.5819353645816845 0 +6197 0.510154167953475 0.7027885145667746 0 +6198 0.9127438611589369 0.6164702875500475 0 +6199 0.6615419037490012 0.937958579330215 0 +6200 0.2873463940740646 0.7003658115585099 0 +6201 0.276652285110633 0.1394132517902294 0 +6202 0.5248898817347779 0.2381602397455254 0 +6203 0.7833977322212805 0.9736893367887923 0 +6204 0.2166022677776676 0.9736893367889278 0 +6205 0.8925029586583025 0.6895223435118569 0 +6206 0.353148514485599 0.1158448076049724 0 +6207 0.6903873901595079 0.9826067107369563 0 +6208 0.772584119432536 0.518854370441254 0 +6209 0.372361291908708 0.9798035882369907 0 +6210 0.9639358125305347 0.8011595106851861 0 +6211 0.03606418746944241 0.8011595106856063 0 +6212 0.9455674505354765 0.1942127326192239 0 +6213 0.7501351871750819 0.2862743423399968 0 +6214 0.2561128860264494 0.7487474665077173 0 +6215 0.9247878377442644 0.690158511805293 0 +6216 0.1935417505113115 0.7265529918991327 0 +6217 0.7195608994038013 0.912002211031175 0 +6218 0.2804391005947867 0.9120022110316345 0 +6219 0.5150883822618911 0.3697176587867824 0 +6220 0.6530111018827388 0.9925578027322287 0 +6221 0.611074869940518 0.9569968201243511 0 +6222 0.9651137716792937 0.7034655130443146 0 +6223 0.5013997648243036 0.767295499961054 0 +6224 0.5890724269142634 0.7039487575651426 0 +6225 0.132984631344333 0.638673284822342 0 +6226 0.4989462369416074 0.9449186878146298 0 +6227 0.4439633625583302 0.5059686671553132 0 +6228 0.2877668380187623 0.1731033874096143 0 +6229 0.5925380191999835 0.6389352693642592 0 +6230 0.4141998460928692 0.7387380722134986 0 +6231 0.8513690227812767 0.7820224415172572 0 +6232 0.6196940721760775 0.6307119770762134 0 +6233 0.4059443053244709 0.7971312609922974 0 +6234 0.2211477273309704 0.5214504305776917 0 +6235 0.790152652518135 0.763581091160737 0 +6236 0.9338177270755383 0.8809566615987512 0 +6237 0.06618227292408516 0.8809566615991293 0 +6238 0.6162200905151866 0.8814836080990938 0 +6239 0.6283096271673346 0.9085269141005804 0 +6240 0.6861818099671169 0.8338372249743476 0 +6241 0.5496822402421278 0.4210968220732841 0 +6242 0.4914065432757073 0.2724313146183496 0 +6243 0.9507926569496075 0.8540305643656967 0 +6244 0.04920734305026959 0.8540305643661071 0 +6245 0.5450067547351533 0.9934788718087424 0 +6246 0.6493453155538043 0.2274561466850132 0 +6247 0.3338222159608659 0.7744620073899825 0 +6248 0.6017809594629139 0.4759979761751326 0 +6249 0.8229241770541235 0.9331615938610278 0 +6250 0.1770758229450199 0.9331615938613506 0 +6251 0.7352471528925193 0.9432091368779265 0 +6252 0.2647528471061498 0.9432091368782309 0 +6253 0.6391134620819892 0.5051616323908145 0 +6254 0.4701464457101454 0.5657372266963648 0 +6255 0.7707510139339434 0.9262197924418167 0 +6256 0.2292489860649021 0.9262197924421942 0 +6257 0.3694905876350827 0.6856977130404813 0 +6258 0.3877070865836759 0.7632041176218606 0 +6259 0.1431092135607851 0.4183640463878613 0 +6260 0.5897098733840711 0.9332758334904041 0 +6261 0.9450000572816862 0.4050163181612534 0 +6262 0.6718062687962219 0.9465372586709312 0 +6263 0.2309790047931109 0.7970896369490053 0 +6264 0.473434190590788 0.978672327047075 0 +6265 0.3501277467248544 0.8275495738347486 0 +6266 0.9770478315062525 0.2884451149200871 0 +6267 0.1904623192762926 0.2490975284805339 0 +6268 0.0294045377762178 0.02959725969311588 0 +6269 0.4048353357559047 0.9931587242713624 0 +6270 0.9511089777172913 0.5069785474203021 0 +6271 0.1951487035500393 0.1687957132889462 0 +6272 0.916675195983971 0.9239844127524361 0 +6273 0.08332480401567864 0.9239844127527572 0 +6274 0.3554818590671066 0.7682032499220097 0 +6275 0.843757664182059 0.1567130545575639 0 +6276 0.860216709706748 0.5866227325999558 0 +6277 0.4940831962869077 0.7890334258373437 0 +6278 0.03728115985546097 0.6991202158559817 0 +6279 0.3743896030675613 0.7874221625997162 0 +6280 0.3603907307941058 0.7199375999380527 0 +6281 0.4891450225028585 0.6192371926809567 0 +6282 0.5245157835587241 0.3961397773281161 0 +6283 0.4134687894635406 0.7862199523321439 0 +6284 0.4802963007022407 0.4499421398691045 0 +6285 0.2434802183704529 0.7267540359127134 0 +6286 0.6459677171914076 0.3153343008603139 0 +6287 0.1479250907470507 0.7834349824537639 0 +6288 0.7549588227885647 0.8979909589623255 0 +6289 0.245041177210246 0.8979909589628448 0 +6290 0.8312542429934946 0.9611099255543043 0 +6291 0.1687457570057134 0.9611099255545085 0 +6292 0.3684933305390807 0.9016874772868441 0 +6293 0.7849882550292935 0.6564397011738609 0 +6294 0.399255992864848 0.913475677939648 0 +6295 0.4272630560626632 0.7875653375651045 0 +6296 0.399995089341152 0.8861788903014705 0 +6297 0.4554863310926411 0.9575322777794214 0 +6298 0.8513155082875326 0.927153006926299 0 +6299 0.1486844917117745 0.9271530069266358 0 +6300 0.9493398126589279 0.8884160669685514 0 +6301 0.05066018734082217 0.888416066968975 0 +6302 0.5361132996394085 0.7651773613257943 0 +6303 0.914904433766243 0.9059749316350647 0 +6304 0.0850955662333738 0.9059749316354354 0 +6305 0.5916209083824751 0.7580399057028374 0 +6306 0.9768730715581154 0.8956511270731936 0 +6307 0.02312692844191717 0.8956511270736178 0 +6308 0.2414051099791601 0.683026036464064 0 +6309 0.4722743991700892 0.1822316602731825 0 +6310 0.9472292429192057 0.3614308976457151 0 +6311 0.5277041754965801 0.1841167166542531 0 +6312 0.4080251891830439 0.7513443218698448 0 +6313 0.4360954189601112 0.7535325453026841 0 +6314 0.7588147383528037 0.6821272221486563 0 +6315 0.1463427286226025 0.514265808137232 0 +6316 0.9561335114654507 0.8719750038657822 0 +6317 0.0438664885343836 0.8719750038663552 0 +6318 0.4168631266204208 0.883584590695379 0 +6319 0.100323303942943 0.7264809189898758 0 +6320 0.6239538578813865 0.8579621483159885 0 +6321 0.4076269718054026 0.7742263285210982 0 +6322 0.3049161806478616 0.7107490108649943 0 +6323 0.0722698064169819 0.5892726781384632 0 +6324 0.9857438036283286 0.6620061434680213 0 +6325 0.8731152849887825 0.9632706252182064 0 +6326 0.1268847150106414 0.9632706252183723 0 +6327 0.9928150186570481 0.9295536913487324 0 +6328 0.007184981342997674 0.9295536913485567 0 +6329 0.9169886432108587 0.3808259229389908 0 +6330 0.8649358735685633 0.3444947093407081 0 +6331 0.6563507518035588 0.968480477127994 0 +6332 0.3438470903451125 0.3352822169930034 0 +6333 0.7846591213531124 0.2109392890570578 0 +6334 0.4716644445157288 0.3739691298315787 0 +6335 0.4228418704013837 0.9332384780626863 0 +6336 0.1913493572774412 0.5408259296261344 0 +6337 0.567497376901861 0.8023005976760258 0 +6338 0.6803799500983272 0.9353434572378061 0 +6339 0.1037368249816808 0.6324260608175785 0 +6340 0.1716526032355223 0.03124332263960176 0 +6341 0.7511972241930672 0.947879337879003 0 +6342 0.439231919655537 0.9492351937372094 0 +6343 0.2488027758056975 0.9478793378792872 0 +6344 0.965504395590802 0.5904099382547773 0 +6345 0.967656143797107 0.9463513911221308 0 +6346 0.03234385620274456 0.9463513911223895 0 +6347 0.1756328411933805 0.7888298452515716 0 +6348 0.2673368496914528 0.02855629473711189 0 +6349 0.7551256621693062 0.4396925738925491 0 +6350 0.9896897475579267 0.7407944964099441 0 +6351 0.7267236158279676 0.1754203493847873 0 +6352 0.60499999999896 0.9938136098715409 0 +6353 0.9300753450844781 0.9618213126003649 0 +6354 0.06992465491520206 0.9618213126005473 0 +6355 0.4308538677866365 0.823036644090902 0 +6356 0.08629680137655263 0.7017798932678577 0 +6357 0.4811425021713306 0.6342452859358905 0 +6358 0.8191450947137391 0.9210143944226546 0 +6359 0.1808549052853985 0.9210143944230458 0 +6360 0.4358754931824698 0.8754198430916027 0 +6361 0.5182456290933604 0.1133798993822902 0 +6362 0.4825766282604916 0.838280330421889 0 +6363 0.8569381307064738 0.7073601113187453 0 +6364 0.5832877487235149 0.9079224501128582 0 +6365 0.752231861986284 0.8140591658968384 0 +6366 0.2483823238182461 0.8111444413816651 0 +6367 0.4748402020100503 0.73710331990127 0 +6368 0.9048094204626707 0.894825211517737 0 +6369 0.09519057953687157 0.8948252115181392 0 +6370 0.8255560879791803 0.8102017137198089 0 +6371 0.1743234606008982 0.810184696772691 0 +6372 0.8374873905116903 0.8737888158178195 0 +6373 0.1625126094875677 0.873788815818403 0 +6374 0.02219074874827395 0.3361360178525911 0 +6375 0.01097406181900513 0.7407167545006317 0 +6376 0.7516389930781849 0.590104263932285 0 +6377 0.2242967462670181 0.6452810889575507 0 +6378 0.4950459221766449 0.8392376099085417 0 +6379 0.3984085070442243 0.5281660354725078 0 +6380 0.01156730394974344 0.6860774803697711 0 +6381 0.986088175646557 0.7118783631533852 0 +6382 0.8657928523191034 0.6048829217868834 0 +6383 0.6439738897205766 0.9802117472394645 0 +6384 0.2193546507692148 0.7441433956056558 0 +6385 0.4230114121143904 0.7124918449873375 0 +6386 0.8826125813511808 0.9157254760989224 0 +6387 0.1173874186482778 0.915725476099269 0 +6388 0.991935032547563 0.8653412278269981 0 +6389 0.008064967452546848 0.8653412278266347 0 +6390 0.5610475018447693 0.2759214491862425 0 +6391 0.7326943079248691 0.9808386200190709 0 +6392 0.2673049891720315 0.9808369886967832 0 +6393 0.8803595284324484 0.803021122095158 0 +6394 0.1196267514121767 0.803166910150332 0 +6395 0.6597737841749968 0.3866181983904248 0 +6396 0.8917129256836749 0.7674543657317815 0 +6397 0.1096758534052287 0.7674153746936733 0 +6398 0.4839145513669044 0.8007984292649675 0 +6399 0.5064047794691722 0.6188830183316061 0 +6400 0.3774680246301512 0.8568493462621382 0 +6401 0.4233496355085098 0.9193483215721483 0 +6402 0.5419388840466115 0.6458534276784453 0 +6403 0.4734843705643608 0.9516200192284684 0 +6404 0.6796072993769848 0.7949580312441312 0 +6405 0.6630714201582779 0.4801672980704125 0 +6406 0.4269094953232503 0.9031369541496919 0 +6407 0.9743532421595236 0.05906473301752724 0 +6408 0.443653079336315 0.8197447468355771 0 +6409 0.4657093661322229 0.8224210496016053 0 +6410 0.02214804734856063 0.05756656695233538 0 +6411 0.04518436657069848 0.4448365800852037 0 +6412 0.4405349621675056 0.9212857727421284 0 +6413 0.5064911028343402 0.4269979208493212 0 +6414 0.5180792723670946 0.26657488697015 0 +6415 0.6592183879149851 0.8967528001138083 0 +6416 0.3213853280128152 0.7980164065876637 0 +6417 0.6602724446633699 0.5946903478502504 0 +6418 0.8831517133273188 0.7164062528314563 0 +6419 0.4477748381769112 0.3316018812847127 0 +6420 0.9813308827307092 0.4586420644641646 0 +6421 0.3428128593505421 0.6198811489552538 0 +6422 0.9549684104447458 0.829427452503545 0 +6423 0.0450315895552819 0.8294274525039227 0 +6424 0.7442921383815286 0.9605977477290166 0 +6425 0.255707861617196 0.9605977477292245 0 +6426 0.8169494782088523 0.9640225786602186 0 +6427 0.1830505217902751 0.9640225786604086 0 +6428 0.2135144022972898 0.4151861465824672 0 +6429 0.6163900519025433 0.8234128577684396 0 +6430 0.07528293265938624 0.06572426427804209 0 +6431 0.4974849890435264 0.884518857940666 0 +6432 0.1783195150987345 0.4209765738893247 0 +6433 0.4624523784436013 0.6040578060504072 0 +6434 0.01610502049553615 0.3834431176626261 0 +6435 0.9863854070588522 0.687837835665606 0 +6436 0.668060916338608 0.7085020647296366 0 +6437 0.7307401960308779 0.8711223654617439 0 +6438 0.2692598039678006 0.8711223654624148 0 +6439 0.5612018035338324 0.5496931231158786 0 +6440 0.2192137348029672 0.3129391967918615 0 +6441 0.1880783212429075 0.7530233173750209 0 +6442 0.6917762888318028 0.8004590473409308 0 +6443 0.8707784509831099 0.2927538840522453 0 +6444 0.9424639126140864 0.9374534562962801 0 +6445 0.0575360873856474 0.9374534562965848 0 +6446 0.3943730011985056 0.7751103522812213 0 +6447 0.382871226056025 0.5002088056001663 0 +6448 0.6091090444747299 0.5108287056275148 0 +6449 0.3100037925264222 0.8484021417646592 0 +6450 0.3252183999055006 0.9459716334558994 0 +6451 0.4925706348767705 0.6959461782716664 0 +6452 0.6671712609096726 0.9926857484668705 0 +6453 0.9526780493653846 0.9395857128929652 0 +6454 0.0473219506343954 0.9395857128932652 0 +6455 0.1132474556098102 0.4436983639391849 0 +6456 0.3222277501958591 0.9351453518882539 0 +6457 0.9390607936751252 0.7404641190859708 0 +6458 0.05997222805311914 0.7415336700381997 0 +6459 0.7272599168116305 0.9649780673374029 0 +6460 0.2727389256305353 0.9649753808344428 0 +6461 0.1999541558485375 0.4479518324789303 0 +6462 0.7373981159063427 0.698269809948557 0 +6463 0.4061037078376427 0.7126567952167566 0 +6464 0.2890064416359076 0.7633575515923605 0 +6465 0.3816596342374201 0.8830867314211348 0 +6466 0.3496229830130909 0.2237610303636746 0 +6467 0.6310029897735626 0.5807675913836314 0 +6468 0.8008631976994398 0.8718419059122373 0 +6469 0.199136802299661 0.8718419059127852 0 +6470 0.5538765120528422 0.7483458468966543 0 +6471 0.6511338722293347 0.9345809171900535 0 +6472 0.8915349426378543 0.0706291351205115 0 +6473 0.4031160674648214 0.8176972637217608 0 +6474 0.948616780129208 0.9215792751546641 0 +6475 0.05138321987055019 0.9215792751550497 0 +6476 0.9231448030892424 0.9550994489042466 0 +6477 0.07685519691040049 0.955099448904446 0 +6478 0.7429430633407066 0.9335076192808667 0 +6479 0.2570569366579983 0.9335076192812193 0 +6480 0.5537775005705127 0.8190302571040196 0 +6481 0.9047071391492656 0.9941035545695236 0 +6482 0.0952928608503061 0.9941035545695517 0 +6483 0.2543649893409036 0.2864806218974359 0 +6484 0.367503492728272 0.3839017933794195 0 +6485 0.937040248838351 0.5921509590686868 0 +6486 0.5166815006210972 0.6327889440440619 0 +6487 0.4822659178825715 0.947641572415893 0 +6488 0.8744284191183327 0.7288517164025466 0 +6489 0.3942556444174026 0.7504935588824091 0 +6490 0.1642397204950825 0.5933680337771168 0 +6491 0.44491571333083 0.3635647102158801 0 +6492 0.9058556520810827 0.2092979998065003 0 +6493 0.484271838214974 0.07669281189071092 0 +6494 0.3279361442400701 0.8692201788394408 0 +6495 0.6718077438556329 0.8691914479660977 0 +6496 0.6482565967760561 0.5757502165820171 0 +6497 0.6472522669911857 0.8794922195753708 0 +6498 0.9659003476169516 0.6718993186510462 0 +6499 0.904570788554885 0.4952619044713598 0 +6500 0.3543321397630168 0.9108800353864378 0 +6501 0.039635276363372 0.684027038989784 0 +6502 0.8495270593370046 0.7413451875113606 0 +6503 0.818780366756519 0.8501155041228401 0 +6504 0.181219633242622 0.8501155041235309 0 +6505 0.6125971012221488 0.3441031712309218 0 +6506 0.9166297775781016 0.8812386364656923 0 +6507 0.08337022242144665 0.881238636466144 0 +6508 0.5419545231780555 0.85948349595415 0 +6509 0.820178827954873 0.7726628995074729 0 +6510 0.5169352583644371 0.8853409982614923 0 +6511 0.7669456764703165 0.6317370653967171 0 +6512 0.3315645700482455 0.755441494095845 0 +6513 0.03691785022490375 0.6293907656708468 0 +6514 0.7768025517928405 0.2961074023118325 0 +6515 0.6361913366756571 0.2075699752013102 0 +6516 0.4255237898544705 0.8090895621572111 0 +6517 0.6624998589034812 0.4121134157190283 0 +6518 0.8012649015824076 0.957062614735515 0 +6519 0.1987350984166322 0.95706261473573 0 +6520 0.7719111229426365 0.9154111479306939 0 +6521 0.2280888770562273 0.9154111479311084 0 +6522 0.5945260725293604 0.6752441360005569 0 +6523 0.932079523506292 0.4459023691673281 0 +6524 0.9924645800713839 0.981952621283539 0 +6525 0.007535419928645174 0.9819526212835147 0 +6526 0.6326180622816568 0.6017339432895102 0 +6527 0.2181423126502171 0.06343693784746979 0 +6528 0.447105635968423 0.07089019923720694 0 +6529 0.4836027436856314 0.9373589646968054 0 +6530 0.6056472908183124 0.1193490380907222 0 +6531 0.5984046921388022 0.7440874874441638 0 +6532 0.8626451709730444 0.9927341814238891 0 +6533 0.1373548290263262 0.9927341814239249 0 +6534 0.9088397602258639 0.8025976775316572 0 +6535 0.09116023977425322 0.8025976775321431 0 +6536 0.1191262973600911 0.3209347914226852 0 +6537 0.4349999999988727 0.9941552206075657 0 +6538 0.01815489018788463 0.4298253096181582 0 +6539 0.3547298101904591 0.4872664057324401 0 +6540 0.7890157905340676 0.8715670325846575 0 +6541 0.2109842094649293 0.8715670325852649 0 +6542 0.3515876867366073 0.02839413361440976 0 +6543 0.7552080929691375 0.07391177022056089 0 +6544 0.5493353262272169 0.9068176387517832 0 +6545 0.3899595357852842 0.3180966474541168 0 +6546 0.7485610269854814 0.9850747777061489 0 +6547 0.2514389730132615 0.9850747777062335 0 +6548 0.8998836805192718 0.7210824593254657 0 +6549 0.9822707723809743 0.9926745955747883 0 +6550 0.01772922761894392 0.992674595574826 0 +6551 0.4771271945320248 0.509746063399322 0 +6552 0.03683793810592608 0.7408423412466355 0 +6553 0.7115193719627968 0.6834060849261692 0 +6554 0.8914440351618993 0.2366912191799572 0 +6555 0.08895432328866296 0.6043363887531636 0 +6556 0.1390011292999405 0.6055081360847195 0 +6557 0.318309354538049 0.9211087202726524 0 +6558 0.6057757520484961 0.8996631190274398 0 +6559 0.4909907908416776 0.9521901396904053 0 +6560 0.1327249167498417 0.2626263940550653 0 +6561 0.6252437054897088 0.474851759502124 0 +6562 0.4199185502209736 0.179009772817637 0 +6563 0.4878080579447625 0.5582766580784662 0 +6564 0.4949999999987035 0.9942153735171784 0 +6565 0.5314341593483533 0.7768441353297862 0 +6566 0.696475373578205 0.9281522822630039 0 +6567 0.3032441884255999 0.9287111735585016 0 +6568 0.5917679069639291 0.9247026376745592 0 +6569 0.9731101350107194 0.02619688720905929 0 +6570 0.3148827956826251 0.835308664927797 0 +6571 0.3157021579034817 0.9701536603195067 0 +6572 0.6088342022035876 0.4225233373108579 0 +6573 0.5627735131002845 0.6014679801226143 0 +6574 0.4884489972850536 0.592209890261098 0 +6575 0.3355135004633637 0.9080559978255061 0 +6576 0.2634190611023387 0.2112741555344346 0 +6577 0.2735449057935789 0.7939689908622549 0 +6578 0.6495554292062764 0.1373361397480107 0 +6579 0.6823718133647538 0.9212488184770301 0 +6580 0.09795769595890089 0.1893278789693392 0 +6581 0.463258060134103 0.0240661897796562 0 +6582 0.7181609636110693 0.3656536896347532 0 +6583 0.8006636332358388 0.9109564413999995 0 +6584 0.1993363667631913 0.9109564414004461 0 +6585 0.9178359124061537 0.4565521228870605 0 +6586 0.5123806667437912 0.6060145817196241 0 +6587 0.6978745888510598 0.4083350043559402 0 +6588 0.5667851584924556 0.8846193151840043 0 +6589 0.1988383168153688 0.7721356394067485 0 +6590 0.9484982635110809 0.6342481279118024 0 +6591 0.9450346727780163 0.9122098241854697 0 +6592 0.05496532722173066 0.9122098241858743 0 +6593 0.1953318765616371 0.6018412952763572 0 +6594 0.307937130920569 0.981509796236226 0 +6595 0.6283484546060126 0.8679910501272823 0 +6596 0.5563746354730387 0.6910671891851237 0 +6597 0.8432750014771186 0.6968732780804576 0 +6598 0.788038790953478 0.9211370802108884 0 +6599 0.2119612090454656 0.9211370802112625 0 +6600 0.5106167362319163 0.902856265668272 0 +6601 0.4712516001327157 0.7988663592987729 0 +6602 0.8046065040368635 0.1994148570440221 0 +6603 0.6670713869650707 0.9300345138306279 0 +6604 0.810969463931562 0.791209328262486 0 +6605 0.01367671649217349 0.5823626761259285 0 +6606 0.1888954306755098 0.79089046426461 0 +6607 0.7047379982519035 0.262049394844344 0 +6608 0.9330003063243931 0.0260490426663518 0 +6609 0.4490464874401406 0.9365766670555711 0 +6610 0.300387977216402 0.4077866922967438 0 +6611 0.7289102524111556 0.787423934882345 0 +6612 0.6594965402763332 0.6541304798492144 0 +6613 0.8891969970408153 0.5480116642992943 0 +6614 0.7093489087864021 0.8913621866329743 0 +6615 0.2906525739269096 0.8913680266175124 0 +6616 0.5224110482582377 0.9363101409879142 0 +6617 0.7989876924226123 0.8525122338238309 0 +6618 0.2010123075764199 0.8525122338245069 0 +6619 0.3504096282457654 0.9528293085959256 0 +6620 0.1733116636687725 0.07111518205423216 0 +6621 0.02043262147040368 0.129909699018045 0 +6622 0.2094526333527911 0.7277901300230397 0 +6623 0.4816432939004696 0.9664404227849315 0 +6624 0.7642306773248015 0.7551235557306384 0 +6625 0.7388548458075705 0.974903606364071 0 +6626 0.2611450944205587 0.9749034676463211 0 +6627 0.8401967566595296 0.9843584059743631 0 +6628 0.1598032433397239 0.9843584059744401 0 +6629 0.5391350882055082 0.893797280458878 0 +6630 0.1871761685091415 0.7666657530853439 0 +6631 0.9308170747407088 0.9751695119674313 0 +6632 0.06918292525897424 0.9751695119675508 0 +6633 0.5108094809672132 0.4989107242431162 0 +6634 0.7911076211501007 0.8905986826707868 0 +6635 0.2088923788488809 0.8905986826713153 0 +6636 0.5523092642064863 0.7633436783467096 0 +6637 0.7615659544950641 0.9843548155259948 0 +6638 0.2384340455037515 0.9843548155260819 0 +6639 0.8282970005507495 0.2369136654426892 0 +6640 0.9012190621443177 0.3281880357583806 0 +6641 0.9414747293286048 0.1061696936223508 0 +6642 0.7845666321789095 0.8813277004443212 0 +6643 0.2154333678200397 0.8813277004449072 0 +6644 0.2173831622482459 0.4366115635205965 0 +6645 0.7600851205097953 0.860150134446251 0 +6646 0.2399148794890137 0.8601501344469591 0 +6647 0.6802612745048597 0.9844225298744657 0 +6648 0.9770901146980364 0.8722321723074611 0 +6649 0.02290988530195938 0.8722321723077556 0 +6650 0.08551151665569097 0.4193697036825962 0 +6651 0.2417528459155418 0.1068198362699198 0 +6652 0.6041023465046114 0.6638889421181564 0 +6653 0.749570978978953 0.8031407904539349 0 +6654 0.4027718716169566 0.6061843258053174 0 +6655 0.6756027457940095 0.901624132900392 0 +6656 0.5635115441612308 0.8238289605599803 0 +6657 0.5514100332309702 0.7070054150113123 0 +6658 0.5032689494629519 0.8084064366397579 0 +6659 0.3230213936014273 0.3974974362755433 0 +6660 0.9840990794299644 0.4108999738560447 0 +6661 0.3336369372013982 0.5911065861016576 0 +6662 0.5534215020630087 0.8419582270587656 0 +6663 0.4632283530058339 0.993128708047006 0 +6664 0.9890369491462321 0.795021106111624 0 +6665 0.01096673043453134 0.7950169939024253 0 +6666 0.7818039726819528 0.9128323330718211 0 +6667 0.2181960273169647 0.9128323330722391 0 +6668 0.6180960775241193 0.3211410643028442 0 +6669 0.5759029633252564 0.7848061163192063 0 +6670 0.5767710866569102 0.9329572356351843 0 +6671 0.6447927259300555 0.7705956701481573 0 +6672 0.4920707506303865 0.8931632314955096 0 +6673 0.4535657012785081 0.9923629698145433 0 +6674 0.1035738905163261 0.7419033417138603 0 +6675 0.7589331041921556 0.6448811075543798 0 +6676 0.2589926166868647 0.4827892951420782 0 +6677 0.5233618025110964 0.8559212489707267 0 +6678 0.8984357146933586 0.9227849132304884 0 +6679 0.1015642853061893 0.922784913230797 0 +6680 0.1257692483172366 0.5643369170351394 0 +6681 0.7819950081319638 0.7720081901171176 0 +6682 0.6545172036265318 0.978749538450675 0 +6683 0.6594427486070474 0.6264198144126385 0 +6684 0.05026697552918476 0.3725688700601562 0 +6685 0.8895665698007109 0.9610003689350206 0 +6686 0.110433430198788 0.9610003689351907 0 +6687 0.46287458511524 0.8094021376383657 0 +6688 0.52623086104219 0.891101987263157 0 +6689 0.1325395762173428 0.5927349741393546 0 +6690 0.0666023973662442 0.7176994533555564 0 +6691 0.336499730557603 0.7119119586440044 0 +6692 0.6301044124957059 0.2483494304044573 0 +6693 0.7521529323398101 0.7333988599868804 0 +6694 0.7114534060577399 0.9414667617735508 0 +6695 0.2885480795022679 0.9414645857235606 0 +6696 0.3591118478107062 0.5748983808146626 0 +6697 0.3794581542969546 0.215337261244833 0 +6698 0.04020686349237851 0.5950048183471306 0 +6699 0.6520862684904453 0.9512587514792796 0 +6700 0.3718978540230424 0.8224739067924446 0 +6701 0.4912237162632543 0.5203501846261633 0 +6702 0.3869477057984436 0.8067183202712913 0 +6703 0.4105057549863959 0.2827865743266195 0 +6704 0.7188992548130976 0.6713121261323364 0 +6705 0.9518029917683537 0.4723611151007208 0 +6706 0.6958080085884265 0.682139829225727 0 +6707 0.3174699357598571 0.9933846345230167 0 +6708 0.532929919802712 0.8492498010239146 0 +6709 0.3409378191974214 0.5633015709998594 0 +6710 0.5952173169110354 0.4572378164393982 0 +6711 0.4188248705478702 0.4219964170354077 0 +6712 0.7423863205436088 0.5045202626503871 0 +6713 0.3737432113843632 0.9450101173682854 0 +6714 0.6738160504315371 0.852892507097576 0 +6715 0.7623595904511784 0.256513771540922 0 +6716 0.6855250954916079 0.853013639357209 0 +6717 0.3278765277805963 0.851813599845383 0 +6718 0.2887627417805465 0.5384835137986849 0 +6719 0.445250489921874 0.2597719908003852 0 +6720 0.2985745350355736 0.7570652841767203 0 +6721 0.3965918714231317 0.6745138283471713 0 +6722 0.9825331779320585 0.9408466714078552 0 +6723 0.01746682206786064 0.9408466714080721 0 +6724 0.8998377965604341 0.3618542925084314 0 +6725 0.4065604282643566 0.4657040561570563 0 +6726 0.6485803848497385 0.9642123191632734 0 +6727 0.6646631116615228 0.9829072291997077 0 +6728 0.2441931771914914 0.759161220988726 0 +6729 0.6237820842813855 0.99363360273653 0 +6730 0.901859873228126 0.6455352018923922 0 +6731 0.8833265805442831 0.1265927288464145 0 +6732 0.7224777983477447 0.3222497569524588 0 +6733 0.5618969147919434 0.9313568900528848 0 +6734 0.7307582257381997 0.8151998574431921 0 +6735 0.06112130690077722 0.5336376188265215 0 +6736 0.671083979239405 0.5195597660151929 0 +6737 0.3213283729808458 0.2695602393956572 0 +6738 0.6570079905113704 0.8513465529153551 0 +6739 0.7011419891802748 0.06338544996809298 0 +6740 0.4280024374052326 0.540087924558 0 +6741 0.5948134582854714 0.8709183122508209 0 +6742 0.6199827086546055 0.5607026883303017 0 +6743 0.4098344983046094 0.3575515305845621 0 +6744 0.4581440599172949 0.9092610320808461 0 +6745 0.2097794009036742 0.2923538163955446 0 +6746 0.7772450721031398 0.5797883493216154 0 +6747 0.5152095980918072 0.7762441364787964 0 +6748 0.2261519406534068 0.707711738676303 0 +6749 0.7071637205907428 0.9301394357732056 0 +6750 0.2929104965171199 0.9301982692601207 0 +6751 0.6083099832819225 0.9290498007356207 0 +6752 0.9625053588938423 0.9317683408803619 0 +6753 0.03749464110598044 0.9317683408806964 0 +6754 0.2519706746465499 0.6213447915594859 0 +6755 0.5803896600689098 0.449106706775037 0 +6756 0.3463972086376353 0.8044853223463491 0 +6757 0.352663800758624 0.5910305477234539 0 +6758 0.6428795980413851 0.4228012905138283 0 +6759 0.8155135703622042 0.9093101575987248 0 +6760 0.1844864296369316 0.909310157599179 0 +6761 0.1678328485177288 0.7094559114035998 0 +6762 0.2136605026644176 0.2508995892772614 0 +6763 0.342822623894377 0.8512571567537235 0 +6764 0.3319599848745503 0.4309272411997039 0 +6765 0.9048422835836263 0.7488320786978414 0 +6766 0.916933162180348 0.7680292901322764 0 +6767 0.08255757053370799 0.7680882334054386 0 +6768 0.3026010153428899 0.2296963999450379 0 +6769 0.1018943207013485 0.021930455996072 0 +6770 0.9803649682392158 0.9547032653283458 0 +6771 0.01963503176067325 0.9547032653284789 0 +6772 0.4173579675547279 0.8735478603315705 0 +6773 0.1538764942748083 0.1002582655892602 0 +6774 0.4124349766942169 0.6577215443962121 0 +6775 0.8277571756969513 0.706115307637001 0 +6776 0.8598985650529303 0.1989053392290047 0 +6777 0.6850151382346902 0.1915776231253989 0 +6778 0.7290345090116577 0.3973863850750134 0 +6779 0.4586735315647807 0.949545108478282 0 +6780 0.349800339583509 0.7525838919642293 0 +6781 0.5410296781911862 0.8383132905313038 0 +6782 0.1156201233532829 0.3934436309027852 0 +6783 0.07934808366443438 0.3061393845230359 0 +6784 0.4046361612299036 0.97776788716368 0 +6785 0.8604485016841972 0.1099232119932427 0 +6786 0.8992351932434026 0.9127883229711975 0 +6787 0.100764806756148 0.9127883229715283 0 +6788 0.4233463628764834 0.4572124065595486 0 +6789 0.05740976093161634 0.2091861795772333 0 +6790 0.5155876580543718 0.7450259992394939 0 +6791 0.3252089519402985 0.9024068172035483 0 +6792 0.9199602664800051 0.8496780391850802 0 +6793 0.08003973351974161 0.8496780391854616 0 +6794 0.5622274229764801 0.9926837374498252 0 +6795 0.8897550831846748 0.9685496978647115 0 +6796 0.1102449168148263 0.9685496978648502 0 +6797 0.3017745862541619 0.9635311791214831 0 +6798 0.09502109108185126 0.1064423975467702 0 +6799 0.01622069216939914 0.4665540483538027 0 +6800 0.6588643572833839 0.7540580731813238 0 +6801 0.5619516540036378 0.8613614469056544 0 +6802 0.5706159749036831 0.8416214782444965 0 +6803 0.7904892999037734 0.7989565378477912 0 +6804 0.2080490447587144 0.7987590843925634 0 +6805 0.3647971374189607 0.6591589321628462 0 +6806 0.7853335658370393 0.07344613572966954 0 +6807 0.7930739229299689 0.5704025813694049 0 +6808 0.2388404337277757 0.7834971020069456 0 +6809 0.5223465334403157 0.7976109193073198 0 +6810 0.5049206049707629 0.8498228797023026 0 +6811 0.7097179827047446 0.877270579606622 0 +6812 0.2914959012247091 0.8781723971882532 0 +6813 0.6469128432066 0.9116822366817108 0 +6814 0.6650798110113629 0.9686876561214044 0 +6815 0.2085197514699737 0.764703348885112 0 +6816 0.6831089643982893 0.9697452431576961 0 +6817 0.3558417595316684 0.4354162256956124 0 +6818 0.1668726529308726 0.1521091256173084 0 +6819 0.4807050737686537 0.9755477481927397 0 +6820 0.6004809541322915 0.9588794822916107 0 +6821 0.9652659119419035 0.8375115346728885 0 +6822 0.03473408805813526 0.8375115346732529 0 +6823 0.7246821858193367 0.3006995368549166 0 +6824 0.2003294848873986 0.5783731580813557 0 +6825 0.6051416682464565 0.1671019932227034 0 +6826 0.5948100679461268 0.7949769616858279 0 +6827 0.8269710067689453 0.9443530929925135 0 +6828 0.1730289932302107 0.9443530929927816 0 +6829 0.5832613032204457 0.8576161856133688 0 +6830 0.7465664858146459 0.7884652409489441 0 +6831 0.7107318966585251 0.7269509291223657 0 +6832 0.3449100714118967 0.8777188562822584 0 +6833 0.423727675336217 0.9732642585492053 0 +6834 0.3538583949258162 0.0579128551780216 0 +6835 0.3402079553212328 0.9859243904577776 0 +6836 0.6588846266855704 0.8658122097075471 0 +6837 0.1188406485604429 0.6795013485358388 0 +6838 0.4436694132091898 0.8941034159572521 0 +6839 0.8372420105784895 0.9565895184844666 0 +6840 0.1627579894207511 0.9565895184846849 0 +6841 0.6703482771090359 0.7340026467072673 0 +6842 0.7622107525866266 0.5576160784273916 0 +6843 0.6115141005787006 0.7829170068460762 0 +6844 0.4004278830130605 0.8672879591025466 0 +6845 0.1859666182025478 0.66600658518501 0 +6846 0.8937582586603162 0.6188822512461543 0 +6847 0.7941484383949626 0.9591484231839131 0 +6848 0.2058515616040369 0.9591484231841161 0 +6849 0.3425890733058139 0.9494190361620773 0 +6850 0.341010704633642 0.8668499970500529 0 +6851 0.7184295608991159 0.5552759826384506 0 +6852 0.2682028032893441 0.8161732496084024 0 +6853 0.02231716424032599 0.2090477551965585 0 +6854 0.6353942501579778 0.9402496613779421 0 +6855 0.8859093443673145 0.8907638803217609 0 +6856 0.1140906556321759 0.8907638803222396 0 +6857 0.9840619579436671 0.4830777426841575 0 +6858 0.6457459206867735 0.9421596529098932 0 +6859 0.7145121736354604 0.7704389390371577 0 +6860 0.3717370633605831 0.6206036885405819 0 +6861 0.09097106369837873 0.7490132434965469 0 +6862 0.8258916957984384 0.9813953935612247 0 +6863 0.1741083042007426 0.98139539356132 0 +6864 0.9662919546109843 0.9760462582032425 0 +6865 0.03370804538887689 0.9760462582033287 0 +6866 0.3163927192646488 0.4910890885180618 0 +6867 0.7182110282624843 0.8700570185138722 0 +6868 0.4422994197913842 0.9094916100692993 0 +6869 0.282341095223438 0.8693478919265135 0 +6870 0.9444131310194506 0.07164717445536233 0 +6871 0.9587310866551868 0.9819026016004961 0 +6872 0.04126891334463132 0.981902601600569 0 +6873 0.324999999999193 0.9947434832496781 0 +6874 0.9029938010410632 0.8761649606763136 0 +6875 0.09700619895847593 0.876164960676818 0 +6876 0.4587445203388341 0.5169717784668301 0 +6877 0.9302216385609372 0.2155059067264443 0 +6878 0.7517260191199886 0.9389470498072769 0 +6879 0.2482739808787671 0.9389470498076 0 +6880 0.698352917761956 0.9635062058342826 0 +6881 0.5632955086964034 0.9725215938025416 0 +6882 0.757224642862057 0.6161679417604867 0 +6883 0.5302045553881035 0.8158399711420513 0 +6884 0.5814495057280464 0.2792721153958804 0 +6885 0.6232925723728394 0.7029143649470239 0 +6886 0.4476954214836478 0.6714163966906638 0 +6887 0.2909771854514417 0.3730759818895937 0 +6888 0.2071896777457166 0.7527878251878825 0 +6889 0.8798649044958593 0.5301340888974828 0 +6890 0.5259070022463388 0.7554785619125164 0 +6891 0.3693522621584778 0.35039984772135 0 +6892 0.4931536427206055 0.7233487344005428 0 +6893 0.6278501831965418 0.9622442200706115 0 +6894 0.4997962661269922 0.9264832997263849 0 +6895 0.598933072295362 0.9833281956740179 0 +6896 0.4721360591828087 0.8766964959106855 0 +6897 0.9940766167724617 0.9940854541448928 0 +6898 0.005923383227486876 0.9940854541449153 0 +6899 0.8761374176936352 0.1544572163509063 0 +6900 0.908772960886491 0.5474977125077283 0 +6901 0.3860531776682846 0.3868763090548055 0 +6902 0.588930707954072 0.9683619005881137 0 +6903 0.8669417921196676 0.9024465215931896 0 +6904 0.1330582078797185 0.9024465215936135 0 +6905 0.957505794180068 0.4284731129848685 0 +6906 0.0165758373571964 0.2640252395595565 0 +6907 0.7249307119908435 0.4926279194479312 0 +6908 0.9479228485807385 0.9933361663619699 0 +6909 0.05207715141902278 0.9933361663620051 0 +6910 0.839602156838228 0.6409409638797224 0 +6911 0.2018467404899029 0.706610279448832 0 +6912 0.7258034849925826 0.9939304226439105 0 +6913 0.2741959262936019 0.9939308064896882 0 +6914 0.8455833518701452 0.9692127015021581 0 +6915 0.1544166481291392 0.969212701502308 0 +6916 0.9549999999998791 0.9948182723071408 0 +6917 0.04499999999991076 0.9948182723071696 0 +6918 0.7447387860532401 0.3334441950757261 0 +6919 0.06793672689257146 0.1172413896250261 0 +6920 0.1785834430330775 0.6370276931458337 0 +6921 0.1901854048629482 0.7136846765650714 0 +6922 0.8810325354342584 0.7553888159567144 0 +6923 0.1999002653539884 0.08200463575744571 0 +6924 0.9778318076196332 0.9256486021750443 0 +6925 0.022168192380318 0.9256486021753272 0 +6926 0.9394234736923056 0.9286893899773139 0 +6927 0.06057652630741465 0.9286893899776602 0 +6928 0.885826109873656 0.9940698237866175 0 +6929 0.1141738901258306 0.9940698237866371 0 +6930 0.4201834143411851 0.8624802984511563 0 +6931 0.9831249004438398 0.1656047159753248 0 +6932 0.1013461851060371 0.5438455013019815 0 +6933 0.5678589423476813 0.9035408438357887 0 +6934 0.633799012783411 0.3576860418045682 0 +6935 0.515968038399224 0.07017383514301968 0 +6936 0.580155979149661 0.6731467271356988 0 +6937 0.5365653585170682 0.6177835000554653 0 +6938 0.711666410482567 0.61904464466156 0 +6939 0.9260915493752686 0.7179179520745446 0 +6940 0.9386542266650957 0.3429755060131074 0 +6941 0.5361446430829958 0.3575027815654246 0 +6942 0.9268127292239782 0.9935376419023252 0 +6943 0.07318727077568925 0.9935376419023575 0 +6944 0.8605363563392761 0.8334774991313469 0 +6945 0.139463643660086 0.8334774991321354 0 +6946 0.08818875022026124 0.6608347122434403 0 +6947 0.6909819564264047 0.5960408268170451 0 +6948 0.9093527511140528 0.8213763201355837 0 +6949 0.09064724888587261 0.821376320136006 0 +6950 0.67919961801942 0.7824700785904976 0 +6951 0.4654583305452509 0.9372386365793303 0 +6952 0.3071254396940266 0.4582742234811892 0 +6953 0.2184616781543798 0.2091488480151026 0 +$EndNodes +$Elements +13766 +1 1 2 14 7 4 239 +2 1 2 14 7 239 240 +3 1 2 14 7 240 241 +4 1 2 14 7 241 242 +5 1 2 14 7 242 243 +6 1 2 14 7 243 244 +7 1 2 14 7 244 245 +8 1 2 14 7 245 246 +9 1 2 14 7 246 247 +10 1 2 14 7 247 248 +11 1 2 14 7 248 249 +12 1 2 14 7 249 250 +13 1 2 14 7 250 251 +14 1 2 14 7 251 252 +15 1 2 14 7 252 253 +16 1 2 14 7 253 254 +17 1 2 14 7 254 255 +18 1 2 14 7 255 256 +19 1 2 14 7 256 257 +20 1 2 14 7 257 258 +21 1 2 14 7 258 259 +22 1 2 14 7 259 260 +23 1 2 14 7 260 261 +24 1 2 14 7 261 262 +25 1 2 14 7 262 263 +26 1 2 14 7 263 264 +27 1 2 14 7 264 265 +28 1 2 14 7 265 266 +29 1 2 14 7 266 267 +30 1 2 14 7 267 268 +31 1 2 14 7 268 269 +32 1 2 14 7 269 270 +33 1 2 14 7 270 271 +34 1 2 14 7 271 272 +35 1 2 14 7 272 273 +36 1 2 14 7 273 274 +37 1 2 14 7 274 275 +38 1 2 14 7 275 276 +39 1 2 14 7 276 277 +40 1 2 14 7 277 278 +41 1 2 14 7 278 279 +42 1 2 14 7 279 280 +43 1 2 14 7 280 281 +44 1 2 14 7 281 282 +45 1 2 14 7 282 283 +46 1 2 14 7 283 284 +47 1 2 14 7 284 285 +48 1 2 14 7 285 286 +49 1 2 14 7 286 287 +50 1 2 14 7 287 288 +51 1 2 14 7 288 289 +52 1 2 14 7 289 290 +53 1 2 14 7 290 291 +54 1 2 14 7 291 292 +55 1 2 14 7 292 293 +56 1 2 14 7 293 294 +57 1 2 14 7 294 295 +58 1 2 14 7 295 296 +59 1 2 14 7 296 297 +60 1 2 14 7 297 298 +61 1 2 14 7 298 299 +62 1 2 14 7 299 300 +63 1 2 14 7 300 301 +64 1 2 14 7 301 302 +65 1 2 14 7 302 303 +66 1 2 14 7 303 304 +67 1 2 14 7 304 305 +68 1 2 14 7 305 306 +69 1 2 14 7 306 307 +70 1 2 14 7 307 308 +71 1 2 14 7 308 309 +72 1 2 14 7 309 310 +73 1 2 14 7 310 311 +74 1 2 14 7 311 312 +75 1 2 14 7 312 313 +76 1 2 14 7 313 314 +77 1 2 14 7 314 315 +78 1 2 14 7 315 316 +79 1 2 14 7 316 317 +80 1 2 14 7 317 318 +81 1 2 14 7 318 319 +82 1 2 14 7 319 320 +83 1 2 14 7 320 321 +84 1 2 14 7 321 322 +85 1 2 14 7 322 323 +86 1 2 14 7 323 324 +87 1 2 14 7 324 325 +88 1 2 14 7 325 326 +89 1 2 14 7 326 327 +90 1 2 14 7 327 328 +91 1 2 14 7 328 329 +92 1 2 14 7 329 330 +93 1 2 14 7 330 331 +94 1 2 14 7 331 332 +95 1 2 14 7 332 333 +96 1 2 14 7 333 334 +97 1 2 14 7 334 335 +98 1 2 14 7 335 336 +99 1 2 14 7 336 337 +100 1 2 14 7 337 3 +101 2 2 12 9 3448 589 1338 +102 2 2 12 9 3016 478 1519 +103 2 2 12 9 3017 1520 479 +104 2 2 12 9 1457 589 3448 +105 2 2 12 9 1427 3016 1519 +106 2 2 12 9 1428 1520 3017 +107 2 2 12 9 1161 1683 2226 +108 2 2 12 9 2226 1683 537 +109 2 2 12 9 2900 1547 1716 +110 2 2 12 9 2901 1717 1548 +111 2 2 12 9 1757 2521 463 +112 2 2 12 9 2707 1691 339 +113 2 2 12 9 1469 1792 3397 +114 2 2 12 9 689 1547 2900 +115 2 2 12 9 690 2901 1548 +116 2 2 12 9 1289 3195 1989 +117 2 2 12 9 1235 1691 2707 +118 2 2 12 9 2521 1564 463 +119 2 2 12 9 3384 833 1522 +120 2 2 12 9 815 1459 3596 +121 2 2 12 9 816 3597 1460 +122 2 2 12 9 1497 3384 1522 +123 2 2 12 9 3642 1449 390 +124 2 2 12 9 3072 388 2197 +125 2 2 12 9 2150 758 3553 +126 2 2 12 9 3596 1459 1560 +127 2 2 12 9 3597 1561 1460 +128 2 2 12 9 3500 1579 1378 +129 2 2 12 9 302 303 1963 +130 2 2 12 9 1537 3642 390 +131 2 2 12 9 1479 1544 3520 +132 2 2 12 9 1507 383 3600 +133 2 2 12 9 613 3500 1378 +134 2 2 12 9 1792 599 3397 +135 2 2 12 9 1806 3180 1327 +136 2 2 12 9 1238 2714 1612 +137 2 2 12 9 303 2976 1963 +138 2 2 12 9 2685 798 1114 +139 2 2 12 9 2714 358 1612 +140 2 2 12 9 3488 1789 1506 +141 2 2 12 9 1949 685 2543 +142 2 2 12 9 3643 1405 679 +143 2 2 12 9 1684 428 2926 +144 2 2 12 9 2838 1629 843 +145 2 2 12 9 1418 3643 679 +146 2 2 12 9 798 1950 1114 +147 2 2 12 9 2639 723 1560 +148 2 2 12 9 2640 1561 724 +149 2 2 12 9 3520 1544 699 +150 2 2 12 9 3600 383 1317 +151 2 2 12 9 1989 3195 627 +152 2 2 12 9 1220 1886 2922 +153 2 2 12 9 1327 3180 612 +154 2 2 12 9 2543 685 1631 +155 2 2 12 9 1851 2860 929 +156 2 2 12 9 1059 3488 1506 +157 2 2 12 9 1310 3130 1556 +158 2 2 12 9 3382 709 1162 +159 2 2 12 9 261 2731 1843 +160 2 2 12 9 315 1844 2732 +161 2 2 12 9 3163 454 1888 +162 2 2 12 9 3164 1889 455 +163 2 2 12 9 760 2195 1133 +164 2 2 12 9 761 1134 2196 +165 2 2 12 9 576 2045 1512 +166 2 2 12 9 1773 1944 2999 +167 2 2 12 9 1033 2720 1997 +168 2 2 12 9 1034 2000 2721 +169 2 2 12 9 672 1617 1202 +170 2 2 12 9 345 1444 2323 +171 2 2 12 9 3116 1585 614 +172 2 2 12 9 3117 615 1586 +173 2 2 12 9 529 1191 1778 +174 2 2 12 9 638 1353 1564 +175 2 2 12 9 450 1619 1222 +176 2 2 12 9 649 1996 1210 +177 2 2 12 9 1422 1589 3013 +178 2 2 12 9 1775 723 2639 +179 2 2 12 9 1776 2640 724 +180 2 2 12 9 3341 2508 1081 +181 2 2 12 9 3342 1082 2509 +182 2 2 12 9 638 1351 2306 +183 2 2 12 9 786 1964 2278 +184 2 2 12 9 785 1609 2277 +185 2 2 12 9 786 2278 1610 +186 2 2 12 9 712 2535 1236 +187 2 2 12 9 908 1758 2018 +188 2 2 12 9 785 2277 1988 +189 2 2 12 9 672 1202 1641 +190 2 2 12 9 653 1860 1664 +191 2 2 12 9 1343 1585 3116 +192 2 2 12 9 1344 3117 1586 +193 2 2 12 9 605 1276 2437 +194 2 2 12 9 445 3113 1199 +195 2 2 12 9 1115 1373 2964 +196 2 2 12 9 1821 2218 3590 +197 2 2 12 9 775 1135 2139 +198 2 2 12 9 2461 2963 659 +199 2 2 12 9 1403 1684 2926 +200 2 2 12 9 284 285 1484 +201 2 2 12 9 850 1657 1724 +202 2 2 12 9 1306 1629 2838 +203 2 2 12 9 760 1133 2991 +204 2 2 12 9 638 2306 1353 +205 2 2 12 9 761 2992 1134 +206 2 2 12 9 2963 1527 659 +207 2 2 12 9 3553 758 1231 +208 2 2 12 9 1295 2860 1851 +209 2 2 12 9 671 1265 1584 +210 2 2 12 9 725 1549 1291 +211 2 2 12 9 474 1731 1614 +212 2 2 12 9 681 2854 1221 +213 2 2 12 9 1106 1965 2715 +214 2 2 12 9 967 2768 1329 +215 2 2 12 9 431 1693 1187 +216 2 2 12 9 423 1289 1989 +217 2 2 12 9 662 1453 1330 +218 2 2 12 9 1349 3072 2197 +219 2 2 12 9 717 3230 1209 +220 2 2 12 9 226 1682 3276 +221 2 2 12 9 1624 2259 2647 +222 2 2 12 9 1329 2944 3269 +223 2 2 12 9 838 1581 1356 +224 2 2 12 9 3130 609 1556 +225 2 2 12 9 758 1951 1231 +226 2 2 12 9 694 1265 2983 +227 2 2 12 9 788 1155 3495 +228 2 2 12 9 1162 709 2060 +229 2 2 12 9 709 1422 3013 +230 2 2 12 9 704 1683 2488 +231 2 2 12 9 593 1357 1793 +232 2 2 12 9 594 1794 1358 +233 2 2 12 9 671 2457 1265 +234 2 2 12 9 3350 1648 1867 +235 2 2 12 9 656 2218 1821 +236 2 2 12 9 401 1231 1951 +237 2 2 12 9 570 1275 3428 +238 2 2 12 9 689 1846 1167 +239 2 2 12 9 690 1168 1847 +240 2 2 12 9 624 1415 1391 +241 2 2 12 9 625 1392 1416 +242 2 2 12 9 1174 2609 2421 +243 2 2 12 9 451 1547 1313 +244 2 2 12 9 452 1314 1548 +245 2 2 12 9 1665 2280 2815 +246 2 2 12 9 542 1374 1987 +247 2 2 12 9 257 258 1322 +248 2 2 12 9 318 319 1323 +249 2 2 12 9 849 2825 1286 +250 2 2 12 9 798 1714 1462 +251 2 2 12 9 628 1991 1315 +252 2 2 12 9 608 1291 3393 +253 2 2 12 9 566 2179 1176 +254 2 2 12 9 300 2381 1475 +255 2 2 12 9 493 1467 2341 +256 2 2 12 9 541 1804 1187 +257 2 2 12 9 616 1914 2811 +258 2 2 12 9 606 1572 1355 +259 2 2 12 9 775 2308 1135 +260 2 2 12 9 350 2163 1278 +261 2 2 12 9 470 1648 1221 +262 2 2 12 9 1763 3239 2537 +263 2 2 12 9 1291 1549 3393 +264 2 2 12 9 969 1654 2758 +265 2 2 12 9 970 2759 1655 +266 2 2 12 9 2944 430 3269 +267 2 2 12 9 300 301 2381 +268 2 2 12 9 2922 1886 600 +269 2 2 12 9 556 2201 1573 +270 2 2 12 9 888 1490 1492 +271 2 2 12 9 229 230 1311 +272 2 2 12 9 946 2084 1627 +273 2 2 12 9 1324 3163 1888 +274 2 2 12 9 1325 1889 3164 +275 2 2 12 9 931 1512 2045 +276 2 2 12 9 862 1290 1987 +277 2 2 12 9 733 1694 1890 +278 2 2 12 9 734 1891 1695 +279 2 2 12 9 1461 3504 2079 +280 2 2 12 9 637 1434 1568 +281 2 2 12 9 1205 3276 1682 +282 2 2 12 9 1941 3228 2525 +283 2 2 12 9 1942 2526 3229 +284 2 2 12 9 1066 1941 2525 +285 2 2 12 9 1067 2526 1942 +286 2 2 12 9 529 1985 1191 +287 2 2 12 9 563 1752 1150 +288 2 2 12 9 754 1781 2119 +289 2 2 12 9 782 1181 2259 +290 2 2 12 9 870 1923 1866 +291 2 2 12 9 930 1966 1335 +292 2 2 12 9 541 1187 1993 +293 2 2 12 9 1645 3533 2866 +294 2 2 12 9 466 1724 1657 +295 2 2 12 9 837 1944 1773 +296 2 2 12 9 674 1749 1243 +297 2 2 12 9 694 2983 1312 +298 2 2 12 9 718 1739 1171 +299 2 2 12 9 616 3304 1914 +300 2 2 12 9 340 1270 2593 +301 2 2 12 9 292 293 1506 +302 2 2 12 9 505 1244 1835 +303 2 2 12 9 284 1484 2932 +304 2 2 12 9 772 1557 1754 +305 2 2 12 9 663 1710 2266 +306 2 2 12 9 664 2267 1711 +307 2 2 12 9 538 1188 2207 +308 2 2 12 9 493 2341 2686 +309 2 2 12 9 969 2839 1654 +310 2 2 12 9 970 1655 2840 +311 2 2 12 9 1099 2944 1329 +312 2 2 12 9 478 1502 1519 +313 2 2 12 9 479 1520 1503 +314 2 2 12 9 1698 2410 3081 +315 2 2 12 9 1103 2205 2807 +316 2 2 12 9 2411 1699 3082 +317 2 2 12 9 1502 2404 3608 +318 2 2 12 9 1503 3609 2405 +319 2 2 12 9 630 2047 1662 +320 2 2 12 9 631 1663 2048 +321 2 2 12 9 681 1221 1648 +322 2 2 12 9 679 1237 3062 +323 2 2 12 9 704 2488 1681 +324 2 2 12 9 539 1156 2286 +325 2 2 12 9 1389 3580 2393 +326 2 2 12 9 501 1627 2084 +327 2 2 12 9 233 2615 1232 +328 2 2 12 9 825 3515 1434 +329 2 2 12 9 787 3573 1177 +330 2 2 12 9 597 2062 1492 +331 2 2 12 9 849 1215 2466 +332 2 2 12 9 422 1433 1462 +333 2 2 12 9 399 3203 1850 +334 2 2 12 9 1372 3453 1815 +335 2 2 12 9 712 1236 2523 +336 2 2 12 9 733 1890 1550 +337 2 2 12 9 734 1551 1891 +338 2 2 12 9 456 1250 3301 +339 2 2 12 9 606 1244 1572 +340 2 2 12 9 538 2964 1373 +341 2 2 12 9 1404 2585 2353 +342 2 2 12 9 557 1204 1822 +343 2 2 12 9 3453 444 1815 +344 2 2 12 9 562 1229 1658 +345 2 2 12 9 564 1659 1230 +346 2 2 12 9 3583 1394 2990 +347 2 2 12 9 354 1645 2866 +348 2 2 12 9 2952 845 1642 +349 2 2 12 9 722 2131 1618 +350 2 2 12 9 442 2280 1665 +351 2 2 12 9 3533 1204 2866 +352 2 2 12 9 837 1282 2113 +353 2 2 12 9 422 1489 1530 +354 2 2 12 9 679 1666 1237 +355 2 2 12 9 792 3316 1336 +356 2 2 12 9 397 1203 2081 +357 2 2 12 9 790 1286 2204 +358 2 2 12 9 1412 3080 1919 +359 2 2 12 9 1008 3590 2218 +360 2 2 12 9 862 1987 1374 +361 2 2 12 9 749 1216 1931 +362 2 2 12 9 856 2202 1296 +363 2 2 12 9 695 1594 1381 +364 2 2 12 9 857 1297 2203 +365 2 2 12 9 721 1530 1489 +366 2 2 12 9 1215 1336 3316 +367 2 2 12 9 1381 1594 3576 +368 2 2 12 9 605 2437 1386 +369 2 2 12 9 434 1200 3287 +370 2 2 12 9 435 3288 1201 +371 2 2 12 9 1077 2219 1897 +372 2 2 12 9 1078 1898 2220 +373 2 2 12 9 391 2346 1374 +374 2 2 12 9 696 1462 1433 +375 2 2 12 9 412 2856 2393 +376 2 2 12 9 539 3389 1156 +377 2 2 12 9 2033 2508 3341 +378 2 2 12 9 2034 3342 2509 +379 2 2 12 9 345 2323 2532 +380 2 2 12 9 1396 2466 2342 +381 2 2 12 9 675 1316 1756 +382 2 2 12 9 1434 3515 1568 +383 2 2 12 9 892 1564 1353 +384 2 2 12 9 849 1396 2825 +385 2 2 12 9 40 2169 2126 +386 2 2 12 9 181 2127 2170 +387 2 2 12 9 3251 2523 668 +388 2 2 12 9 570 3428 1515 +389 2 2 12 9 1962 1555 3206 +390 2 2 12 9 1075 2119 1781 +391 2 2 12 9 695 1258 3072 +392 2 2 12 9 3617 561 2583 +393 2 2 12 9 718 1171 2247 +394 2 2 12 9 666 2489 1364 +395 2 2 12 9 873 1748 1255 +396 2 2 12 9 3627 1837 598 +397 2 2 12 9 1205 3222 2291 +398 2 2 12 9 538 2032 1188 +399 2 2 12 9 782 1887 1181 +400 2 2 12 9 749 2954 1216 +401 2 2 12 9 529 3376 1252 +402 2 2 12 9 692 1724 2670 +403 2 2 12 9 546 2626 1157 +404 2 2 12 9 547 1158 2627 +405 2 2 12 9 634 1262 2695 +406 2 2 12 9 1033 1997 2979 +407 2 2 12 9 1034 2980 2000 +408 2 2 12 9 863 1614 1731 +409 2 2 12 9 743 1199 1685 +410 2 2 12 9 910 1257 2714 +411 2 2 12 9 739 1519 1502 +412 2 2 12 9 740 1503 1520 +413 2 2 12 9 779 2073 1688 +414 2 2 12 9 426 1459 2301 +415 2 2 12 9 427 2302 1460 +416 2 2 12 9 888 1492 2062 +417 2 2 12 9 677 3136 1307 +418 2 2 12 9 592 1449 2596 +419 2 2 12 9 397 2190 1203 +420 2 2 12 9 293 2959 1506 +421 2 2 12 9 562 1924 1229 +422 2 2 12 9 564 1230 1925 +423 2 2 12 9 438 1492 1490 +424 2 2 12 9 555 2421 2609 +425 2 2 12 9 447 1356 1581 +426 2 2 12 9 403 1287 2023 +427 2 2 12 9 404 2024 1288 +428 2 2 12 9 608 2917 1417 +429 2 2 12 9 541 2633 1804 +430 2 2 12 9 882 1349 2197 +431 2 2 12 9 1017 1573 2201 +432 2 2 12 9 642 2254 2684 +433 2 2 12 9 1664 1860 2891 +434 2 2 12 9 408 1897 2219 +435 2 2 12 9 409 2220 1898 +436 2 2 12 9 546 1157 2255 +437 2 2 12 9 547 2256 1158 +438 2 2 12 9 443 1986 2099 +439 2 2 12 9 702 1723 1691 +440 2 2 12 9 1296 2202 3087 +441 2 2 12 9 1297 3088 2203 +442 2 2 12 9 1279 2523 3251 +443 2 2 12 9 670 1577 1372 +444 2 2 12 9 1309 2952 1642 +445 2 2 12 9 357 1243 1749 +446 2 2 12 9 395 1745 1214 +447 2 2 12 9 722 2485 3021 +448 2 2 12 9 1220 2670 1724 +449 2 2 12 9 1132 3029 2168 +450 2 2 12 9 362 2259 2247 +451 2 2 12 9 542 1162 2060 +452 2 2 12 9 288 289 1360 +453 2 2 12 9 1700 432 3033 +454 2 2 12 9 3034 433 1701 +455 2 2 12 9 357 2913 1186 +456 2 2 12 9 377 2524 3057 +457 2 2 12 9 634 3475 1262 +458 2 2 12 9 723 2410 1698 +459 2 2 12 9 724 1699 2411 +460 2 2 12 9 922 1624 2647 +461 2 2 12 9 1095 2537 3239 +462 2 2 12 9 457 2466 1215 +463 2 2 12 9 1004 1662 2047 +464 2 2 12 9 1005 2048 1663 +465 2 2 12 9 1001 2208 2360 +466 2 2 12 9 870 1866 1371 +467 2 2 12 9 1106 2968 1965 +468 2 2 12 9 512 1269 1789 +469 2 2 12 9 398 1219 1751 +470 2 2 12 9 854 1278 2163 +471 2 2 12 9 790 1447 1881 +472 2 2 12 9 632 1728 1256 +473 2 2 12 9 681 1648 3350 +474 2 2 12 9 1555 999 3206 +475 2 2 12 9 922 1684 1403 +476 2 2 12 9 1373 2841 1702 +477 2 2 12 9 620 1206 1838 +478 2 2 12 9 760 1574 1625 +479 2 2 12 9 761 1626 1575 +480 2 2 12 9 406 2883 1342 +481 2 2 12 9 434 1625 1574 +482 2 2 12 9 1064 1417 3047 +483 2 2 12 9 435 1575 1626 +484 2 2 12 9 439 1653 1516 +485 2 2 12 9 428 1684 1577 +486 2 2 12 9 563 1150 2324 +487 2 2 12 9 693 1394 3583 +488 2 2 12 9 3438 656 2109 +489 2 2 12 9 3608 2404 650 +490 2 2 12 9 3609 651 2405 +491 2 2 12 9 763 1516 1653 +492 2 2 12 9 1329 2768 2931 +493 2 2 12 9 662 1294 2804 +494 2 2 12 9 3576 1594 645 +495 2 2 12 9 1318 2266 3324 +496 2 2 12 9 1319 3325 2267 +497 2 2 12 9 997 2266 1710 +498 2 2 12 9 998 1711 2267 +499 2 2 12 9 3475 2050 1262 +500 2 2 12 9 966 1326 2777 +501 2 2 12 9 470 1221 2505 +502 2 2 12 9 930 2367 1966 +503 2 2 12 9 1304 3102 2077 +504 2 2 12 9 273 2059 2903 +505 2 2 12 9 572 2654 1241 +506 2 2 12 9 573 1242 2655 +507 2 2 12 9 477 1754 1557 +508 2 2 12 9 505 2723 1244 +509 2 2 12 9 1144 1417 2917 +510 2 2 12 9 722 3021 1630 +511 2 2 12 9 230 2076 1311 +512 2 2 12 9 639 1727 2257 +513 2 2 12 9 717 1209 1757 +514 2 2 12 9 434 2712 1200 +515 2 2 12 9 435 1201 2713 +516 2 2 12 9 1304 2020 3047 +517 2 2 12 9 387 2018 1758 +518 2 2 12 9 576 1237 1666 +519 2 2 12 9 3129 1504 696 +520 2 2 12 9 834 1691 1723 +521 2 2 12 9 689 1167 2364 +522 2 2 12 9 690 2365 1168 +523 2 2 12 9 424 1620 3003 +524 2 2 12 9 608 3168 1291 +525 2 2 12 9 3047 2020 1064 +526 2 2 12 9 1459 2754 2301 +527 2 2 12 9 1460 2302 2755 +528 2 2 12 9 900 2292 1225 +529 2 2 12 9 1215 3372 1336 +530 2 2 12 9 1103 3249 2205 +531 2 2 12 9 511 1827 1291 +532 2 2 12 9 1130 2388 2001 +533 2 2 12 9 1131 2002 2389 +534 2 2 12 9 358 1256 2624 +535 2 2 12 9 684 1763 2537 +536 2 2 12 9 1975 371 2605 +537 2 2 12 9 233 1232 1972 +538 2 2 12 9 2607 372 1976 +539 2 2 12 9 1804 2633 3375 +540 2 2 12 9 587 1212 1761 +541 2 2 12 9 588 1762 1213 +542 2 2 12 9 267 1917 2391 +543 2 2 12 9 834 1669 2027 +544 2 2 12 9 662 1330 1814 +545 2 2 12 9 837 2997 1282 +546 2 2 12 9 364 1400 1907 +547 2 2 12 9 646 1398 2065 +548 2 2 12 9 893 1909 1704 +549 2 2 12 9 894 1705 1911 +550 2 2 12 9 813 1769 1848 +551 2 2 12 9 1001 1688 2073 +552 2 2 12 9 447 1995 1713 +553 2 2 12 9 595 2264 1399 +554 2 2 12 9 506 1318 3324 +555 2 2 12 9 507 3325 1319 +556 2 2 12 9 788 2136 1155 +557 2 2 12 9 940 1532 2967 +558 2 2 12 9 793 2177 1258 +559 2 2 12 9 1181 2247 2259 +560 2 2 12 9 1003 2941 1332 +561 2 2 12 9 735 1785 3508 +562 2 2 12 9 361 3141 2074 +563 2 2 12 9 432 1700 1271 +564 2 2 12 9 433 1272 1701 +565 2 2 12 9 424 3003 2513 +566 2 2 12 9 697 1250 2575 +567 2 2 12 9 475 1861 2981 +568 2 2 12 9 476 2982 1862 +569 2 2 12 9 849 2919 1215 +570 2 2 12 9 542 1987 1162 +571 2 2 12 9 717 1531 3230 +572 2 2 12 9 444 1402 1815 +573 2 2 12 9 736 3509 1788 +574 2 2 12 9 353 2132 1979 +575 2 2 12 9 691 1702 2841 +576 2 2 12 9 624 1667 2304 +577 2 2 12 9 625 2305 1668 +578 2 2 12 9 620 1850 1206 +579 2 2 12 9 3080 1010 1919 +580 2 2 12 9 680 1280 2178 +581 2 2 12 9 1449 3642 2596 +582 2 2 12 9 617 1401 3625 +583 2 2 12 9 512 2049 1269 +584 2 2 12 9 1260 1975 2605 +585 2 2 12 9 1261 2607 1976 +586 2 2 12 9 445 1199 1937 +587 2 2 12 9 675 1693 1316 +588 2 2 12 9 867 1396 2342 +589 2 2 12 9 778 2081 1203 +590 2 2 12 9 1074 1379 1879 +591 2 2 12 9 683 1736 3564 +592 2 2 12 9 1007 1327 2800 +593 2 2 12 9 1417 3210 3047 +594 2 2 12 9 556 1573 2293 +595 2 2 12 9 1357 1700 3033 +596 2 2 12 9 1358 3034 1701 +597 2 2 12 9 646 2065 2824 +598 2 2 12 9 633 2756 3418 +599 2 2 12 9 577 1676 2166 +600 2 2 12 9 1127 2751 1540 +601 2 2 12 9 553 1268 2580 +602 2 2 12 9 1228 2393 2856 +603 2 2 12 9 681 1451 2854 +604 2 2 12 9 1705 3094 2835 +605 2 2 12 9 1071 1463 2583 +606 2 2 12 9 722 1630 2131 +607 2 2 12 9 1206 1850 3203 +608 2 2 12 9 874 1285 2569 +609 2 2 12 9 1216 15 2283 +610 2 2 12 9 2099 1986 3029 +611 2 2 12 9 3580 412 2393 +612 2 2 12 9 695 3072 1349 +613 2 2 12 9 492 2182 1652 +614 2 2 12 9 773 1704 1909 +615 2 2 12 9 774 1911 1705 +616 2 2 12 9 425 2315 1350 +617 2 2 12 9 1413 3564 1736 +618 2 2 12 9 360 2108 2870 +619 2 2 12 9 725 1291 1827 +620 2 2 12 9 397 2081 1806 +621 2 2 12 9 398 2542 1431 +622 2 2 12 9 580 2363 1366 +623 2 2 12 9 668 1236 1703 +624 2 2 12 9 1098 2124 2008 +625 2 2 12 9 812 1994 1208 +626 2 2 12 9 647 1287 1725 +627 2 2 12 9 648 1726 1288 +628 2 2 12 9 538 1373 1702 +629 2 2 12 9 3504 698 2079 +630 2 2 12 9 737 1427 1519 +631 2 2 12 9 738 1520 1428 +632 2 2 12 9 367 1613 1956 +633 2 2 12 9 449 1193 3126 +634 2 2 12 9 829 1223 1900 +635 2 2 12 9 830 1901 1224 +636 2 2 12 9 754 2119 1222 +637 2 2 12 9 797 1592 1785 +638 2 2 12 9 551 2373 1857 +639 2 2 12 9 552 1858 2374 +640 2 2 12 9 223 224 1390 +641 2 2 12 9 464 1362 1819 +642 2 2 12 9 465 1820 1363 +643 2 2 12 9 1470 3438 2109 +644 2 2 12 9 742 1544 1479 +645 2 2 12 9 395 1214 2285 +646 2 2 12 9 686 1484 2989 +647 2 2 12 9 566 1176 2455 +648 2 2 12 9 438 2185 1305 +649 2 2 12 9 910 2416 1257 +650 2 2 12 9 1150 1979 2132 +651 2 2 12 9 741 2312 1190 +652 2 2 12 9 558 2777 1326 +653 2 2 12 9 898 2539 2348 +654 2 2 12 9 1092 2257 1727 +655 2 2 12 9 814 1342 1604 +656 2 2 12 9 523 2008 2124 +657 2 2 12 9 671 2751 2457 +658 2 2 12 9 1245 2849 2080 +659 2 2 12 9 308 1998 2357 +660 2 2 12 9 679 3062 1418 +661 2 2 12 9 1305 2185 2371 +662 2 2 12 9 966 2210 1326 +663 2 2 12 9 663 1435 1710 +664 2 2 12 9 664 1711 1436 +665 2 2 12 9 677 3581 3136 +666 2 2 12 9 199 2354 1783 +667 2 2 12 9 601 1494 2213 +668 2 2 12 9 602 2214 1495 +669 2 2 12 9 519 2001 2388 +670 2 2 12 9 520 2389 2002 +671 2 2 12 9 780 3009 1269 +672 2 2 12 9 715 1589 1422 +673 2 2 12 9 829 3462 1223 +674 2 2 12 9 830 1224 3463 +675 2 2 12 9 898 2348 1731 +676 2 2 12 9 799 1788 1595 +677 2 2 12 9 3102 1118 2077 +678 2 2 12 9 834 2027 2426 +679 2 2 12 9 557 1822 1251 +680 2 2 12 9 1523 1837 3627 +681 2 2 12 9 432 1271 2745 +682 2 2 12 9 433 2746 1272 +683 2 2 12 9 1205 2291 3276 +684 2 2 12 9 805 1311 2076 +685 2 2 12 9 730 1679 3154 +686 2 2 12 9 731 3155 1680 +687 2 2 12 9 38 39 1384 +688 2 2 12 9 182 183 1385 +689 2 2 12 9 1687 2527 2934 +690 2 2 12 9 770 1819 1217 +691 2 2 12 9 1818 3129 696 +692 2 2 12 9 473 1298 2570 +693 2 2 12 9 771 1218 1820 +694 2 2 12 9 456 3301 1544 +695 2 2 12 9 545 3333 1931 +696 2 2 12 9 359 2279 1448 +697 2 2 12 9 377 3057 1922 +698 2 2 12 9 633 3511 2756 +699 2 2 12 9 1074 3091 1379 +700 2 2 12 9 1518 2883 2912 +701 2 2 12 9 666 3461 2489 +702 2 2 12 9 662 2804 1453 +703 2 2 12 9 1045 2304 1667 +704 2 2 12 9 1046 1668 2305 +705 2 2 12 9 273 274 2059 +706 2 2 12 9 445 1486 3113 +707 2 2 12 9 1651 2998 2671 +708 2 2 12 9 357 2675 1243 +709 2 2 12 9 1463 3617 2583 +710 2 2 12 9 1179 2273 3081 +711 2 2 12 9 686 2989 1707 +712 2 2 12 9 1180 3082 2274 +713 2 2 12 9 832 1984 1321 +714 2 2 12 9 488 1310 2398 +715 2 2 12 9 1443 3508 1785 +716 2 2 12 9 447 1581 1995 +717 2 2 12 9 260 261 1843 +718 2 2 12 9 315 316 1844 +719 2 2 12 9 754 1222 2676 +720 2 2 12 9 513 2478 3079 +721 2 2 12 9 1009 1431 2542 +722 2 2 12 9 862 1374 2346 +723 2 2 12 9 1706 2726 2750 +724 2 2 12 9 1444 1788 3509 +725 2 2 12 9 529 1252 1985 +726 2 2 12 9 355 1892 1266 +727 2 2 12 9 783 2117 2011 +728 2 2 12 9 356 1267 1893 +729 2 2 12 9 784 2012 2118 +730 2 2 12 9 787 1177 2194 +731 2 2 12 9 617 3625 1471 +732 2 2 12 9 568 1238 2178 +733 2 2 12 9 1313 1547 3309 +734 2 2 12 9 1132 2168 3399 +735 2 2 12 9 1314 3310 1548 +736 2 2 12 9 878 2353 2585 +737 2 2 12 9 1262 2064 2695 +738 2 2 12 9 398 2534 1219 +739 2 2 12 9 741 1190 1938 +740 2 2 12 9 605 1386 1674 +741 2 2 12 9 1211 1931 3333 +742 2 2 12 9 449 1756 1316 +743 2 2 12 9 439 1211 3138 +744 2 2 12 9 756 3279 1197 +745 2 2 12 9 757 1198 3280 +746 2 2 12 9 387 1505 2018 +747 2 2 12 9 360 3538 2108 +748 2 2 12 9 759 1247 2067 +749 2 2 12 9 350 1278 3409 +750 2 2 12 9 933 2624 1256 +751 2 2 12 9 464 1819 1796 +752 2 2 12 9 465 1797 1820 +753 2 2 12 9 425 1350 1677 +754 2 2 12 9 423 1989 1590 +755 2 2 12 9 357 1186 2228 +756 2 2 12 9 530 1396 2232 +757 2 2 12 9 1532 1715 2967 +758 2 2 12 9 894 3094 1705 +759 2 2 12 9 1025 2166 1676 +760 2 2 12 9 446 1365 2087 +761 2 2 12 9 1324 1888 3327 +762 2 2 12 9 1325 3328 1889 +763 2 2 12 9 1627 2402 2957 +764 2 2 12 9 636 1552 1880 +765 2 2 12 9 650 2025 3608 +766 2 2 12 9 651 3609 2026 +767 2 2 12 9 637 1568 3353 +768 2 2 12 9 1200 1857 2373 +769 2 2 12 9 1201 2374 1858 +770 2 2 12 9 636 1347 1746 +771 2 2 12 9 817 1969 1644 +772 2 2 12 9 2544 730 3154 +773 2 2 12 9 2545 3155 731 +774 2 2 12 9 859 1399 2264 +775 2 2 12 9 587 2103 1212 +776 2 2 12 9 588 1213 2104 +777 2 2 12 9 1002 1652 2182 +778 2 2 12 9 434 1615 1565 +779 2 2 12 9 435 1566 1616 +780 2 2 12 9 799 1525 2467 +781 2 2 12 9 1157 1843 2731 +782 2 2 12 9 1158 2732 1844 +783 2 2 12 9 467 2303 1361 +784 2 2 12 9 618 2899 1307 +785 2 2 12 9 1029 1806 2081 +786 2 2 12 9 899 1957 1754 +787 2 2 12 9 1573 2643 2293 +788 2 2 12 9 1003 1332 3268 +789 2 2 12 9 1001 1380 2208 +790 2 2 12 9 628 2795 1991 +791 2 2 12 9 649 1210 2425 +792 2 2 12 9 3134 447 1713 +793 2 2 12 9 364 1303 3166 +794 2 2 12 9 400 2625 1863 +795 2 2 12 9 338 1410 3326 +796 2 2 12 9 781 1866 1923 +797 2 2 12 9 908 1298 1758 +798 2 2 12 9 671 1540 2751 +799 2 2 12 9 672 1571 1617 +800 2 2 12 9 1483 2369 2736 +801 2 2 12 9 506 3045 1318 +802 2 2 12 9 507 1319 3046 +803 2 2 12 9 1148 1432 3195 +804 2 2 12 9 449 3123 1193 +805 2 2 12 9 743 1937 1199 +806 2 2 12 9 1043 1941 2110 +807 2 2 12 9 361 2074 2967 +808 2 2 12 9 1044 2111 1942 +809 2 2 12 9 618 3456 1453 +810 2 2 12 9 867 2232 1396 +811 2 2 12 9 431 1187 2236 +812 2 2 12 9 904 2213 1494 +813 2 2 12 9 905 1495 2214 +814 2 2 12 9 379 1567 1535 +815 2 2 12 9 401 2312 1231 +816 2 2 12 9 780 1269 2049 +817 2 2 12 9 632 1256 2035 +818 2 2 12 9 536 1865 2802 +819 2 2 12 9 309 2392 1998 +820 2 2 12 9 1133 1472 2991 +821 2 2 12 9 391 1404 2353 +822 2 2 12 9 1134 2992 1473 +823 2 2 12 9 908 2570 1298 +824 2 2 12 9 1579 2562 3526 +825 2 2 12 9 513 3079 1513 +826 2 2 12 9 481 1802 1609 +827 2 2 12 9 482 1610 1803 +828 2 2 12 9 505 2562 1579 +829 2 2 12 9 340 2578 1270 +830 2 2 12 9 440 2113 1282 +831 2 2 12 9 355 1266 2245 +832 2 2 12 9 356 2246 1267 +833 2 2 12 9 825 1434 2154 +834 2 2 12 9 709 2715 1422 +835 2 2 12 9 1178 3208 1602 +836 2 2 12 9 23 24 1720 +837 2 2 12 9 1367 2330 3197 +838 2 2 12 9 3298 572 1241 +839 2 2 12 9 1368 3198 2331 +840 2 2 12 9 3300 1242 573 +841 2 2 12 9 756 1197 2245 +842 2 2 12 9 757 2246 1198 +843 2 2 12 9 729 1264 2175 +844 2 2 12 9 756 3327 1888 +845 2 2 12 9 757 1889 3328 +846 2 2 12 9 381 2569 1285 +847 2 2 12 9 453 1251 2628 +848 2 2 12 9 344 1785 1592 +849 2 2 12 9 657 2546 1795 +850 2 2 12 9 875 2398 1310 +851 2 2 12 9 772 1754 1957 +852 2 2 12 9 339 2882 3013 +853 2 2 12 9 1235 2757 1691 +854 2 2 12 9 226 227 1682 +855 2 2 12 9 1299 3036 1977 +856 2 2 12 9 1300 1978 3037 +857 2 2 12 9 450 1222 2119 +858 2 2 12 9 2954 15 1216 +859 2 2 12 9 553 2733 1268 +860 2 2 12 9 737 1519 1636 +861 2 2 12 9 738 1637 1520 +862 2 2 12 9 26 27 1423 +863 2 2 12 9 2125 2417 376 +864 2 2 12 9 426 1560 1459 +865 2 2 12 9 427 1460 1561 +866 2 2 12 9 1332 2941 3256 +867 2 2 12 9 754 1545 1781 +868 2 2 12 9 652 1497 1522 +869 2 2 12 9 900 1225 2837 +870 2 2 12 9 787 2030 3573 +871 2 2 12 9 456 2575 1250 +872 2 2 12 9 500 2715 1965 +873 2 2 12 9 382 2158 1630 +874 2 2 12 9 2951 1922 1695 +875 2 2 12 9 766 2080 2849 +876 2 2 12 9 1096 2802 1865 +877 2 2 12 9 367 1956 1605 +878 2 2 12 9 456 3383 2933 +879 2 2 12 9 423 1369 2576 +880 2 2 12 9 925 2486 1407 +881 2 2 12 9 926 1408 2487 +882 2 2 12 9 770 1217 2875 +883 2 2 12 9 771 2876 1218 +884 2 2 12 9 781 1923 1425 +885 2 2 12 9 705 2818 1884 +886 2 2 12 9 626 1371 2175 +887 2 2 12 9 706 1885 2819 +888 2 2 12 9 449 1316 1826 +889 2 2 12 9 529 1639 3376 +890 2 2 12 9 598 1379 3091 +891 2 2 12 9 1161 1930 2488 +892 2 2 12 9 400 1934 2625 +893 2 2 12 9 358 3470 1256 +894 2 2 12 9 345 1595 1788 +895 2 2 12 9 439 2061 1211 +896 2 2 12 9 440 1282 3255 +897 2 2 12 9 1286 2825 2204 +898 2 2 12 9 344 1443 1785 +899 2 2 12 9 770 1345 1796 +900 2 2 12 9 3159 417 2268 +901 2 2 12 9 771 1797 1346 +902 2 2 12 9 1290 2820 1987 +903 2 2 12 9 406 1342 2144 +904 2 2 12 9 875 1310 2470 +905 2 2 12 9 3016 1897 943 +906 2 2 12 9 3017 944 1898 +907 2 2 12 9 650 2404 2677 +908 2 2 12 9 651 2678 2405 +909 2 2 12 9 788 3495 2031 +910 2 2 12 9 446 2087 1418 +911 2 2 12 9 407 1999 3001 +912 2 2 12 9 533 1631 2705 +913 2 2 12 9 694 2829 1265 +914 2 2 12 9 345 1788 1444 +915 2 2 12 9 387 2603 1505 +916 2 2 12 9 2615 235 1852 +917 2 2 12 9 343 2006 1345 +918 2 2 12 9 342 1346 2007 +919 2 2 12 9 1313 3309 3508 +920 2 2 12 9 1314 3509 3310 +921 2 2 12 9 2402 599 2957 +922 2 2 12 9 405 3047 3210 +923 2 2 12 9 450 2327 1619 +924 2 2 12 9 793 1258 2168 +925 2 2 12 9 755 1985 1252 +926 2 2 12 9 1182 3441 1536 +927 2 2 12 9 1910 2851 2706 +928 2 2 12 9 1175 2684 2254 +929 2 2 12 9 618 1453 3615 +930 2 2 12 9 662 3539 1294 +931 2 2 12 9 470 1255 2683 +932 2 2 12 9 616 1425 1923 +933 2 2 12 9 354 2413 2412 +934 2 2 12 9 198 199 1783 +935 2 2 12 9 251 1854 2275 +936 2 2 12 9 325 2276 1855 +937 2 2 12 9 1190 1795 2546 +938 2 2 12 9 2292 3408 1225 +939 2 2 12 9 388 1195 2250 +940 2 2 12 9 705 1734 2818 +941 2 2 12 9 706 2819 1735 +942 2 2 12 9 438 1305 2193 +943 2 2 12 9 191 192 1432 +944 2 2 12 9 812 1208 2093 +945 2 2 12 9 2362 961 3111 +946 2 2 12 9 1399 3408 2292 +947 2 2 12 9 1024 2883 1518 +948 2 2 12 9 463 1517 2602 +949 2 2 12 9 748 1487 2236 +950 2 2 12 9 705 1824 1367 +951 2 2 12 9 706 1368 1825 +952 2 2 12 9 3099 1018 1815 +953 2 2 12 9 1171 2606 2975 +954 2 2 12 9 755 1341 1983 +955 2 2 12 9 557 2462 1204 +956 2 2 12 9 352 2991 1472 +957 2 2 12 9 351 1473 2992 +958 2 2 12 9 827 2182 1370 +959 2 2 12 9 627 3195 1432 +960 2 2 12 9 3036 710 1977 +961 2 2 12 9 3037 1978 711 +962 2 2 12 9 457 1215 3316 +963 2 2 12 9 224 2291 1390 +964 2 2 12 9 417 3159 1454 +965 2 2 12 9 365 1554 2659 +966 2 2 12 9 605 2941 1276 +967 2 2 12 9 982 2793 1553 +968 2 2 12 9 988 2126 2169 +969 2 2 12 9 989 2170 2127 +970 2 2 12 9 606 1882 1244 +971 2 2 12 9 1380 3134 1713 +972 2 2 12 9 916 2951 1695 +973 2 2 12 9 705 1367 1734 +974 2 2 12 9 706 1735 1368 +975 2 2 12 9 823 2122 1391 +976 2 2 12 9 824 1392 2123 +977 2 2 12 9 593 1793 2942 +978 2 2 12 9 568 2368 1238 +979 2 2 12 9 594 2943 1794 +980 2 2 12 9 584 1311 2263 +981 2 2 12 9 746 1259 2955 +982 2 2 12 9 976 1526 2188 +983 2 2 12 9 381 1285 2494 +984 2 2 12 9 483 2384 2915 +985 2 2 12 9 942 1630 2158 +986 2 2 12 9 647 2023 1287 +987 2 2 12 9 648 1288 2024 +988 2 2 12 9 446 2369 1483 +989 2 2 12 9 1330 1453 3456 +990 2 2 12 9 896 1845 1770 +991 2 2 12 9 1208 2063 2805 +992 2 2 12 9 1536 3441 2907 +993 2 2 12 9 729 2439 1264 +994 2 2 12 9 391 1374 2491 +995 2 2 12 9 274 275 2212 +996 2 2 12 9 666 1364 3242 +997 2 2 12 9 250 251 2275 +998 2 2 12 9 325 326 2276 +999 2 2 12 9 714 2726 1706 +1000 2 2 12 9 373 2110 1941 +1001 2 2 12 9 374 1942 2111 +1002 2 2 12 9 537 1683 1461 +1003 2 2 12 9 450 2531 1932 +1004 2 2 12 9 1553 2793 3071 +1005 2 2 12 9 741 1938 1352 +1006 2 2 12 9 800 2371 2185 +1007 2 2 12 9 670 1372 1815 +1008 2 2 12 9 1235 2973 2757 +1009 2 2 12 9 703 2953 1506 +1010 2 2 12 9 403 2557 1287 +1011 2 2 12 9 404 1288 2558 +1012 2 2 12 9 925 1407 2464 +1013 2 2 12 9 926 2465 1408 +1014 2 2 12 9 748 3068 1351 +1015 2 2 12 9 474 2029 1731 +1016 2 2 12 9 578 3087 2202 +1017 2 2 12 9 801 1305 1840 +1018 2 2 12 9 579 2203 3088 +1019 2 2 12 9 2841 1992 921 +1020 2 2 12 9 458 2364 1481 +1021 2 2 12 9 459 1482 2365 +1022 2 2 12 9 546 2255 1271 +1023 2 2 12 9 547 1272 2256 +1024 2 2 12 9 1427 1897 3016 +1025 2 2 12 9 413 3175 1375 +1026 2 2 12 9 1428 3017 1898 +1027 2 2 12 9 645 1990 1375 +1028 2 2 12 9 668 2523 1236 +1029 2 2 12 9 741 1231 2312 +1030 2 2 12 9 472 1347 2861 +1031 2 2 12 9 1179 3369 2273 +1032 2 2 12 9 1180 2274 3370 +1033 2 2 12 9 3253 1757 463 +1034 2 2 12 9 778 1203 2207 +1035 2 2 12 9 1270 3247 2593 +1036 2 2 12 9 836 2928 1480 +1037 2 2 12 9 765 1670 1352 +1038 2 2 12 9 640 1602 3208 +1039 2 2 12 9 1336 2417 2125 +1040 2 2 12 9 597 3289 1361 +1041 2 2 12 9 927 1716 1980 +1042 2 2 12 9 928 1981 1717 +1043 2 2 12 9 1099 1329 2931 +1044 2 2 12 9 456 1739 3383 +1045 2 2 12 9 441 2488 1930 +1046 2 2 12 9 395 1747 1745 +1047 2 2 12 9 388 2177 1195 +1048 2 2 12 9 419 1870 1359 +1049 2 2 12 9 403 2464 1407 +1050 2 2 12 9 404 1408 2465 +1051 2 2 12 9 472 2394 1347 +1052 2 2 12 9 511 1291 2090 +1053 2 2 12 9 624 1391 2122 +1054 2 2 12 9 695 2429 1258 +1055 2 2 12 9 625 2123 1392 +1056 2 2 12 9 580 1903 1339 +1057 2 2 12 9 677 1307 2899 +1058 2 2 12 9 605 3256 2941 +1059 2 2 12 9 268 2311 1917 +1060 2 2 12 9 1480 2928 1706 +1061 2 2 12 9 458 1508 2364 +1062 2 2 12 9 459 2365 1509 +1063 2 2 12 9 1111 2412 2413 +1064 2 2 12 9 525 2336 1793 +1065 2 2 12 9 526 1794 2337 +1066 2 2 12 9 1876 2722 2799 +1067 2 2 12 9 417 1454 3039 +1068 2 2 12 9 354 1814 1330 +1069 2 2 12 9 903 2071 1713 +1070 2 2 12 9 691 1692 1702 +1071 2 2 12 9 359 1784 2279 +1072 2 2 12 9 840 2101 1439 +1073 2 2 12 9 841 1440 2102 +1074 2 2 12 9 623 2888 1342 +1075 2 2 12 9 274 2212 2059 +1076 2 2 12 9 365 2298 1333 +1077 2 2 12 9 1327 3286 2800 +1078 2 2 12 9 805 2263 1311 +1079 2 2 12 9 829 1609 1802 +1080 2 2 12 9 830 1803 1610 +1081 2 2 12 9 977 2562 1835 +1082 2 2 12 9 408 1439 2101 +1083 2 2 12 9 409 2102 1440 +1084 2 2 12 9 1052 1712 2428 +1085 2 2 12 9 386 2154 1434 +1086 2 2 12 9 488 1918 1310 +1087 2 2 12 9 766 1933 2080 +1088 2 2 12 9 885 2387 1414 +1089 2 2 12 9 1958 3146 2879 +1090 2 2 12 9 432 2745 3118 +1091 2 2 12 9 433 3119 2746 +1092 2 2 12 9 399 1850 2456 +1093 2 2 12 9 747 1567 1772 +1094 2 2 12 9 1402 3099 1815 +1095 2 2 12 9 1102 2671 2998 +1096 2 2 12 9 234 235 2615 +1097 2 2 12 9 685 1410 1690 +1098 2 2 12 9 1437 3608 2025 +1099 2 2 12 9 801 2193 1305 +1100 2 2 12 9 1438 2026 3609 +1101 2 2 12 9 975 1765 2513 +1102 2 2 12 9 739 3608 1437 +1103 2 2 12 9 739 1636 1519 +1104 2 2 12 9 423 2014 1289 +1105 2 2 12 9 892 1353 2498 +1106 2 2 12 9 740 1438 3609 +1107 2 2 12 9 740 1520 1637 +1108 2 2 12 9 3384 1955 1782 +1109 2 2 12 9 764 1617 1571 +1110 2 2 12 9 747 1535 1567 +1111 2 2 12 9 874 2085 1285 +1112 2 2 12 9 1100 1793 2336 +1113 2 2 12 9 973 2011 2117 +1114 2 2 12 9 1101 2337 1794 +1115 2 2 12 9 974 2118 2012 +1116 2 2 12 9 832 1321 2390 +1117 2 2 12 9 874 2569 1347 +1118 2 2 12 9 819 3457 1259 +1119 2 2 12 9 3460 958 1285 +1120 2 2 12 9 398 1751 1760 +1121 2 2 12 9 536 2020 1304 +1122 2 2 12 9 915 1694 1921 +1123 2 2 12 9 593 1407 2486 +1124 2 2 12 9 594 2487 1408 +1125 2 2 12 9 759 2620 1247 +1126 2 2 12 9 1172 2949 1651 +1127 2 2 12 9 918 1945 1895 +1128 2 2 12 9 560 2563 1518 +1129 2 2 12 9 919 1896 1946 +1130 2 2 12 9 375 1781 1545 +1131 2 2 12 9 542 2027 1374 +1132 2 2 12 9 1169 2705 1631 +1133 2 2 12 9 732 3453 1372 +1134 2 2 12 9 364 3166 1400 +1135 2 2 12 9 685 1859 1631 +1136 2 2 12 9 873 1255 2505 +1137 2 2 12 9 726 1380 1713 +1138 2 2 12 9 8 9 1464 +1139 2 2 12 9 1183 2828 3055 +1140 2 2 12 9 791 2112 2807 +1141 2 2 12 9 470 2505 1255 +1142 2 2 12 9 592 3633 1449 +1143 2 2 12 9 844 1963 2621 +1144 2 2 12 9 1784 3405 2896 +1145 2 2 12 9 770 1884 1345 +1146 2 2 12 9 1165 3353 1568 +1147 2 2 12 9 722 1618 1653 +1148 2 2 12 9 771 1346 1885 +1149 2 2 12 9 799 2467 2038 +1150 2 2 12 9 957 1805 2053 +1151 2 2 12 9 430 1480 1706 +1152 2 2 12 9 527 2508 2033 +1153 2 2 12 9 528 2034 2509 +1154 2 2 12 9 814 1348 3040 +1155 2 2 12 9 454 1367 1824 +1156 2 2 12 9 455 1825 1368 +1157 2 2 12 9 449 1826 1371 +1158 2 2 12 9 576 2269 1237 +1159 2 2 12 9 483 2915 1909 +1160 2 2 12 9 980 2934 2527 +1161 2 2 12 9 231 232 1500 +1162 2 2 12 9 645 1375 1771 +1163 2 2 12 9 2330 727 3197 +1164 2 2 12 9 3198 728 2331 +1165 2 2 12 9 674 1243 3631 +1166 2 2 12 9 692 1611 2227 +1167 2 2 12 9 699 1784 2896 +1168 2 2 12 9 1276 1932 2531 +1169 2 2 12 9 703 1738 2953 +1170 2 2 12 9 847 1857 1565 +1171 2 2 12 9 848 1566 1858 +1172 2 2 12 9 1462 1714 2406 +1173 2 2 12 9 434 3287 1625 +1174 2 2 12 9 435 1626 3288 +1175 2 2 12 9 1435 3565 2600 +1176 2 2 12 9 1436 2601 3566 +1177 2 2 12 9 810 1390 2291 +1178 2 2 12 9 1570 3415 3333 +1179 2 2 12 9 834 1723 1669 +1180 2 2 12 9 739 1502 3608 +1181 2 2 12 9 740 3609 1503 +1182 2 2 12 9 813 1848 1614 +1183 2 2 12 9 3277 777 1954 +1184 2 2 12 9 696 1433 1712 +1185 2 2 12 9 475 3121 1861 +1186 2 2 12 9 476 1862 3122 +1187 2 2 12 9 700 2171 1590 +1188 2 2 12 9 3274 1952 776 +1189 2 2 12 9 842 1470 2109 +1190 2 2 12 9 692 2227 1678 +1191 2 2 12 9 1138 2087 3235 +1192 2 2 12 9 196 197 1580 +1193 2 2 12 9 958 2726 1285 +1194 2 2 12 9 258 1868 1322 +1195 2 2 12 9 318 1323 1869 +1196 2 2 12 9 1373 1992 2841 +1197 2 2 12 9 874 1347 2394 +1198 2 2 12 9 431 1487 3230 +1199 2 2 12 9 534 1452 1686 +1200 2 2 12 9 917 2769 1467 +1201 2 2 12 9 747 1848 1769 +1202 2 2 12 9 901 1873 1541 +1203 2 2 12 9 902 1542 1874 +1204 2 2 12 9 1051 1484 1791 +1205 2 2 12 9 794 2053 1805 +1206 2 2 12 9 744 1565 1615 +1207 2 2 12 9 745 1616 1566 +1208 2 2 12 9 746 1810 2602 +1209 2 2 12 9 741 2008 1231 +1210 2 2 12 9 1395 3289 3521 +1211 2 2 12 9 945 2681 1423 +1212 2 2 12 9 1116 2659 1554 +1213 2 2 12 9 819 1259 3648 +1214 2 2 12 9 729 1826 1316 +1215 2 2 12 9 622 1478 2370 +1216 2 2 12 9 748 1351 2846 +1217 2 2 12 9 755 1252 2343 +1218 2 2 12 9 1810 3253 463 +1219 2 2 12 9 773 1864 1496 +1220 2 2 12 9 350 2390 1321 +1221 2 2 12 9 481 2325 2629 +1222 2 2 12 9 482 2630 2326 +1223 2 2 12 9 549 3191 1524 +1224 2 2 12 9 694 1956 1764 +1225 2 2 12 9 45 46 1465 +1226 2 2 12 9 175 176 1466 +1227 2 2 12 9 557 1251 3030 +1228 2 2 12 9 792 2125 2735 +1229 2 2 12 9 645 3507 1990 +1230 2 2 12 9 473 2844 1298 +1231 2 2 12 9 797 2836 1524 +1232 2 2 12 9 536 1304 2077 +1233 2 2 12 9 1184 3001 1999 +1234 2 2 12 9 386 1644 1969 +1235 2 2 12 9 1041 2080 1933 +1236 2 2 12 9 923 2600 3565 +1237 2 2 12 9 924 3566 2601 +1238 2 2 12 9 485 1770 1845 +1239 2 2 12 9 1051 2932 1484 +1240 2 2 12 9 407 2646 1999 +1241 2 2 12 9 849 1286 2456 +1242 2 2 12 9 1342 2883 1604 +1243 2 2 12 9 1410 1949 3326 +1244 2 2 12 9 1070 3362 1355 +1245 2 2 12 9 967 1329 2307 +1246 2 2 12 9 379 1535 2438 +1247 2 2 12 9 377 1828 2524 +1248 2 2 12 9 800 2018 1505 +1249 2 2 12 9 450 1932 2327 +1250 2 2 12 9 236 1736 2827 +1251 2 2 12 9 698 1852 2396 +1252 2 2 12 9 3039 1918 991 +1253 2 2 12 9 768 2557 1407 +1254 2 2 12 9 769 1408 2558 +1255 2 2 12 9 597 3521 3289 +1256 2 2 12 9 26 1423 1834 +1257 2 2 12 9 1058 1448 2226 +1258 2 2 12 9 721 1489 3242 +1259 2 2 12 9 921 1764 1956 +1260 2 2 12 9 23 1720 2694 +1261 2 2 12 9 864 2423 1485 +1262 2 2 12 9 689 1508 3309 +1263 2 2 12 9 690 3310 1509 +1264 2 2 12 9 863 2072 1614 +1265 2 2 12 9 543 1708 2440 +1266 2 2 12 9 439 3248 2061 +1267 2 2 12 9 544 2441 1709 +1268 2 2 12 9 569 1840 1305 +1269 2 2 12 9 497 2443 1759 +1270 2 2 12 9 343 1895 1945 +1271 2 2 12 9 406 1562 2370 +1272 2 2 12 9 342 1946 1896 +1273 2 2 12 9 736 1788 1732 +1274 2 2 12 9 599 1792 2957 +1275 2 2 12 9 497 2604 2443 +1276 2 2 12 9 3111 961 1578 +1277 2 2 12 9 843 1745 1747 +1278 2 2 12 9 1450 3159 2268 +1279 2 2 12 9 863 2158 2072 +1280 2 2 12 9 1370 2182 3498 +1281 2 2 12 9 956 2512 1514 +1282 2 2 12 9 381 2494 1382 +1283 2 2 12 9 713 1646 2068 +1284 2 2 12 9 839 2422 2475 +1285 2 2 12 9 546 1271 2215 +1286 2 2 12 9 547 2216 1272 +1287 2 2 12 9 399 1496 1864 +1288 2 2 12 9 654 2057 1696 +1289 2 2 12 9 655 1697 2058 +1290 2 2 12 9 852 1419 2281 +1291 2 2 12 9 853 2282 1420 +1292 2 2 12 9 702 2996 1723 +1293 2 2 12 9 956 1514 2260 +1294 2 2 12 9 735 1718 1785 +1295 2 2 12 9 1069 1596 2616 +1296 2 2 12 9 1682 3628 3187 +1297 2 2 12 9 660 1651 2949 +1298 2 2 12 9 1696 2057 2792 +1299 2 2 12 9 592 1441 1908 +1300 2 2 12 9 1697 2794 2058 +1301 2 2 12 9 389 2616 1596 +1302 2 2 12 9 233 234 2615 +1303 2 2 12 9 1049 3343 1446 +1304 2 2 12 9 796 1702 1692 +1305 2 2 12 9 1284 3013 2882 +1306 2 2 12 9 580 2772 2865 +1307 2 2 12 9 266 267 2391 +1308 2 2 12 9 309 310 2392 +1309 2 2 12 9 1014 2757 2973 +1310 2 2 12 9 1366 2363 3586 +1311 2 2 12 9 733 1550 2172 +1312 2 2 12 9 48 49 1598 +1313 2 2 12 9 172 173 1599 +1314 2 2 12 9 734 2173 1551 +1315 2 2 12 9 449 1371 1866 +1316 2 2 12 9 842 2805 2063 +1317 2 2 12 9 689 3309 1547 +1318 2 2 12 9 500 1974 1422 +1319 2 2 12 9 690 1548 3310 +1320 2 2 12 9 833 3384 1782 +1321 2 2 12 9 1216 2790 1931 +1322 2 2 12 9 269 270 1521 +1323 2 2 12 9 43 1533 1800 +1324 2 2 12 9 178 1801 1534 +1325 2 2 12 9 806 1890 1622 +1326 2 2 12 9 807 1623 1891 +1327 2 2 12 9 735 1508 1718 +1328 2 2 12 9 1517 3275 2602 +1329 2 2 12 9 1174 2524 1828 +1330 2 2 12 9 1475 2218 3438 +1331 2 2 12 9 976 2188 2518 +1332 2 2 12 9 481 2629 1802 +1333 2 2 12 9 482 1803 2630 +1334 2 2 12 9 736 1732 1509 +1335 2 2 12 9 726 1713 2071 +1336 2 2 12 9 368 2430 1395 +1337 2 2 12 9 986 1766 2082 +1338 2 2 12 9 646 3486 1398 +1339 2 2 12 9 987 2083 1767 +1340 2 2 12 9 451 1313 2434 +1341 2 2 12 9 732 1372 3264 +1342 2 2 12 9 452 2435 1314 +1343 2 2 12 9 584 2848 1311 +1344 2 2 12 9 3438 2218 656 +1345 2 2 12 9 570 2209 1275 +1346 2 2 12 9 709 3382 2715 +1347 2 2 12 9 915 1921 2417 +1348 2 2 12 9 702 1691 2757 +1349 2 2 12 9 1222 1619 3347 +1350 2 2 12 9 1205 1682 3187 +1351 2 2 12 9 43 44 1533 +1352 2 2 12 9 177 178 1534 +1353 2 2 12 9 453 2205 1251 +1354 2 2 12 9 1171 1739 2606 +1355 2 2 12 9 447 2073 1356 +1356 2 2 12 9 600 1886 1442 +1357 2 2 12 9 3560 2225 1006 +1358 2 2 12 9 392 1829 1419 +1359 2 2 12 9 393 1420 1830 +1360 2 2 12 9 1011 1452 2908 +1361 2 2 12 9 698 1689 2079 +1362 2 2 12 9 1334 3136 3581 +1363 2 2 12 9 653 1514 2512 +1364 2 2 12 9 845 1760 1751 +1365 2 2 12 9 797 2504 2836 +1366 2 2 12 9 845 1842 1760 +1367 2 2 12 9 1007 2880 1327 +1368 2 2 12 9 1406 2061 3248 +1369 2 2 12 9 750 2221 1829 +1370 2 2 12 9 751 1830 2222 +1371 2 2 12 9 1246 2865 2772 +1372 2 2 12 9 1138 1454 3159 +1373 2 2 12 9 583 2233 1317 +1374 2 2 12 9 767 1811 1960 +1375 2 2 12 9 509 2428 1712 +1376 2 2 12 9 522 2536 2348 +1377 2 2 12 9 721 3242 3112 +1378 2 2 12 9 746 2602 2658 +1379 2 2 12 9 1010 1876 2799 +1380 2 2 12 9 895 1359 2460 +1381 2 2 12 9 768 1407 2375 +1382 2 2 12 9 769 2376 1408 +1383 2 2 12 9 1024 1518 2563 +1384 2 2 12 9 496 1532 2380 +1385 2 2 12 9 598 1837 1379 +1386 2 2 12 9 795 1374 2027 +1387 2 2 12 9 458 1718 1508 +1388 2 2 12 9 1240 2896 2258 +1389 2 2 12 9 1186 2913 1638 +1390 2 2 12 9 590 2931 2768 +1391 2 2 12 9 1059 1506 2959 +1392 2 2 12 9 622 2370 1562 +1393 2 2 12 9 448 1764 1992 +1394 2 2 12 9 565 3055 2828 +1395 2 2 12 9 716 1860 1456 +1396 2 2 12 9 402 2527 1687 +1397 2 2 12 9 746 2098 1259 +1398 2 2 12 9 541 1926 2633 +1399 2 2 12 9 921 1992 1764 +1400 2 2 12 9 859 1894 1328 +1401 2 2 12 9 1715 2962 2730 +1402 2 2 12 9 469 1669 1723 +1403 2 2 12 9 459 1509 1732 +1404 2 2 12 9 933 1256 2463 +1405 2 2 12 9 680 2178 1612 +1406 2 2 12 9 1765 3367 2513 +1407 2 2 12 9 686 2307 1569 +1408 2 2 12 9 782 2147 1887 +1409 2 2 12 9 779 1356 2073 +1410 2 2 12 9 1501 1990 3507 +1411 2 2 12 9 1577 1684 3264 +1412 2 2 12 9 697 2279 1250 +1413 2 2 12 9 1209 3230 1487 +1414 2 2 12 9 694 1312 3204 +1415 2 2 12 9 1294 3539 2339 +1416 2 2 12 9 612 1423 2681 +1417 2 2 12 9 425 3469 2747 +1418 2 2 12 9 349 2005 1378 +1419 2 2 12 9 971 1429 2787 +1420 2 2 12 9 1447 3053 1881 +1421 2 2 12 9 610 1481 3258 +1422 2 2 12 9 611 3259 1482 +1423 2 2 12 9 210 2065 1398 +1424 2 2 12 9 1056 1419 1829 +1425 2 2 12 9 1214 1524 3191 +1426 2 2 12 9 1057 1830 1420 +1427 2 2 12 9 642 3362 2254 +1428 2 2 12 9 1491 2225 3560 +1429 2 2 12 9 533 2360 2208 +1430 2 2 12 9 725 1760 1842 +1431 2 2 12 9 889 1430 2191 +1432 2 2 12 9 749 1910 2954 +1433 2 2 12 9 712 1755 2535 +1434 2 2 12 9 306 307 1703 +1435 2 2 12 9 413 1375 3027 +1436 2 2 12 9 301 302 2381 +1437 2 2 12 9 339 3013 1589 +1438 2 2 12 9 1112 2735 2125 +1439 2 2 12 9 860 2377 1415 +1440 2 2 12 9 861 1416 2378 +1441 2 2 12 9 580 1366 2772 +1442 2 2 12 9 732 1488 3453 +1443 2 2 12 9 763 1653 1618 +1444 2 2 12 9 1088 2440 1708 +1445 2 2 12 9 1174 2421 3272 +1446 2 2 12 9 1089 1709 2441 +1447 2 2 12 9 1010 2244 1919 +1448 2 2 12 9 904 1904 1888 +1449 2 2 12 9 905 1889 1905 +1450 2 2 12 9 1454 1918 3039 +1451 2 2 12 9 522 1833 2536 +1452 2 2 12 9 1278 2517 2091 +1453 2 2 12 9 768 1287 2557 +1454 2 2 12 9 769 2558 1288 +1455 2 2 12 9 1257 3470 2714 +1456 2 2 12 9 1365 3235 2087 +1457 2 2 12 9 770 1796 1819 +1458 2 2 12 9 1185 1689 2963 +1459 2 2 12 9 771 1820 1797 +1460 2 2 12 9 713 2068 2966 +1461 2 2 12 9 375 1545 1894 +1462 2 2 12 9 657 1467 1730 +1463 2 2 12 9 642 1293 2183 +1464 2 2 12 9 929 2801 1851 +1465 2 2 12 9 440 3255 1539 +1466 2 2 12 9 2115 777 3277 +1467 2 2 12 9 729 1316 2549 +1468 2 2 12 9 2114 3274 776 +1469 2 2 12 9 756 1888 1904 +1470 2 2 12 9 425 2773 2315 +1471 2 2 12 9 757 1905 1889 +1472 2 2 12 9 212 213 1643 +1473 2 2 12 9 3265 674 1995 +1474 2 2 12 9 1006 2187 2264 +1475 2 2 12 9 765 1352 3536 +1476 2 2 12 9 1113 2902 2970 +1477 2 2 12 9 749 2851 1910 +1478 2 2 12 9 196 1580 3299 +1479 2 2 12 9 669 1276 3434 +1480 2 2 12 9 869 1752 1912 +1481 2 2 12 9 1070 1355 3027 +1482 2 2 12 9 695 1381 2429 +1483 2 2 12 9 1088 2929 2094 +1484 2 2 12 9 1089 2095 2930 +1485 2 2 12 9 791 2807 1962 +1486 2 2 12 9 1042 1913 2863 +1487 2 2 12 9 1371 1826 2175 +1488 2 2 12 9 599 2402 1790 +1489 2 2 12 9 1943 3332 763 +1490 2 2 12 9 860 1415 2304 +1491 2 2 12 9 861 2305 1416 +1492 2 2 12 9 790 2822 1286 +1493 2 2 12 9 650 3319 2025 +1494 2 2 12 9 651 2026 3320 +1495 2 2 12 9 1166 2824 2065 +1496 2 2 12 9 545 1570 3333 +1497 2 2 12 9 1248 3118 2745 +1498 2 2 12 9 1249 2746 3119 +1499 2 2 12 9 257 1322 2242 +1500 2 2 12 9 319 2243 1323 +1501 2 2 12 9 425 1677 3469 +1502 2 2 12 9 760 2137 1574 +1503 2 2 12 9 761 1575 2138 +1504 2 2 12 9 1808 2422 3110 +1505 2 2 12 9 1113 2970 2141 +1506 2 2 12 9 3554 531 2463 +1507 2 2 12 9 451 1997 2720 +1508 2 2 12 9 452 2721 2000 +1509 2 2 12 9 852 2325 1343 +1510 2 2 12 9 853 1344 2326 +1511 2 2 12 9 609 1454 3235 +1512 2 2 12 9 1011 2135 1452 +1513 2 2 12 9 1007 1650 3540 +1514 2 2 12 9 1167 3258 1481 +1515 2 2 12 9 1168 1482 3259 +1516 2 2 12 9 437 2963 1689 +1517 2 2 12 9 343 1345 2818 +1518 2 2 12 9 342 2819 1346 +1519 2 2 12 9 601 1301 2146 +1520 2 2 12 9 602 2148 1302 +1521 2 2 12 9 484 2978 2386 +1522 2 2 12 9 642 2108 1293 +1523 2 2 12 9 344 2801 1443 +1524 2 2 12 9 188 189 1646 +1525 2 2 12 9 2682 2071 903 +1526 2 2 12 9 1088 2581 2929 +1527 2 2 12 9 1089 2930 2582 +1528 2 2 12 9 856 1296 2391 +1529 2 2 12 9 580 1339 2363 +1530 2 2 12 9 366 1927 1445 +1531 2 2 12 9 857 2392 1297 +1532 2 2 12 9 624 2304 1415 +1533 2 2 12 9 625 1416 2305 +1534 2 2 12 9 1194 2074 3141 +1535 2 2 12 9 930 1335 2532 +1536 2 2 12 9 940 2380 1532 +1537 2 2 12 9 636 1880 1347 +1538 2 2 12 9 381 1382 2340 +1539 2 2 12 9 1723 2996 2165 +1540 2 2 12 9 933 3347 1619 +1541 2 2 12 9 862 3503 1290 +1542 2 2 12 9 1332 2071 2682 +1543 2 2 12 9 1138 3235 1454 +1544 2 2 12 9 748 2236 1804 +1545 2 2 12 9 302 1963 2381 +1546 2 2 12 9 308 309 1998 +1547 2 2 12 9 590 2787 1429 +1548 2 2 12 9 907 1878 2430 +1549 2 2 12 9 451 1716 1547 +1550 2 2 12 9 900 1559 2292 +1551 2 2 12 9 1115 1992 1373 +1552 2 2 12 9 794 1733 2105 +1553 2 2 12 9 452 1548 1717 +1554 2 2 12 9 2896 3207 2258 +1555 2 2 12 9 649 2813 1996 +1556 2 2 12 9 511 2090 2749 +1557 2 2 12 9 1050 2396 1852 +1558 2 2 12 9 1055 1887 2147 +1559 2 2 12 9 464 2221 1362 +1560 2 2 12 9 440 2397 2113 +1561 2 2 12 9 1552 2507 1880 +1562 2 2 12 9 465 1363 2222 +1563 2 2 12 9 1095 1940 2390 +1564 2 2 12 9 2025 475 2981 +1565 2 2 12 9 2026 2982 476 +1566 2 2 12 9 827 1370 1982 +1567 2 2 12 9 858 1742 2100 +1568 2 2 12 9 1437 2025 2981 +1569 2 2 12 9 1438 2982 2026 +1570 2 2 12 9 883 2534 1431 +1571 2 2 12 9 350 1321 2163 +1572 2 2 12 9 635 1430 3105 +1573 2 2 12 9 669 2437 1276 +1574 2 2 12 9 423 2576 3381 +1575 2 2 12 9 2882 834 1284 +1576 2 2 12 9 808 2082 1766 +1577 2 2 12 9 809 1767 2083 +1578 2 2 12 9 494 1622 1890 +1579 2 2 12 9 495 1891 1623 +1580 2 2 12 9 1395 2430 3289 +1581 2 2 12 9 1159 2981 1861 +1582 2 2 12 9 1160 1862 2982 +1583 2 2 12 9 232 1972 1500 +1584 2 2 12 9 646 1517 3486 +1585 2 2 12 9 1156 1580 2286 +1586 2 2 12 9 1097 2021 1591 +1587 2 2 12 9 665 1715 1532 +1588 2 2 12 9 1028 1865 2401 +1589 2 2 12 9 695 1349 1916 +1590 2 2 12 9 206 1351 3068 +1591 2 2 12 9 467 1877 2303 +1592 2 2 12 9 1244 3124 1835 +1593 2 2 12 9 534 2908 1452 +1594 2 2 12 9 1029 2081 2037 +1595 2 2 12 9 1590 2171 3048 +1596 2 2 12 9 3563 443 2099 +1597 2 2 12 9 574 1775 2868 +1598 2 2 12 9 575 2869 1776 +1599 2 2 12 9 1079 1790 2402 +1600 2 2 12 9 350 3409 1685 +1601 2 2 12 9 762 1908 3575 +1602 2 2 12 9 1266 2103 3335 +1603 2 2 12 9 1267 3336 2104 +1604 2 2 12 9 1056 1829 2221 +1605 2 2 12 9 288 1360 2237 +1606 2 2 12 9 1057 2222 1830 +1607 2 2 12 9 1413 1736 3303 +1608 2 2 12 9 380 2229 1331 +1609 2 2 12 9 289 2248 1360 +1610 2 2 12 9 1581 3265 1995 +1611 2 2 12 9 563 1912 1752 +1612 2 2 12 9 543 1582 1708 +1613 2 2 12 9 544 1709 1583 +1614 2 2 12 9 352 2410 1498 +1615 2 2 12 9 351 1499 2411 +1616 2 2 12 9 1248 3317 1679 +1617 2 2 12 9 1249 1680 3318 +1618 2 2 12 9 1728 3554 2463 +1619 2 2 12 9 236 237 1736 +1620 2 2 12 9 554 2091 2517 +1621 2 2 12 9 799 1732 1788 +1622 2 2 12 9 464 2288 2221 +1623 2 2 12 9 465 2222 2289 +1624 2 2 12 9 1064 2020 2749 +1625 2 2 12 9 2003 3604 811 +1626 2 2 12 9 855 1450 2268 +1627 2 2 12 9 595 2292 1559 +1628 2 2 12 9 838 1356 2823 +1629 2 2 12 9 1429 1959 3263 +1630 2 2 12 9 868 3289 2430 +1631 2 2 12 9 2056 2935 3254 +1632 2 2 12 9 1097 2303 1877 +1633 2 2 12 9 797 1785 1718 +1634 2 2 12 9 741 1352 2623 +1635 2 2 12 9 715 1915 1589 +1636 2 2 12 9 267 268 1917 +1637 2 2 12 9 364 1907 2334 +1638 2 2 12 9 419 1359 2135 +1639 2 2 12 9 1217 2868 1775 +1640 2 2 12 9 1218 1776 2869 +1641 2 2 12 9 578 1679 3317 +1642 2 2 12 9 579 3318 1680 +1643 2 2 12 9 595 1399 2292 +1644 2 2 12 9 412 1476 1957 +1645 2 2 12 9 462 1526 1807 +1646 2 2 12 9 818 1591 2021 +1647 2 2 12 9 1441 3575 1908 +1648 2 2 12 9 660 2998 1651 +1649 2 2 12 9 253 254 1587 +1650 2 2 12 9 322 323 1588 +1651 2 2 12 9 747 1772 1848 +1652 2 2 12 9 1293 2108 3538 +1653 2 2 12 9 505 1579 2723 +1654 2 2 12 9 686 1791 1484 +1655 2 2 12 9 17 18 1651 +1656 2 2 12 9 1050 2827 1736 +1657 2 2 12 9 3287 687 2195 +1658 2 2 12 9 3288 2196 688 +1659 2 2 12 9 354 1330 2413 +1660 2 2 12 9 49 2763 1598 +1661 2 2 12 9 172 1599 2764 +1662 2 2 12 9 971 2904 1429 +1663 2 2 12 9 1007 3540 2880 +1664 2 2 12 9 768 2797 1287 +1665 2 2 12 9 769 1288 2798 +1666 2 2 12 9 967 2307 1707 +1667 2 2 12 9 803 2772 2403 +1668 2 2 12 9 618 1307 2662 +1669 2 2 12 9 1435 2600 3610 +1670 2 2 12 9 1436 3611 2601 +1671 2 2 12 9 229 1311 2019 +1672 2 2 12 9 212 1643 3314 +1673 2 2 12 9 844 2218 1475 +1674 2 2 12 9 746 1445 1810 +1675 2 2 12 9 467 1361 2561 +1676 2 2 12 9 1012 2621 1963 +1677 2 2 12 9 881 1686 2257 +1678 2 2 12 9 759 3032 3313 +1679 2 2 12 9 364 2133 1303 +1680 2 2 12 9 653 1456 1860 +1681 2 2 12 9 635 1298 2191 +1682 2 2 12 9 445 1937 2147 +1683 2 2 12 9 814 2493 1348 +1684 2 2 12 9 1375 3175 1771 +1685 2 2 12 9 1070 3027 1375 +1686 2 2 12 9 601 2547 1301 +1687 2 2 12 9 693 1870 1394 +1688 2 2 12 9 602 1302 2548 +1689 2 2 12 9 484 1911 2978 +1690 2 2 12 9 1017 2908 2235 +1691 2 2 12 9 505 1835 2562 +1692 2 2 12 9 750 1708 1582 +1693 2 2 12 9 751 1583 1709 +1694 2 2 12 9 349 1378 2812 +1695 2 2 12 9 398 1431 2534 +1696 2 2 12 9 680 3127 1280 +1697 2 2 12 9 2035 3411 2572 +1698 2 2 12 9 394 2687 1727 +1699 2 2 12 9 755 2343 1341 +1700 2 2 12 9 854 2517 1278 +1701 2 2 12 9 608 1417 3168 +1702 2 2 12 9 1571 3563 2099 +1703 2 2 12 9 703 1506 1789 +1704 2 2 12 9 1467 2769 1730 +1705 2 2 12 9 618 3615 2899 +1706 2 2 12 9 1537 2815 3642 +1707 2 2 12 9 975 2358 1765 +1708 2 2 12 9 780 2039 3009 +1709 2 2 12 9 906 1442 1886 +1710 2 2 12 9 1625 3287 2195 +1711 2 2 12 9 1626 2196 3288 +1712 2 2 12 9 635 2191 1430 +1713 2 2 12 9 858 2419 1393 +1714 2 2 12 9 733 2172 1798 +1715 2 2 12 9 734 1799 2173 +1716 2 2 12 9 1546 3332 1943 +1717 2 2 12 9 558 1326 2918 +1718 2 2 12 9 767 1777 1774 +1719 2 2 12 9 529 3004 1639 +1720 2 2 12 9 825 1409 1961 +1721 2 2 12 9 627 2529 1989 +1722 2 2 12 9 952 1505 2603 +1723 2 2 12 9 1245 2080 3183 +1724 2 2 12 9 778 2037 2081 +1725 2 2 12 9 750 2447 1362 +1726 2 2 12 9 751 1363 2448 +1727 2 2 12 9 720 3232 1779 +1728 2 2 12 9 414 2968 2407 +1729 2 2 12 9 457 2342 2466 +1730 2 2 12 9 471 1692 2484 +1731 2 2 12 9 471 2484 1664 +1732 2 2 12 9 379 1811 1567 +1733 2 2 12 9 789 1783 2009 +1734 2 2 12 9 1051 2105 1733 +1735 2 2 12 9 906 2636 1442 +1736 2 2 12 9 569 1505 2528 +1737 2 2 12 9 834 2426 1284 +1738 2 2 12 9 686 1707 2307 +1739 2 2 12 9 1023 2357 1998 +1740 2 2 12 9 869 1530 1752 +1741 2 2 12 9 676 1576 2415 +1742 2 2 12 9 717 1445 1927 +1743 2 2 12 9 1310 1556 2470 +1744 2 2 12 9 1277 2113 2397 +1745 2 2 12 9 510 2085 1608 +1746 2 2 12 9 508 1381 2349 +1747 2 2 12 9 589 2036 1338 +1748 2 2 12 9 810 2291 3222 +1749 2 2 12 9 406 2370 2912 +1750 2 2 12 9 306 1703 3512 +1751 2 2 12 9 1095 2390 3395 +1752 2 2 12 9 492 3498 2182 +1753 2 2 12 9 1426 2734 3396 +1754 2 2 12 9 489 2217 1899 +1755 2 2 12 9 886 2402 1627 +1756 2 2 12 9 191 1432 3075 +1757 2 2 12 9 1054 2723 1579 +1758 2 2 12 9 1414 2387 3624 +1759 2 2 12 9 1384 2618 2355 +1760 2 2 12 9 1385 2356 2619 +1761 2 2 12 9 922 1403 2724 +1762 2 2 12 9 1355 3362 2183 +1763 2 2 12 9 1340 2813 3547 +1764 2 2 12 9 767 1772 1567 +1765 2 2 12 9 715 1673 1915 +1766 2 2 12 9 1535 3194 2438 +1767 2 2 12 9 870 1371 2270 +1768 2 2 12 9 473 1471 2300 +1769 2 2 12 9 762 1765 2791 +1770 2 2 12 9 407 1919 2244 +1771 2 2 12 9 461 1393 2419 +1772 2 2 12 9 3263 1959 436 +1773 2 2 12 9 766 1965 2968 +1774 2 2 12 9 1009 1827 2372 +1775 2 2 12 9 776 3297 1303 +1776 2 2 12 9 792 1336 2125 +1777 2 2 12 9 1148 3075 1432 +1778 2 2 12 9 746 2955 1445 +1779 2 2 12 9 498 1966 2367 +1780 2 2 12 9 719 1835 3124 +1781 2 2 12 9 574 3548 1775 +1782 2 2 12 9 575 1776 3549 +1783 2 2 12 9 574 2832 3548 +1784 2 2 12 9 575 3549 2834 +1785 2 2 12 9 1268 3306 2580 +1786 2 2 12 9 383 2490 1317 +1787 2 2 12 9 635 2492 1298 +1788 2 2 12 9 776 1303 2133 +1789 2 2 12 9 1011 2290 2135 +1790 2 2 12 9 864 2251 2423 +1791 2 2 12 9 907 2430 2753 +1792 2 2 12 9 1167 1481 2364 +1793 2 2 12 9 1168 2365 1482 +1794 2 2 12 9 1059 1737 2174 +1795 2 2 12 9 1143 2010 2339 +1796 2 2 12 9 869 2495 1433 +1797 2 2 12 9 567 2339 2010 +1798 2 2 12 9 1165 1914 3304 +1799 2 2 12 9 889 1783 2354 +1800 2 2 12 9 1156 3299 1580 +1801 2 2 12 9 1641 3626 2042 +1802 2 2 12 9 638 2846 1351 +1803 2 2 12 9 804 1774 1777 +1804 2 2 12 9 529 2359 3004 +1805 2 2 12 9 632 2035 2572 +1806 2 2 12 9 715 1422 1974 +1807 2 2 12 9 1033 2336 1980 +1808 2 2 12 9 193 1831 2579 +1809 2 2 12 9 1034 1981 2337 +1810 2 2 12 9 188 1646 3069 +1811 2 2 12 9 872 2340 1382 +1812 2 2 12 9 508 2429 1381 +1813 2 2 12 9 1040 3057 2524 +1814 2 2 12 9 1366 2403 2772 +1815 2 2 12 9 1244 2723 1572 +1816 2 2 12 9 186 187 1632 +1817 2 2 12 9 406 2144 1562 +1818 2 2 12 9 1146 2835 3094 +1819 2 2 12 9 1064 2090 1417 +1820 2 2 12 9 811 3604 1813 +1821 2 2 12 9 796 1960 1811 +1822 2 2 12 9 744 1800 1533 +1823 2 2 12 9 745 1534 1801 +1824 2 2 12 9 2734 499 3396 +1825 2 2 12 9 380 1331 2427 +1826 2 2 12 9 583 1317 3321 +1827 2 2 12 9 812 2174 1737 +1828 2 2 12 9 511 2372 1827 +1829 2 2 12 9 206 2306 1351 +1830 2 2 12 9 875 2470 1507 +1831 2 2 12 9 355 1600 1892 +1832 2 2 12 9 356 1893 1601 +1833 2 2 12 9 775 2972 1410 +1834 2 2 12 9 1058 2226 2871 +1835 2 2 12 9 3626 565 2042 +1836 2 2 12 9 888 2597 1490 +1837 2 2 12 9 1014 1513 2184 +1838 2 2 12 9 1040 2524 1823 +1839 2 2 12 9 717 2439 1531 +1840 2 2 12 9 730 1975 2938 +1841 2 2 12 9 731 2939 1976 +1842 2 2 12 9 569 1305 2371 +1843 2 2 12 9 474 1614 1848 +1844 2 2 12 9 1055 2147 1937 +1845 2 2 12 9 1042 3145 1913 +1846 2 2 12 9 1779 3232 2225 +1847 2 2 12 9 395 3011 1747 +1848 2 2 12 9 34 35 1672 +1849 2 2 12 9 612 2681 1327 +1850 2 2 12 9 1337 2756 3511 +1851 2 2 12 9 3059 873 1341 +1852 2 2 12 9 671 2003 1540 +1853 2 2 12 9 1716 2720 1980 +1854 2 2 12 9 1717 1981 2721 +1855 2 2 12 9 849 2466 1396 +1856 2 2 12 9 278 279 1635 +1857 2 2 12 9 375 2496 1781 +1858 2 2 12 9 39 2126 1384 +1859 2 2 12 9 182 1385 2127 +1860 2 2 12 9 1355 1572 2571 +1861 2 2 12 9 519 3081 2273 +1862 2 2 12 9 520 2274 3082 +1863 2 2 12 9 394 2879 3146 +1864 2 2 12 9 359 1448 3024 +1865 2 2 12 9 767 1567 1811 +1866 2 2 12 9 795 2036 1404 +1867 2 2 12 9 1080 3436 1768 +1868 2 2 12 9 1173 2870 2108 +1869 2 2 12 9 1260 2938 1975 +1870 2 2 12 9 415 1337 2145 +1871 2 2 12 9 1261 1976 2939 +1872 2 2 12 9 576 3363 2045 +1873 2 2 12 9 1176 2179 3131 +1874 2 2 12 9 454 2330 1367 +1875 2 2 12 9 455 1368 2331 +1876 2 2 12 9 499 1765 2358 +1877 2 2 12 9 1387 3446 3149 +1878 2 2 12 9 1388 3150 3447 +1879 2 2 12 9 223 1390 3236 +1880 2 2 12 9 953 2129 1854 +1881 2 2 12 9 954 1855 2130 +1882 2 2 12 9 697 2575 3474 +1883 2 2 12 9 685 1949 1410 +1884 2 2 12 9 628 1315 2423 +1885 2 2 12 9 1009 2045 1431 +1886 2 2 12 9 1045 2101 2161 +1887 2 2 12 9 1046 2162 2102 +1888 2 2 12 9 1514 3070 2260 +1889 2 2 12 9 365 1333 2809 +1890 2 2 12 9 2340 2042 3425 +1891 2 2 12 9 859 1328 2444 +1892 2 2 12 9 1079 1535 2550 +1893 2 2 12 9 453 2807 2205 +1894 2 2 12 9 38 1384 2355 +1895 2 2 12 9 183 2356 1385 +1896 2 2 12 9 748 1853 3068 +1897 2 2 12 9 27 2599 1423 +1898 2 2 12 9 779 2106 1356 +1899 2 2 12 9 474 1774 2029 +1900 2 2 12 9 1686 3291 2257 +1901 2 2 12 9 1299 2096 3036 +1902 2 2 12 9 1300 3037 2097 +1903 2 2 12 9 692 2670 1611 +1904 2 2 12 9 823 1854 2129 +1905 2 2 12 9 824 2130 1855 +1906 2 2 12 9 369 2016 1528 +1907 2 2 12 9 370 1529 2017 +1908 2 2 12 9 1446 3343 1993 +1909 2 2 12 9 1020 3642 2815 +1910 2 2 12 9 643 1643 3125 +1911 2 2 12 9 1342 2888 2144 +1912 2 2 12 9 945 1423 2599 +1913 2 2 12 9 18 3354 1651 +1914 2 2 12 9 563 1836 1650 +1915 2 2 12 9 1196 3125 1643 +1916 2 2 12 9 811 1540 2003 +1917 2 2 12 9 778 3307 3593 +1918 2 2 12 9 509 2800 3286 +1919 2 2 12 9 952 2528 1505 +1920 2 2 12 9 494 2223 1622 +1921 2 2 12 9 349 1442 2636 +1922 2 2 12 9 1130 2001 2718 +1923 2 2 12 9 495 1623 2224 +1924 2 2 12 9 895 2716 1359 +1925 2 2 12 9 1431 2045 3363 +1926 2 2 12 9 1131 2719 2002 +1927 2 2 12 9 2042 1108 3425 +1928 2 2 12 9 215 2847 2956 +1929 2 2 12 9 878 1393 2309 +1930 2 2 12 9 619 2472 1421 +1931 2 2 12 9 1001 2360 1688 +1932 2 2 12 9 885 1421 1953 +1933 2 2 12 9 874 1608 2085 +1934 2 2 12 9 941 2593 3247 +1935 2 2 12 9 623 1342 2631 +1936 2 2 12 9 593 2486 1357 +1937 2 2 12 9 594 1358 2487 +1938 2 2 12 9 1084 3036 2096 +1939 2 2 12 9 1085 2097 3037 +1940 2 2 12 9 759 2067 3032 +1941 2 2 12 9 934 1403 2926 +1942 2 2 12 9 819 1557 1939 +1943 2 2 12 9 536 2401 1865 +1944 2 2 12 9 1144 3210 1417 +1945 2 2 12 9 548 1593 2709 +1946 2 2 12 9 367 3575 1441 +1947 2 2 12 9 1029 1902 3180 +1948 2 2 12 9 1328 2309 2444 +1949 2 2 12 9 448 1584 1764 +1950 2 2 12 9 772 1957 1476 +1951 2 2 12 9 742 1479 2506 +1952 2 2 12 9 869 1912 2495 +1953 2 2 12 9 606 1355 3523 +1954 2 2 12 9 570 1455 2209 +1955 2 2 12 9 658 2815 1537 +1956 2 2 12 9 468 2241 2514 +1957 2 2 12 9 389 2999 1944 +1958 2 2 12 9 589 1393 2585 +1959 2 2 12 9 461 2444 2309 +1960 2 2 12 9 767 1774 1772 +1961 2 2 12 9 468 2403 1366 +1962 2 2 12 9 1238 1612 2178 +1963 2 2 12 9 362 2647 2259 +1964 2 2 12 9 842 3412 1470 +1965 2 2 12 9 1361 2303 3184 +1966 2 2 12 9 747 2550 1535 +1967 2 2 12 9 1902 2458 3180 +1968 2 2 12 9 1340 2241 2813 +1969 2 2 12 9 1258 2177 3072 +1970 2 2 12 9 662 1814 2164 +1971 2 2 12 9 1318 3045 2040 +1972 2 2 12 9 1319 2041 3046 +1973 2 2 12 9 1022 2475 2422 +1974 2 2 12 9 893 1704 3616 +1975 2 2 12 9 493 1970 1628 +1976 2 2 12 9 881 2228 1686 +1977 2 2 12 9 804 2379 2253 +1978 2 2 12 9 1049 1446 3151 +1979 2 2 12 9 442 2471 1456 +1980 2 2 12 9 893 3616 3093 +1981 2 2 12 9 418 1379 2506 +1982 2 2 12 9 906 1886 2424 +1983 2 2 12 9 762 2791 1908 +1984 2 2 12 9 732 2617 2433 +1985 2 2 12 9 352 1472 3483 +1986 2 2 12 9 351 3484 1473 +1987 2 2 12 9 814 2631 1342 +1988 2 2 12 9 361 1715 2730 +1989 2 2 12 9 193 194 1831 +1990 2 2 12 9 947 2734 1426 +1991 2 2 12 9 889 2009 1783 +1992 2 2 12 9 934 2970 1403 +1993 2 2 12 9 810 2612 1390 +1994 2 2 12 9 232 233 1972 +1995 2 2 12 9 1142 1595 3144 +1996 2 2 12 9 864 1485 2116 +1997 2 2 12 9 494 1890 1694 +1998 2 2 12 9 495 1695 1891 +1999 2 2 12 9 851 1331 2635 +2000 2 2 12 9 1110 3146 1958 +2001 2 2 12 9 431 1531 2549 +2002 2 2 12 9 1353 3599 2498 +2003 2 2 12 9 1345 2006 3639 +2004 2 2 12 9 1346 3640 2007 +2005 2 2 12 9 852 1343 2318 +2006 2 2 12 9 853 2319 1344 +2007 2 2 12 9 1092 1727 2687 +2008 2 2 12 9 611 1482 3277 +2009 2 2 12 9 502 2839 1977 +2010 2 2 12 9 503 1978 2840 +2011 2 2 12 9 750 1362 2221 +2012 2 2 12 9 751 2222 1363 +2013 2 2 12 9 610 3274 1481 +2014 2 2 12 9 783 2006 1947 +2015 2 2 12 9 784 1948 2007 +2016 2 2 12 9 1002 2329 1652 +2017 2 2 12 9 1471 3625 2300 +2018 2 2 12 9 851 2427 1331 +2019 2 2 12 9 537 1461 2079 +2020 2 2 12 9 1001 3134 1380 +2021 2 2 12 9 402 3110 2422 +2022 2 2 12 9 1685 2537 3395 +2023 2 2 12 9 1559 3368 2699 +2024 2 2 12 9 423 3048 1369 +2025 2 2 12 9 222 1411 2230 +2026 2 2 12 9 1030 2633 1926 +2027 2 2 12 9 626 2270 1371 +2028 2 2 12 9 392 1419 2318 +2029 2 2 12 9 393 2319 1420 +2030 2 2 12 9 469 2679 2345 +2031 2 2 12 9 1742 2777 2100 +2032 2 2 12 9 1266 1892 2103 +2033 2 2 12 9 1267 2104 1893 +2034 2 2 12 9 1235 2206 2973 +2035 2 2 12 9 1166 3314 1643 +2036 2 2 12 9 617 1490 2597 +2037 2 2 12 9 1341 873 2445 +2038 2 2 12 9 882 2442 1349 +2039 2 2 12 9 877 2736 2369 +2040 2 2 12 9 525 1980 2336 +2041 2 2 12 9 526 2337 1981 +2042 2 2 12 9 1688 2360 3143 +2043 2 2 12 9 981 1899 2217 +2044 2 2 12 9 589 2436 1393 +2045 2 2 12 9 1419 3644 2281 +2046 2 2 12 9 726 2071 1674 +2047 2 2 12 9 1420 2282 3645 +2048 2 2 12 9 9 2387 1464 +2049 2 2 12 9 369 1528 2692 +2050 2 2 12 9 370 2693 1529 +2051 2 2 12 9 1117 2935 2056 +2052 2 2 12 9 530 2825 1396 +2053 2 2 12 9 439 1516 3248 +2054 2 2 12 9 1084 3149 3446 +2055 2 2 12 9 1085 3447 3150 +2056 2 2 12 9 986 1598 2763 +2057 2 2 12 9 987 2764 1599 +2058 2 2 12 9 831 1369 2171 +2059 2 2 12 9 1199 2537 1685 +2060 2 2 12 9 1123 1465 3018 +2061 2 2 12 9 1124 3019 1466 +2062 2 2 12 9 415 2481 1337 +2063 2 2 12 9 2743 614 1384 +2064 2 2 12 9 2744 1385 615 +2065 2 2 12 9 42 43 1800 +2066 2 2 12 9 178 179 1801 +2067 2 2 12 9 790 2204 1447 +2068 2 2 12 9 418 3278 1379 +2069 2 2 12 9 878 2585 1393 +2070 2 2 12 9 31 3076 1504 +2071 2 2 12 9 1090 2040 3045 +2072 2 2 12 9 1091 3046 2041 +2073 2 2 12 9 416 2136 1424 +2074 2 2 12 9 831 3010 1369 +2075 2 2 12 9 806 1550 1890 +2076 2 2 12 9 898 1731 2029 +2077 2 2 12 9 604 3183 2080 +2078 2 2 12 9 807 1891 1551 +2079 2 2 12 9 383 1507 2470 +2080 2 2 12 9 442 2778 2471 +2081 2 2 12 9 840 2161 2101 +2082 2 2 12 9 841 2102 2162 +2083 2 2 12 9 408 2219 1439 +2084 2 2 12 9 409 1440 2220 +2085 2 2 12 9 875 1507 2717 +2086 2 2 12 9 921 1956 1613 +2087 2 2 12 9 1074 1879 3283 +2088 2 2 12 9 545 1931 2790 +2089 2 2 12 9 338 2308 1410 +2090 2 2 12 9 531 2211 1458 +2091 2 2 12 9 1226 2933 3383 +2092 2 2 12 9 539 2112 3389 +2093 2 2 12 9 461 2309 1393 +2094 2 2 12 9 609 2608 1556 +2095 2 2 12 9 589 1404 2036 +2096 2 2 12 9 2699 3368 347 +2097 2 2 12 9 837 2408 1944 +2098 2 2 12 9 659 1527 3473 +2099 2 2 12 9 1058 3024 1448 +2100 2 2 12 9 1823 2524 3272 +2101 2 2 12 9 811 1813 1836 +2102 2 2 12 9 775 1410 2308 +2103 2 2 12 9 1337 3514 2756 +2104 2 2 12 9 1118 3103 2077 +2105 2 2 12 9 1768 3436 2668 +2106 2 2 12 9 957 2053 1849 +2107 2 2 12 9 1745 3432 3532 +2108 2 2 12 9 767 1960 1777 +2109 2 2 12 9 653 3537 1514 +2110 2 2 12 9 1347 2569 1746 +2111 2 2 12 9 403 2023 3212 +2112 2 2 12 9 404 3213 2024 +2113 2 2 12 9 1159 3524 2016 +2114 2 2 12 9 1160 2017 3525 +2115 2 2 12 9 833 2284 1522 +2116 2 2 12 9 710 3413 1598 +2117 2 2 12 9 711 1599 3414 +2118 2 2 12 9 663 3565 1435 +2119 2 2 12 9 664 1436 3566 +2120 2 2 12 9 439 3138 1653 +2121 2 2 12 9 663 2758 1654 +2122 2 2 12 9 664 1655 2759 +2123 2 2 12 9 796 1692 1960 +2124 2 2 12 9 859 2264 2187 +2125 2 2 12 9 936 2845 1397 +2126 2 2 12 9 765 3536 1652 +2127 2 2 12 9 785 1541 1873 +2128 2 2 12 9 786 1874 1542 +2129 2 2 12 9 823 1391 2275 +2130 2 2 12 9 824 2276 1392 +2131 2 2 12 9 1076 3069 1646 +2132 2 2 12 9 1053 1611 2670 +2133 2 2 12 9 481 1609 1873 +2134 2 2 12 9 482 1874 1610 +2135 2 2 12 9 754 1458 3387 +2136 2 2 12 9 567 3071 2793 +2137 2 2 12 9 1729 2881 2950 +2138 2 2 12 9 1343 2325 1585 +2139 2 2 12 9 1344 1586 2326 +2140 2 2 12 9 369 2718 1636 +2141 2 2 12 9 370 1637 2719 +2142 2 2 12 9 446 2923 1365 +2143 2 2 12 9 1241 1838 3298 +2144 2 2 12 9 1242 3300 1839 +2145 2 2 12 9 754 2676 1458 +2146 2 2 12 9 843 1747 1970 +2147 2 2 12 9 1340 2514 2241 +2148 2 2 12 9 46 3018 1465 +2149 2 2 12 9 175 1466 3019 +2150 2 2 12 9 938 1947 2006 +2151 2 2 12 9 795 1404 2491 +2152 2 2 12 9 939 2007 1948 +2153 2 2 12 9 788 1424 2136 +2154 2 2 12 9 1751 3543 3458 +2155 2 2 12 9 814 1411 2631 +2156 2 2 12 9 1338 2345 2679 +2157 2 2 12 9 343 1945 2006 +2158 2 2 12 9 342 2007 1946 +2159 2 2 12 9 1747 3011 2530 +2160 2 2 12 9 1378 1579 3526 +2161 2 2 12 9 831 2171 1645 +2162 2 2 12 9 828 1650 1836 +2163 2 2 12 9 424 2457 2409 +2164 2 2 12 9 773 1496 2299 +2165 2 2 12 9 1119 2903 2059 +2166 2 2 12 9 1781 2496 3073 +2167 2 2 12 9 981 1917 2311 +2168 2 2 12 9 1006 1753 2187 +2169 2 2 12 9 462 2188 1526 +2170 2 2 12 9 483 2316 3089 +2171 2 2 12 9 484 3090 2317 +2172 2 2 12 9 781 1425 2595 +2173 2 2 12 9 345 3144 1595 +2174 2 2 12 9 901 2355 2618 +2175 2 2 12 9 902 2619 2356 +2176 2 2 12 9 3592 365 1405 +2177 2 2 12 9 422 2898 1433 +2178 2 2 12 9 1172 1651 3354 +2179 2 2 12 9 656 1821 2109 +2180 2 2 12 9 918 3063 1945 +2181 2 2 12 9 919 1946 3064 +2182 2 2 12 9 1299 1977 2839 +2183 2 2 12 9 1300 2840 1978 +2184 2 2 12 9 1147 3248 1516 +2185 2 2 12 9 851 2300 3625 +2186 2 2 12 9 1631 1859 2725 +2187 2 2 12 9 964 1494 2146 +2188 2 2 12 9 793 2168 3029 +2189 2 2 12 9 965 2148 1495 +2190 2 2 12 9 1430 1973 3105 +2191 2 2 12 9 502 1977 2082 +2192 2 2 12 9 503 2083 1978 +2193 2 2 12 9 675 1446 3480 +2194 2 2 12 9 1886 3252 2424 +2195 2 2 12 9 814 2230 1411 +2196 2 2 12 9 477 1557 2107 +2197 2 2 12 9 1098 2008 2623 +2198 2 2 12 9 1182 1536 3583 +2199 2 2 12 9 220 1348 2665 +2200 2 2 12 9 471 1960 1692 +2201 2 2 12 9 990 1556 2608 +2202 2 2 12 9 1080 1768 2075 +2203 2 2 12 9 719 1970 1747 +2204 2 2 12 9 3040 1348 220 +2205 2 2 12 9 619 1421 2586 +2206 2 2 12 9 1083 2457 2751 +2207 2 2 12 9 388 2250 2197 +2208 2 2 12 9 474 1848 1772 +2209 2 2 12 9 210 1398 3546 +2210 2 2 12 9 480 1872 1741 +2211 2 2 12 9 986 2082 1977 +2212 2 2 12 9 987 1978 2083 +2213 2 2 12 9 1576 3147 2415 +2214 2 2 12 9 1041 1933 2395 +2215 2 2 12 9 1100 2942 1793 +2216 2 2 12 9 1101 1794 2943 +2217 2 2 12 9 445 1543 2167 +2218 2 2 12 9 746 2658 2098 +2219 2 2 12 9 1056 2221 2288 +2220 2 2 12 9 1057 2289 2222 +2221 2 2 12 9 1041 2395 2262 +2222 2 2 12 9 359 1546 1943 +2223 2 2 12 9 903 1713 1995 +2224 2 2 12 9 817 1741 1969 +2225 2 2 12 9 1090 2449 2040 +2226 2 2 12 9 1091 2041 2450 +2227 2 2 12 9 1123 3618 1465 +2228 2 2 12 9 1124 1466 3619 +2229 2 2 12 9 1099 2338 1576 +2230 2 2 12 9 825 2154 1409 +2231 2 2 12 9 883 1431 3363 +2232 2 2 12 9 964 2692 1528 +2233 2 2 12 9 965 1529 2693 +2234 2 2 12 9 1183 1597 2828 +2235 2 2 12 9 474 1772 1774 +2236 2 2 12 9 1384 614 2618 +2237 2 2 12 9 1385 2619 615 +2238 2 2 12 9 430 2944 1480 +2239 2 2 12 9 1220 1724 3252 +2240 2 2 12 9 603 1403 2970 +2241 2 2 12 9 496 3450 1532 +2242 2 2 12 9 340 1522 2284 +2243 2 2 12 9 502 1654 2839 +2244 2 2 12 9 503 2840 1655 +2245 2 2 12 9 368 1395 2877 +2246 2 2 12 9 1022 2422 1808 +2247 2 2 12 9 1025 2483 3146 +2248 2 2 12 9 521 1618 2131 +2249 2 2 12 9 818 2229 1591 +2250 2 2 12 9 1142 3407 1595 +2251 2 2 12 9 814 3040 2230 +2252 2 2 12 9 1189 1999 2646 +2253 2 2 12 9 1107 2015 2421 +2254 2 2 12 9 726 2748 1380 +2255 2 2 12 9 713 2966 2014 +2256 2 2 12 9 367 1605 3575 +2257 2 2 12 9 672 1778 3322 +2258 2 2 12 9 679 1405 3468 +2259 2 2 12 9 466 3252 1724 +2260 2 2 12 9 1443 2801 2322 +2261 2 2 12 9 391 2491 1404 +2262 2 2 12 9 1045 1667 2101 +2263 2 2 12 9 1046 2102 1668 +2264 2 2 12 9 570 2400 1455 +2265 2 2 12 9 763 1618 2180 +2266 2 2 12 9 858 1393 2436 +2267 2 2 12 9 775 1841 1872 +2268 2 2 12 9 835 3485 1409 +2269 2 2 12 9 1071 2747 1463 +2270 2 2 12 9 1204 3533 1822 +2271 2 2 12 9 1023 1998 2231 +2272 2 2 12 9 819 2107 1557 +2273 2 2 12 9 880 1834 3035 +2274 2 2 12 9 737 2718 2001 +2275 2 2 12 9 738 2002 2719 +2276 2 2 12 9 613 1378 3499 +2277 2 2 12 9 683 1953 1563 +2278 2 2 12 9 45 1465 2271 +2279 2 2 12 9 176 2272 1466 +2280 2 2 12 9 538 1702 2032 +2281 2 2 12 9 1432 2579 2857 +2282 2 2 12 9 204 205 1853 +2283 2 2 12 9 686 1569 3476 +2284 2 2 12 9 936 1397 2478 +2285 2 2 12 9 889 2354 1430 +2286 2 2 12 9 192 2579 1432 +2287 2 2 12 9 601 2146 1494 +2288 2 2 12 9 1306 2669 2697 +2289 2 2 12 9 602 1495 2148 +2290 2 2 12 9 597 1361 3184 +2291 2 2 12 9 367 1514 3440 +2292 2 2 12 9 852 2318 1419 +2293 2 2 12 9 853 1420 2319 +2294 2 2 12 9 246 2377 1660 +2295 2 2 12 9 330 1661 2378 +2296 2 2 12 9 462 2550 1769 +2297 2 2 12 9 1214 1745 3532 +2298 2 2 12 9 485 2139 1770 +2299 2 2 12 9 1415 2377 3176 +2300 2 2 12 9 1416 3177 2378 +2301 2 2 12 9 587 3335 2103 +2302 2 2 12 9 913 2028 1596 +2303 2 2 12 9 588 2104 3336 +2304 2 2 12 9 1528 2016 3524 +2305 2 2 12 9 1529 3525 2017 +2306 2 2 12 9 12 2706 2153 +2307 2 2 12 9 396 2632 1996 +2308 2 2 12 9 574 2868 2447 +2309 2 2 12 9 575 2448 2869 +2310 2 2 12 9 857 2231 1998 +2311 2 2 12 9 525 1793 3173 +2312 2 2 12 9 526 3174 1794 +2313 2 2 12 9 1793 3571 3173 +2314 2 2 12 9 798 1504 3076 +2315 2 2 12 9 1794 3174 3572 +2316 2 2 12 9 850 2425 1657 +2317 2 2 12 9 805 2076 1500 +2318 2 2 12 9 1912 2800 2495 +2319 2 2 12 9 1678 2227 3510 +2320 2 2 12 9 778 3593 2037 +2321 2 2 12 9 855 3092 1450 +2322 2 2 12 9 1219 3543 1751 +2323 2 2 12 9 490 1633 2157 +2324 2 2 12 9 25 26 1834 +2325 2 2 12 9 764 1571 2099 +2326 2 2 12 9 282 283 1733 +2327 2 2 12 9 785 1873 1609 +2328 2 2 12 9 786 1610 1874 +2329 2 2 12 9 1128 3375 2633 +2330 2 2 12 9 369 1636 2016 +2331 2 2 12 9 514 3196 1881 +2332 2 2 12 9 370 2017 1637 +2333 2 2 12 9 825 1961 1779 +2334 2 2 12 9 1087 2706 2851 +2335 2 2 12 9 948 1867 1648 +2336 2 2 12 9 1274 3439 1939 +2337 2 2 12 9 999 2579 1831 +2338 2 2 12 9 468 1366 3586 +2339 2 2 12 9 375 1894 2187 +2340 2 2 12 9 754 3387 1545 +2341 2 2 12 9 847 1533 2271 +2342 2 2 12 9 848 2272 1534 +2343 2 2 12 9 449 3126 1756 +2344 2 2 12 9 1056 3644 1419 +2345 2 2 12 9 1057 1420 3645 +2346 2 2 12 9 847 2271 1465 +2347 2 2 12 9 848 1466 2272 +2348 2 2 12 9 1433 2495 1712 +2349 2 2 12 9 820 1439 2219 +2350 2 2 12 9 888 1920 3371 +2351 2 2 12 9 821 2220 1440 +2352 2 2 12 9 918 2654 3063 +2353 2 2 12 9 3510 2227 1139 +2354 2 2 12 9 919 3064 2655 +2355 2 2 12 9 1347 1880 2861 +2356 2 2 12 9 453 1555 1962 +2357 2 2 12 9 827 2870 2293 +2358 2 2 12 9 294 295 1737 +2359 2 2 12 9 1062 1991 2795 +2360 2 2 12 9 1064 2749 2090 +2361 2 2 12 9 961 2733 1906 +2362 2 2 12 9 472 1849 2053 +2363 2 2 12 9 877 1512 2698 +2364 2 2 12 9 365 2659 1405 +2365 2 2 12 9 488 2200 1918 +2366 2 2 12 9 679 2151 1666 +2367 2 2 12 9 828 1836 1813 +2368 2 2 12 9 240 241 1743 +2369 2 2 12 9 335 336 1744 +2370 2 2 12 9 500 1422 2715 +2371 2 2 12 9 576 1512 2269 +2372 2 2 12 9 472 2053 3574 +2373 2 2 12 9 997 1660 2142 +2374 2 2 12 9 998 2143 1661 +2375 2 2 12 9 991 2109 1821 +2376 2 2 12 9 514 2299 3196 +2377 2 2 12 9 888 3371 2597 +2378 2 2 12 9 369 2985 2718 +2379 2 2 12 9 370 2719 2986 +2380 2 2 12 9 705 1884 1606 +2381 2 2 12 9 732 2433 1488 +2382 2 2 12 9 994 2730 2962 +2383 2 2 12 9 706 1607 1885 +2384 2 2 12 9 1031 2152 1864 +2385 2 2 12 9 704 3433 1972 +2386 2 2 12 9 416 1424 2821 +2387 2 2 12 9 388 3072 2177 +2388 2 2 12 9 794 3492 1733 +2389 2 2 12 9 938 2451 2384 +2390 2 2 12 9 1212 2103 2784 +2391 2 2 12 9 442 1456 3544 +2392 2 2 12 9 939 2386 2452 +2393 2 2 12 9 1213 2786 2104 +2394 2 2 12 9 1147 1516 3473 +2395 2 2 12 9 493 2850 1467 +2396 2 2 12 9 969 2040 2096 +2397 2 2 12 9 970 2097 2041 +2398 2 2 12 9 28 29 2140 +2399 2 2 12 9 299 1470 3412 +2400 2 2 12 9 419 2135 2290 +2401 2 2 12 9 880 3035 2458 +2402 2 2 12 9 630 2332 2047 +2403 2 2 12 9 631 2048 2333 +2404 2 2 12 9 583 2189 2479 +2405 2 2 12 9 694 1605 1956 +2406 2 2 12 9 991 1918 2200 +2407 2 2 12 9 717 3253 1445 +2408 2 2 12 9 32 33 1950 +2409 2 2 12 9 885 3334 2387 +2410 2 2 12 9 674 3265 1749 +2411 2 2 12 9 412 2567 1476 +2412 2 2 12 9 981 2217 1917 +2413 2 2 12 9 531 1458 2676 +2414 2 2 12 9 969 2096 2839 +2415 2 2 12 9 970 2840 2097 +2416 2 2 12 9 720 1779 1961 +2417 2 2 12 9 581 2525 3228 +2418 2 2 12 9 582 3229 2526 +2419 2 2 12 9 798 1462 2906 +2420 2 2 12 9 1391 1415 2775 +2421 2 2 12 9 1392 2776 1416 +2422 2 2 12 9 1236 3512 1703 +2423 2 2 12 9 752 2784 2103 +2424 2 2 12 9 753 2104 2786 +2425 2 2 12 9 938 2006 1945 +2426 2 2 12 9 939 1946 2007 +2427 2 2 12 9 822 2075 1768 +2428 2 2 12 9 1273 1828 3419 +2429 2 2 12 9 1362 2447 2868 +2430 2 2 12 9 1363 2869 2448 +2431 2 2 12 9 269 1521 2311 +2432 2 2 12 9 856 1917 2217 +2433 2 2 12 9 339 1589 1915 +2434 2 2 12 9 1331 3249 3014 +2435 2 2 12 9 1151 3333 3415 +2436 2 2 12 9 1070 1375 2656 +2437 2 2 12 9 459 1732 2038 +2438 2 2 12 9 44 2271 1533 +2439 2 2 12 9 177 1534 2272 +2440 2 2 12 9 48 1598 2051 +2441 2 2 12 9 173 2052 1599 +2442 2 2 12 9 1066 2316 2320 +2443 2 2 12 9 1067 2321 2317 +2444 2 2 12 9 990 1483 3100 +2445 2 2 12 9 700 1645 2171 +2446 2 2 12 9 795 2491 1374 +2447 2 2 12 9 2300 3427 473 +2448 2 2 12 9 681 3065 1451 +2449 2 2 12 9 1318 2040 2758 +2450 2 2 12 9 1319 2759 2041 +2451 2 2 12 9 719 1628 1970 +2452 2 2 12 9 299 2564 1470 +2453 2 2 12 9 1355 2571 3027 +2454 2 2 12 9 653 2512 1456 +2455 2 2 12 9 2858 3490 392 +2456 2 2 12 9 469 2165 1553 +2457 2 2 12 9 2859 393 3491 +2458 2 2 12 9 285 2989 1484 +2459 2 2 12 9 898 3041 2539 +2460 2 2 12 9 444 2510 1402 +2461 2 2 12 9 859 2444 1399 +2462 2 2 12 9 1316 1693 2549 +2463 2 2 12 9 1077 2001 2273 +2464 2 2 12 9 1078 2274 2002 +2465 2 2 12 9 222 3236 1411 +2466 2 2 12 9 872 1382 2359 +2467 2 2 12 9 775 2139 1841 +2468 2 2 12 9 1176 2329 2240 +2469 2 2 12 9 694 3204 1605 +2470 2 2 12 9 1464 2387 3334 +2471 2 2 12 9 770 1606 1884 +2472 2 2 12 9 771 1885 1607 +2473 2 2 12 9 626 1476 2270 +2474 2 2 12 9 403 1407 2557 +2475 2 2 12 9 404 2558 1408 +2476 2 2 12 9 698 2615 1852 +2477 2 2 12 9 354 2412 1645 +2478 2 2 12 9 390 1449 2252 +2479 2 2 12 9 597 1492 2210 +2480 2 2 12 9 411 2240 2329 +2481 2 2 12 9 300 1475 2564 +2482 2 2 12 9 1120 2896 3405 +2483 2 2 12 9 1647 3373 3418 +2484 2 2 12 9 772 1476 2704 +2485 2 2 12 9 1320 2098 2658 +2486 2 2 12 9 661 2756 3514 +2487 2 2 12 9 1523 2975 1837 +2488 2 2 12 9 671 1584 2003 +2489 2 2 12 9 786 1632 1964 +2490 2 2 12 9 1671 2821 2826 +2491 2 2 12 9 835 1409 3402 +2492 2 2 12 9 1410 2972 1690 +2493 2 2 12 9 562 2960 1924 +2494 2 2 12 9 564 1925 2961 +2495 2 2 12 9 1138 3267 2087 +2496 2 2 12 9 431 2236 1487 +2497 2 2 12 9 1906 2733 2916 +2498 2 2 12 9 1187 1693 3480 +2499 2 2 12 9 1100 1600 3214 +2500 2 2 12 9 1101 3215 1601 +2501 2 2 12 9 696 2906 1462 +2502 2 2 12 9 1451 3065 2250 +2503 2 2 12 9 917 1628 1882 +2504 2 2 12 9 1352 1938 3536 +2505 2 2 12 9 1133 2960 1472 +2506 2 2 12 9 1134 1473 2961 +2507 2 2 12 9 782 3636 1543 +2508 2 2 12 9 185 2399 1542 +2509 2 2 12 9 1095 3395 2537 +2510 2 2 12 9 886 2553 1383 +2511 2 2 12 9 1119 3373 1647 +2512 2 2 12 9 612 3035 1423 +2513 2 2 12 9 304 1755 2976 +2514 2 2 12 9 431 2549 1693 +2515 2 2 12 9 1598 3413 2051 +2516 2 2 12 9 1599 2052 3414 +2517 2 2 12 9 590 1429 2338 +2518 2 2 12 9 1299 2839 2096 +2519 2 2 12 9 1300 2097 2840 +2520 2 2 12 9 366 1445 2955 +2521 2 2 12 9 716 1456 2471 +2522 2 2 12 9 1309 2673 2663 +2523 2 2 12 9 1107 2421 3160 +2524 2 2 12 9 553 1638 2916 +2525 2 2 12 9 969 2758 2040 +2526 2 2 12 9 1406 2851 2061 +2527 2 2 12 9 970 2041 2759 +2528 2 2 12 9 1944 2408 3052 +2529 2 2 12 9 1162 1987 2820 +2530 2 2 12 9 885 2586 1421 +2531 2 2 12 9 1227 2433 2617 +2532 2 2 12 9 353 3292 1540 +2533 2 2 12 9 408 2101 1667 +2534 2 2 12 9 409 1668 2102 +2535 2 2 12 9 725 3391 1549 +2536 2 2 12 9 1127 1540 3292 +2537 2 2 12 9 422 1462 2406 +2538 2 2 12 9 262 263 1786 +2539 2 2 12 9 313 314 1787 +2540 2 2 12 9 50 51 1766 +2541 2 2 12 9 170 171 1767 +2542 2 2 12 9 1255 1748 2479 +2543 2 2 12 9 657 2341 1467 +2544 2 2 12 9 815 2547 1459 +2545 2 2 12 9 816 1460 2548 +2546 2 2 12 9 1037 2644 1773 +2547 2 2 12 9 472 3574 2394 +2548 2 2 12 9 270 2696 1521 +2549 2 2 12 9 1178 1602 3474 +2550 2 2 12 9 446 1418 3062 +2551 2 2 12 9 569 3156 1840 +2552 2 2 12 9 1210 1996 2632 +2553 2 2 12 9 255 2043 2739 +2554 2 2 12 9 321 2740 2044 +2555 2 2 12 9 601 1459 2547 +2556 2 2 12 9 602 2548 1460 +2557 2 2 12 9 415 1493 2194 +2558 2 2 12 9 733 1921 1694 +2559 2 2 12 9 886 1383 2438 +2560 2 2 12 9 734 1695 1922 +2561 2 2 12 9 616 2811 1425 +2562 2 2 12 9 446 1483 2923 +2563 2 2 12 9 895 1593 1958 +2564 2 2 12 9 787 2194 1493 +2565 2 2 12 9 506 2161 3045 +2566 2 2 12 9 1028 2197 2250 +2567 2 2 12 9 507 3046 2162 +2568 2 2 12 9 554 1773 2644 +2569 2 2 12 9 697 1448 2279 +2570 2 2 12 9 641 3532 3432 +2571 2 2 12 9 1809 2830 2996 +2572 2 2 12 9 1013 2253 2379 +2573 2 2 12 9 385 2040 2449 +2574 2 2 12 9 591 2697 2669 +2575 2 2 12 9 384 2450 2041 +2576 2 2 12 9 835 1872 1841 +2577 2 2 12 9 637 3179 1434 +2578 2 2 12 9 1170 3440 1514 +2579 2 2 12 9 622 3161 1478 +2580 2 2 12 9 592 2260 1441 +2581 2 2 12 9 847 1465 2591 +2582 2 2 12 9 848 2592 1466 +2583 2 2 12 9 785 1988 1672 +2584 2 2 12 9 1125 2047 2332 +2585 2 2 12 9 1076 1964 1632 +2586 2 2 12 9 1126 2333 2048 +2587 2 2 12 9 835 1741 1872 +2588 2 2 12 9 717 1927 2439 +2589 2 2 12 9 964 3050 1494 +2590 2 2 12 9 1322 2660 2242 +2591 2 2 12 9 742 2975 2606 +2592 2 2 12 9 1323 2243 2661 +2593 2 2 12 9 965 1495 3051 +2594 2 2 12 9 923 2559 1743 +2595 2 2 12 9 924 1744 2560 +2596 2 2 12 9 840 1439 2641 +2597 2 2 12 9 841 2642 1440 +2598 2 2 12 9 1263 2734 2252 +2599 2 2 12 9 380 1591 2229 +2600 2 2 12 9 899 3023 2856 +2601 2 2 12 9 947 2252 2734 +2602 2 2 12 9 1500 1972 3433 +2603 2 2 12 9 1289 2014 2966 +2604 2 2 12 9 871 1455 2400 +2605 2 2 12 9 763 3332 1516 +2606 2 2 12 9 34 1672 3042 +2607 2 2 12 9 826 2866 2462 +2608 2 2 12 9 617 2597 1401 +2609 2 2 12 9 1281 1840 3156 +2610 2 2 12 9 473 3427 2009 +2611 2 2 12 9 947 1426 2766 +2612 2 2 12 9 253 1587 2088 +2613 2 2 12 9 323 2089 1588 +2614 2 2 12 9 352 3483 2410 +2615 2 2 12 9 351 2411 3484 +2616 2 2 12 9 1152 1903 2865 +2617 2 2 12 9 353 1540 2132 +2618 2 2 12 9 743 2091 2927 +2619 2 2 12 9 3364 2948 636 +2620 2 2 12 9 871 2657 1455 +2621 2 2 12 9 659 3473 1516 +2622 2 2 12 9 486 1725 2797 +2623 2 2 12 9 487 2798 1726 +2624 2 2 12 9 1322 2780 2660 +2625 2 2 12 9 1323 2661 2781 +2626 2 2 12 9 460 2225 1491 +2627 2 2 12 9 800 1505 2371 +2628 2 2 12 9 856 2391 1917 +2629 2 2 12 9 855 2157 1633 +2630 2 2 12 9 1569 2307 3269 +2631 2 2 12 9 877 2269 1512 +2632 2 2 12 9 675 1756 2947 +2633 2 2 12 9 424 2409 1620 +2634 2 2 12 9 982 1553 2165 +2635 2 2 12 9 887 2806 1780 +2636 2 2 12 9 1468 2612 2397 +2637 2 2 12 9 908 2018 1875 +2638 2 2 12 9 1798 2649 3426 +2639 2 2 12 9 441 1930 1602 +2640 2 2 12 9 705 1606 3066 +2641 2 2 12 9 706 3067 1607 +2642 2 2 12 9 389 1596 2028 +2643 2 2 12 9 1209 1487 3481 +2644 2 2 12 9 914 1915 1673 +2645 2 2 12 9 366 1939 3439 +2646 2 2 12 9 1268 3374 2352 +2647 2 2 12 9 1593 3487 2709 +2648 2 2 12 9 838 2199 2418 +2649 2 2 12 9 201 3231 1973 +2650 2 2 12 9 913 1596 2672 +2651 2 2 12 9 365 2809 1554 +2652 2 2 12 9 958 2186 1569 +2653 2 2 12 9 794 2105 3574 +2654 2 2 12 9 812 1737 1994 +2655 2 2 12 9 1255 2479 2189 +2656 2 2 12 9 637 2393 2265 +2657 2 2 12 9 385 2096 2040 +2658 2 2 12 9 810 2397 2612 +2659 2 2 12 9 384 2041 2097 +2660 2 2 12 9 788 2577 1424 +2661 2 2 12 9 406 2912 2883 +2662 2 2 12 9 644 3458 3543 +2663 2 2 12 9 1049 3151 1758 +2664 2 2 12 9 386 1434 3594 +2665 2 2 12 9 365 3592 2298 +2666 2 2 12 9 279 1971 1635 +2667 2 2 12 9 783 1947 2117 +2668 2 2 12 9 3550 2174 812 +2669 2 2 12 9 784 2118 1948 +2670 2 2 12 9 219 2665 3032 +2671 2 2 12 9 885 1414 2586 +2672 2 2 12 9 1326 2210 3026 +2673 2 2 12 9 1094 1675 3381 +2674 2 2 12 9 189 2068 1646 +2675 2 2 12 9 785 2469 1541 +2676 2 2 12 9 458 1481 2114 +2677 2 2 12 9 459 2115 1482 +2678 2 2 12 9 570 1515 3099 +2679 2 2 12 9 1597 2948 3364 +2680 2 2 12 9 883 1666 2151 +2681 2 2 12 9 789 2286 1580 +2682 2 2 12 9 1251 3641 2628 +2683 2 2 12 9 760 2991 1816 +2684 2 2 12 9 805 1500 3433 +2685 2 2 12 9 761 1817 2992 +2686 2 2 12 9 340 1670 2578 +2687 2 2 12 9 367 3070 1514 +2688 2 2 12 9 713 2014 1675 +2689 2 2 12 9 445 2167 1486 +2690 2 2 12 9 194 2054 1831 +2691 2 2 12 9 790 1496 2822 +2692 2 2 12 9 601 2754 1459 +2693 2 2 12 9 40 41 2169 +2694 2 2 12 9 180 181 2170 +2695 2 2 12 9 602 1460 2755 +2696 2 2 12 9 990 2923 1483 +2697 2 2 12 9 918 1895 2223 +2698 2 2 12 9 919 2224 1896 +2699 2 2 12 9 920 1468 2774 +2700 2 2 12 9 772 3178 1557 +2701 2 2 12 9 1072 2916 1638 +2702 2 2 12 9 413 3027 2571 +2703 2 2 12 9 869 1433 2898 +2704 2 2 12 9 1023 2231 1812 +2705 2 2 12 9 866 3114 1469 +2706 2 2 12 9 593 2375 1407 +2707 2 2 12 9 594 1408 2376 +2708 2 2 12 9 366 3439 1927 +2709 2 2 12 9 1262 2539 3041 +2710 2 2 12 9 607 3100 1483 +2711 2 2 12 9 770 2875 1606 +2712 2 2 12 9 771 1607 2876 +2713 2 2 12 9 3490 1829 392 +2714 2 2 12 9 3491 393 1830 +2715 2 2 12 9 917 1467 2850 +2716 2 2 12 9 922 2617 1684 +2717 2 2 12 9 1042 2974 1671 +2718 2 2 12 9 355 3214 1600 +2719 2 2 12 9 292 1506 2953 +2720 2 2 12 9 356 1601 3215 +2721 2 2 12 9 420 2172 1550 +2722 2 2 12 9 2250 3065 1028 +2723 2 2 12 9 231 1500 2076 +2724 2 2 12 9 580 2865 1903 +2725 2 2 12 9 884 1590 1989 +2726 2 2 12 9 421 1551 2173 +2727 2 2 12 9 1600 2979 1892 +2728 2 2 12 9 1601 1893 2980 +2729 2 2 12 9 609 3130 1454 +2730 2 2 12 9 1116 1554 2420 +2731 2 2 12 9 672 3322 1571 +2732 2 2 12 9 1275 2471 2778 +2733 2 2 12 9 36 1541 2469 +2734 2 2 12 9 739 2016 1636 +2735 2 2 12 9 740 1637 2017 +2736 2 2 12 9 1585 2893 2618 +2737 2 2 12 9 1586 2619 2894 +2738 2 2 12 9 855 1633 2297 +2739 2 2 12 9 992 2792 2057 +2740 2 2 12 9 1018 3099 1515 +2741 2 2 12 9 993 2058 2794 +2742 2 2 12 9 920 2888 1468 +2743 2 2 12 9 774 1705 2055 +2744 2 2 12 9 1137 1881 3053 +2745 2 2 12 9 255 256 2043 +2746 2 2 12 9 320 321 2044 +2747 2 2 12 9 826 2462 1877 +2748 2 2 12 9 1049 1758 2492 +2749 2 2 12 9 783 3639 2006 +2750 2 2 12 9 784 2007 3640 +2751 2 2 12 9 3537 1170 1514 +2752 2 2 12 9 1565 1857 2712 +2753 2 2 12 9 1566 2713 1858 +2754 2 2 12 9 1190 2546 1938 +2755 2 2 12 9 519 2273 2001 +2756 2 2 12 9 457 3384 1497 +2757 2 2 12 9 520 2002 2274 +2758 2 2 12 9 972 3271 1518 +2759 2 2 12 9 794 1805 3492 +2760 2 2 12 9 522 2050 2500 +2761 2 2 12 9 689 2364 1508 +2762 2 2 12 9 1196 2956 2847 +2763 2 2 12 9 690 1509 2365 +2764 2 2 12 9 627 1432 2857 +2765 2 2 12 9 890 2242 2660 +2766 2 2 12 9 891 2661 2243 +2767 2 2 12 9 440 2774 1468 +2768 2 2 12 9 589 2585 1404 +2769 2 2 12 9 846 2802 2977 +2770 2 2 12 9 1283 2927 2091 +2771 2 2 12 9 541 3343 1926 +2772 2 2 12 9 1256 1728 2463 +2773 2 2 12 9 844 1475 2381 +2774 2 2 12 9 201 202 3231 +2775 2 2 12 9 458 2504 1718 +2776 2 2 12 9 735 3508 3309 +2777 2 2 12 9 736 3310 3509 +2778 2 2 12 9 1039 1759 1928 +2779 2 2 12 9 542 2060 2426 +2780 2 2 12 9 434 2987 1615 +2781 2 2 12 9 435 1616 2988 +2782 2 2 12 9 438 1490 2185 +2783 2 2 12 9 457 1497 2342 +2784 2 2 12 9 786 1542 2399 +2785 2 2 12 9 596 2538 1808 +2786 2 2 12 9 560 1518 2287 +2787 2 2 12 9 210 211 2065 +2788 2 2 12 9 596 2663 2673 +2789 2 2 12 9 1043 2110 1802 +2790 2 2 12 9 741 2623 2008 +2791 2 2 12 9 1044 1803 2111 +2792 2 2 12 9 577 2799 2722 +2793 2 2 12 9 652 2614 1497 +2794 2 2 12 9 2161 3171 3045 +2795 2 2 12 9 2162 3046 3172 +2796 2 2 12 9 798 2906 1504 +2797 2 2 12 9 1039 1798 3426 +2798 2 2 12 9 787 1510 2565 +2799 2 2 12 9 864 2046 2984 +2800 2 2 12 9 788 2566 1511 +2801 2 2 12 9 1563 2396 3167 +2802 2 2 12 9 1264 1927 3439 +2803 2 2 12 9 1223 3461 2554 +2804 2 2 12 9 663 1654 3565 +2805 2 2 12 9 664 3566 1655 +2806 2 2 12 9 658 2075 1665 +2807 2 2 12 9 492 3536 1938 +2808 2 2 12 9 752 2979 1997 +2809 2 2 12 9 753 2000 2980 +2810 2 2 12 9 1461 1683 3237 +2811 2 2 12 9 744 1615 2033 +2812 2 2 12 9 745 2034 1616 +2813 2 2 12 9 1686 2228 3629 +2814 2 2 12 9 710 3466 1977 +2815 2 2 12 9 711 1978 3467 +2816 2 2 12 9 760 1625 2195 +2817 2 2 12 9 761 2196 1626 +2818 2 2 12 9 750 1582 2447 +2819 2 2 12 9 751 2448 1583 +2820 2 2 12 9 352 1498 3060 +2821 2 2 12 9 351 3061 1499 +2822 2 2 12 9 982 2996 2830 +2823 2 2 12 9 460 1491 3647 +2824 2 2 12 9 600 2192 1929 +2825 2 2 12 9 1284 2426 2060 +2826 2 2 12 9 872 1641 2042 +2827 2 2 12 9 483 3089 2117 +2828 2 2 12 9 484 2118 3090 +2829 2 2 12 9 488 3550 2093 +2830 2 2 12 9 1234 2233 3085 +2831 2 2 12 9 1208 3223 2063 +2832 2 2 12 9 1099 1576 3308 +2833 2 2 12 9 440 1468 2397 +2834 2 2 12 9 670 3254 2935 +2835 2 2 12 9 842 2063 3412 +2836 2 2 12 9 698 3504 2615 +2837 2 2 12 9 215 216 2847 +2838 2 2 12 9 900 3368 1559 +2839 2 2 12 9 1072 2418 2199 +2840 2 2 12 9 1191 3322 1778 +2841 2 2 12 9 303 304 2976 +2842 2 2 12 9 456 1544 2606 +2843 2 2 12 9 416 1671 2974 +2844 2 2 12 9 727 2330 3311 +2845 2 2 12 9 728 3312 2331 +2846 2 2 12 9 835 1969 1741 +2847 2 2 12 9 673 2297 1633 +2848 2 2 12 9 367 1441 3070 +2849 2 2 12 9 901 1541 3357 +2850 2 2 12 9 902 3358 1542 +2851 2 2 12 9 699 3301 1784 +2852 2 2 12 9 782 1624 3636 +2853 2 2 12 9 569 2371 1505 +2854 2 2 12 9 603 2724 1403 +2855 2 2 12 9 972 1478 3464 +2856 2 2 12 9 431 3230 1531 +2857 2 2 12 9 992 1798 2172 +2858 2 2 12 9 993 2173 1799 +2859 2 2 12 9 936 3419 1828 +2860 2 2 12 9 1359 1870 2460 +2861 2 2 12 9 1033 1600 2336 +2862 2 2 12 9 1140 2500 2050 +2863 2 2 12 9 415 2950 1493 +2864 2 2 12 9 1034 2337 1601 +2865 2 2 12 9 1022 1808 2538 +2866 2 2 12 9 1608 3574 2105 +2867 2 2 12 9 1025 3146 2166 +2868 2 2 12 9 589 1457 2436 +2869 2 2 12 9 636 2948 1552 +2870 2 2 12 9 640 2672 1596 +2871 2 2 12 9 414 1933 2968 +2872 2 2 12 9 836 1480 3431 +2873 2 2 12 9 764 2005 1617 +2874 2 2 12 9 627 2857 1555 +2875 2 2 12 9 1148 2966 2068 +2876 2 2 12 9 787 2552 1510 +2877 2 2 12 9 31 32 3076 +2878 2 2 12 9 1214 3532 1524 +2879 2 2 12 9 880 1902 2084 +2880 2 2 12 9 748 2846 1487 +2881 2 2 12 9 1306 2697 1629 +2882 2 2 12 9 1165 1568 3459 +2883 2 2 12 9 788 1511 2577 +2884 2 2 12 9 478 2404 1502 +2885 2 2 12 9 479 1503 2405 +2886 2 2 12 9 510 1608 2105 +2887 2 2 12 9 1652 2329 3131 +2888 2 2 12 9 343 1734 1895 +2889 2 2 12 9 368 1457 2753 +2890 2 2 12 9 29 3015 2140 +2891 2 2 12 9 342 1896 1735 +2892 2 2 12 9 626 2704 1476 +2893 2 2 12 9 901 2893 1873 +2894 2 2 12 9 902 1874 2894 +2895 2 2 12 9 1656 2174 3550 +2896 2 2 12 9 813 1614 2072 +2897 2 2 12 9 792 1782 1955 +2898 2 2 12 9 254 2739 1587 +2899 2 2 12 9 322 1588 2740 +2900 2 2 12 9 730 1935 1679 +2901 2 2 12 9 731 1680 1936 +2902 2 2 12 9 471 1777 1960 +2903 2 2 12 9 445 2147 1543 +2904 2 2 12 9 1574 2137 2920 +2905 2 2 12 9 1575 2921 2138 +2906 2 2 12 9 496 2380 1842 +2907 2 2 12 9 1083 2409 2457 +2908 2 2 12 9 513 1513 2973 +2909 2 2 12 9 670 3401 1577 +2910 2 2 12 9 866 1469 3397 +2911 2 2 12 9 999 2857 2579 +2912 2 2 12 9 530 2204 2825 +2913 2 2 12 9 946 1720 2084 +2914 2 2 12 9 789 1634 2286 +2915 2 2 12 9 1327 2880 1806 +2916 2 2 12 9 972 2370 1478 +2917 2 2 12 9 1339 3517 2905 +2918 2 2 12 9 1472 2382 3369 +2919 2 2 12 9 1473 3370 2383 +2920 2 2 12 9 901 2618 2893 +2921 2 2 12 9 902 2894 2619 +2922 2 2 12 9 1106 2407 2968 +2923 2 2 12 9 187 3069 1632 +2924 2 2 12 9 1114 1672 1988 +2925 2 2 12 9 1077 1897 2710 +2926 2 2 12 9 1078 2711 1898 +2927 2 2 12 9 304 2535 1755 +2928 2 2 12 9 1223 2554 1900 +2929 2 2 12 9 1224 1901 2555 +2930 2 2 12 9 820 2382 1439 +2931 2 2 12 9 821 1440 2383 +2932 2 2 12 9 349 2812 1442 +2933 2 2 12 9 846 2749 2020 +2934 2 2 12 9 1228 2265 2393 +2935 2 2 12 9 515 1640 2181 +2936 2 2 12 9 1011 2201 2638 +2937 2 2 12 9 462 3281 2550 +2938 2 2 12 9 986 2763 1766 +2939 2 2 12 9 987 1767 2764 +2940 2 2 12 9 1282 2997 2517 +2941 2 2 12 9 806 2862 1550 +2942 2 2 12 9 807 1551 2864 +2943 2 2 12 9 782 1543 2147 +2944 2 2 12 9 911 1574 2920 +2945 2 2 12 9 912 2921 1575 +2946 2 2 12 9 368 2742 1457 +2947 2 2 12 9 632 2066 1728 +2948 2 2 12 9 659 1516 3332 +2949 2 2 12 9 1255 2189 2683 +2950 2 2 12 9 983 2950 2881 +2951 2 2 12 9 1162 2407 3382 +2952 2 2 12 9 430 2750 1569 +2953 2 2 12 9 920 1562 2144 +2954 2 2 12 9 958 1569 2750 +2955 2 2 12 9 773 2299 1704 +2956 2 2 12 9 802 2632 1552 +2957 2 2 12 9 786 2399 1632 +2958 2 2 12 9 623 2612 1468 +2959 2 2 12 9 742 2506 1837 +2960 2 2 12 9 630 2660 2780 +2961 2 2 12 9 631 2781 2661 +2962 2 2 12 9 946 2694 1720 +2963 2 2 12 9 463 2843 1517 +2964 2 2 12 9 712 2863 1913 +2965 2 2 12 9 721 2887 1530 +2966 2 2 12 9 1900 2554 3152 +2967 2 2 12 9 1901 3153 2555 +2968 2 2 12 9 675 2947 1446 +2969 2 2 12 9 1151 3021 2485 +2970 2 2 12 9 811 2132 1540 +2971 2 2 12 9 727 2223 1895 +2972 2 2 12 9 728 1896 2224 +2973 2 2 12 9 819 3648 2287 +2974 2 2 12 9 477 3464 1984 +2975 2 2 12 9 704 3237 1683 +2976 2 2 12 9 1340 3552 3390 +2977 2 2 12 9 472 2861 1849 +2978 2 2 12 9 697 3043 1448 +2979 2 2 12 9 622 1562 2584 +2980 2 2 12 9 1233 3032 2665 +2981 2 2 12 9 897 3586 2363 +2982 2 2 12 9 647 1861 2023 +2983 2 2 12 9 739 1437 3534 +2984 2 2 12 9 648 2024 1862 +2985 2 2 12 9 740 3535 1438 +2986 2 2 12 9 390 2362 1537 +2987 2 2 12 9 488 2398 3550 +2988 2 2 12 9 675 3480 1693 +2989 2 2 12 9 791 1831 2054 +2990 2 2 12 9 600 1442 3435 +2991 2 2 12 9 515 2835 1640 +2992 2 2 12 9 246 247 2377 +2993 2 2 12 9 329 330 2378 +2994 2 2 12 9 1118 2116 3379 +2995 2 2 12 9 798 2685 1714 +2996 2 2 12 9 376 2417 1921 +2997 2 2 12 9 513 2897 3419 +2998 2 2 12 9 444 1558 2510 +2999 2 2 12 9 491 1812 2231 +3000 2 2 12 9 659 3332 1546 +3001 2 2 12 9 938 2384 1947 +3002 2 2 12 9 939 1948 2386 +3003 2 2 12 9 879 1538 2683 +3004 2 2 12 9 893 2320 2316 +3005 2 2 12 9 894 2317 2321 +3006 2 2 12 9 382 2072 2158 +3007 2 2 12 9 649 1907 3547 +3008 2 2 12 9 1276 2941 1932 +3009 2 2 12 9 468 1474 2403 +3010 2 2 12 9 1087 2153 2706 +3011 2 2 12 9 448 1992 2511 +3012 2 2 12 9 789 1580 2454 +3013 2 2 12 9 8 1464 3101 +3014 2 2 12 9 360 1982 1730 +3015 2 2 12 9 494 2666 2223 +3016 2 2 12 9 1157 2626 1843 +3017 2 2 12 9 1158 1844 2627 +3018 2 2 12 9 495 2224 2667 +3019 2 2 12 9 549 1524 2836 +3020 2 2 12 9 1114 3042 1672 +3021 2 2 12 9 696 1504 2906 +3022 2 2 12 9 1309 1642 2673 +3023 2 2 12 9 194 195 2054 +3024 2 2 12 9 737 2710 1427 +3025 2 2 12 9 738 1428 2711 +3026 2 2 12 9 3567 3200 1015 +3027 2 2 12 9 3568 1016 3201 +3028 2 2 12 9 820 3369 2382 +3029 2 2 12 9 821 2383 3370 +3030 2 2 12 9 729 2549 1531 +3031 2 2 12 9 1662 3121 2702 +3032 2 2 12 9 1663 2703 3122 +3033 2 2 12 9 3167 2396 1050 +3034 2 2 12 9 828 3540 1650 +3035 2 2 12 9 649 3547 2813 +3036 2 2 12 9 1154 1919 3001 +3037 2 2 12 9 819 1939 3457 +3038 2 2 12 9 1446 1993 3480 +3039 2 2 12 9 737 1636 2718 +3040 2 2 12 9 738 2719 1637 +3041 2 2 12 9 829 1802 2110 +3042 2 2 12 9 830 2111 1803 +3043 2 2 12 9 1228 2856 3023 +3044 2 2 12 9 518 2278 1964 +3045 2 2 12 9 422 3634 1489 +3046 2 2 12 9 682 2881 1729 +3047 2 2 12 9 640 2149 1602 +3048 2 2 12 9 1414 2895 2586 +3049 2 2 12 9 808 1743 2559 +3050 2 2 12 9 809 2560 1744 +3051 2 2 12 9 972 1518 2912 +3052 2 2 12 9 635 1926 2492 +3053 2 2 12 9 396 2507 1552 +3054 2 2 12 9 623 1468 2888 +3055 2 2 12 9 1077 2273 2219 +3056 2 2 12 9 1078 2220 2274 +3057 2 2 12 9 521 2180 1618 +3058 2 2 12 9 785 1672 2469 +3059 2 2 12 9 501 2084 1902 +3060 2 2 12 9 399 2822 1496 +3061 2 2 12 9 1429 2904 1959 +3062 2 2 12 9 935 1863 2055 +3063 2 2 12 9 619 2586 2895 +3064 2 2 12 9 735 3309 1508 +3065 2 2 12 9 1657 2425 3445 +3066 2 2 12 9 1780 2806 2580 +3067 2 2 12 9 829 2110 3462 +3068 2 2 12 9 830 3463 2111 +3069 2 2 12 9 736 1509 3310 +3070 2 2 12 9 36 3357 1541 +3071 2 2 12 9 185 1542 3358 +3072 2 2 12 9 202 203 2294 +3073 2 2 12 9 758 3305 1759 +3074 2 2 12 9 1021 2799 2533 +3075 2 2 12 9 617 1471 2653 +3076 2 2 12 9 763 2180 1943 +3077 2 2 12 9 801 1840 2664 +3078 2 2 12 9 638 1564 2521 +3079 2 2 12 9 935 2497 2022 +3080 2 2 12 9 942 2131 1630 +3081 2 2 12 9 1387 2373 3446 +3082 2 2 12 9 1388 3447 2374 +3083 2 2 12 9 729 1531 2439 +3084 2 2 12 9 517 1988 2277 +3085 2 2 12 9 950 2213 2155 +3086 2 2 12 9 951 2156 2214 +3087 2 2 12 9 665 1532 2414 +3088 2 2 12 9 1211 2061 1931 +3089 2 2 12 9 723 3596 1560 +3090 2 2 12 9 724 1561 3597 +3091 2 2 12 9 627 1555 2529 +3092 2 2 12 9 864 2984 2480 +3093 2 2 12 9 676 3308 1576 +3094 2 2 12 9 1400 3547 1907 +3095 2 2 12 9 795 2027 1669 +3096 2 2 12 9 1020 2815 2280 +3097 2 2 12 9 955 3526 2562 +3098 2 2 12 9 1038 2479 1748 +3099 2 2 12 9 950 2155 1824 +3100 2 2 12 9 951 1825 2156 +3101 2 2 12 9 7 3101 3261 +3102 2 2 12 9 977 1929 2192 +3103 2 2 12 9 1040 3545 1799 +3104 2 2 12 9 441 2520 1681 +3105 2 2 12 9 1250 1784 3301 +3106 2 2 12 9 31 1504 3129 +3107 2 2 12 9 295 1994 1737 +3108 2 2 12 9 1161 3043 1930 +3109 2 2 12 9 3510 364 2334 +3110 2 2 12 9 806 2502 1761 +3111 2 2 12 9 807 1762 2503 +3112 2 2 12 9 534 2235 2908 +3113 2 2 12 9 1340 3390 2514 +3114 2 2 12 9 396 2905 3517 +3115 2 2 12 9 1501 2522 3441 +3116 2 2 12 9 1613 3505 2841 +3117 2 2 12 9 1799 3545 2650 +3118 2 2 12 9 3505 691 2841 +3119 2 2 12 9 691 2484 1692 +3120 2 2 12 9 462 1769 2188 +3121 2 2 12 9 787 1493 2552 +3122 2 2 12 9 1221 3429 2505 +3123 2 2 12 9 865 1920 2062 +3124 2 2 12 9 862 2346 2066 +3125 2 2 12 9 829 2277 1609 +3126 2 2 12 9 614 1585 2618 +3127 2 2 12 9 830 1610 2278 +3128 2 2 12 9 615 2619 1586 +3129 2 2 12 9 1029 2037 1902 +3130 2 2 12 9 822 1665 2075 +3131 2 2 12 9 774 2055 1863 +3132 2 2 12 9 1326 3026 2193 +3133 2 2 12 9 426 2301 1606 +3134 2 2 12 9 427 1607 2302 +3135 2 2 12 9 548 3585 1593 +3136 2 2 12 9 1076 1632 3069 +3137 2 2 12 9 1269 3632 1789 +3138 2 2 12 9 759 1677 2620 +3139 2 2 12 9 1170 3537 1664 +3140 2 2 12 9 983 1493 2950 +3141 2 2 12 9 411 2234 1780 +3142 2 2 12 9 777 2115 3266 +3143 2 2 12 9 700 1822 3533 +3144 2 2 12 9 776 2568 2114 +3145 2 2 12 9 258 259 1868 +3146 2 2 12 9 317 318 1869 +3147 2 2 12 9 566 2455 1621 +3148 2 2 12 9 473 2570 1471 +3149 2 2 12 9 999 1555 2857 +3150 2 2 12 9 585 3187 3628 +3151 2 2 12 9 278 1635 3044 +3152 2 2 12 9 780 2049 3600 +3153 2 2 12 9 469 1723 2165 +3154 2 2 12 9 961 3220 1578 +3155 2 2 12 9 420 1550 2862 +3156 2 2 12 9 1603 2872 2845 +3157 2 2 12 9 421 2864 1551 +3158 2 2 12 9 617 3005 1490 +3159 2 2 12 9 466 2473 2424 +3160 2 2 12 9 847 2994 1533 +3161 2 2 12 9 848 1534 2995 +3162 2 2 12 9 795 1669 2345 +3163 2 2 12 9 827 1982 2870 +3164 2 2 12 9 1008 2157 2268 +3165 2 2 12 9 454 1824 2155 +3166 2 2 12 9 455 2156 1825 +3167 2 2 12 9 879 2874 1538 +3168 2 2 12 9 1166 1643 3613 +3169 2 2 12 9 790 3196 1496 +3170 2 2 12 9 607 1483 2736 +3171 2 2 12 9 475 2702 3121 +3172 2 2 12 9 476 3122 2703 +3173 2 2 12 9 1185 2079 1689 +3174 2 2 12 9 660 2949 1526 +3175 2 2 12 9 1383 3593 3307 +3176 2 2 12 9 726 1674 2092 +3177 2 2 12 9 39 40 2126 +3178 2 2 12 9 1478 1984 3464 +3179 2 2 12 9 181 182 2127 +3180 2 2 12 9 727 1622 2223 +3181 2 2 12 9 900 1883 2013 +3182 2 2 12 9 728 2224 1623 +3183 2 2 12 9 923 1743 2600 +3184 2 2 12 9 924 2601 1744 +3185 2 2 12 9 663 2266 2758 +3186 2 2 12 9 664 2759 2267 +3187 2 2 12 9 1507 3600 2049 +3188 2 2 12 9 808 1721 3243 +3189 2 2 12 9 809 3244 1722 +3190 2 2 12 9 1770 2139 2911 +3191 2 2 12 9 506 2540 2161 +3192 2 2 12 9 507 2162 2541 +3193 2 2 12 9 820 2219 2273 +3194 2 2 12 9 821 2274 2220 +3195 2 2 12 9 1424 2577 3074 +3196 2 2 12 9 920 1539 2584 +3197 2 2 12 9 1090 3171 1658 +3198 2 2 12 9 1091 1659 3172 +3199 2 2 12 9 1014 2973 1513 +3200 2 2 12 9 1204 2462 2866 +3201 2 2 12 9 1116 2420 2701 +3202 2 2 12 9 880 2084 1720 +3203 2 2 12 9 205 206 3068 +3204 2 2 12 9 1485 3379 2116 +3205 2 2 12 9 720 1961 1845 +3206 2 2 12 9 732 3264 1684 +3207 2 2 12 9 486 2797 2120 +3208 2 2 12 9 487 2121 2798 +3209 2 2 12 9 422 1530 2898 +3210 2 2 12 9 1049 2492 1926 +3211 2 2 12 9 1759 3305 1928 +3212 2 2 12 9 709 3013 2060 +3213 2 2 12 9 1073 1728 2066 +3214 2 2 12 9 1079 3194 1535 +3215 2 2 12 9 13 14 1910 +3216 2 2 12 9 1295 2925 2767 +3217 2 2 12 9 846 2977 2086 +3218 2 2 12 9 804 2029 1774 +3219 2 2 12 9 831 2181 1640 +3220 2 2 12 9 606 2198 1882 +3221 2 2 12 9 864 2480 2251 +3222 2 2 12 9 444 3211 1558 +3223 2 2 12 9 937 2826 2821 +3224 2 2 12 9 2115 3489 3266 +3225 2 2 12 9 1424 3074 2821 +3226 2 2 12 9 871 2510 1558 +3227 2 2 12 9 886 2438 3194 +3228 2 2 12 9 423 1590 3048 +3229 2 2 12 9 468 3417 1474 +3230 2 2 12 9 864 2116 2046 +3231 2 2 12 9 628 1999 2795 +3232 2 2 12 9 832 1940 2296 +3233 2 2 12 9 755 1983 3054 +3234 2 2 12 9 438 2193 3026 +3235 2 2 12 9 797 1524 3189 +3236 2 2 12 9 16 2671 2283 +3237 2 2 12 9 611 3074 2577 +3238 2 2 12 9 840 1658 3171 +3239 2 2 12 9 841 3172 1659 +3240 2 2 12 9 1115 2511 1992 +3241 2 2 12 9 1017 2201 2908 +3242 2 2 12 9 1510 3443 3385 +3243 2 2 12 9 1511 3386 3444 +3244 2 2 12 9 799 3188 1525 +3245 2 2 12 9 428 1577 3449 +3246 2 2 12 9 1183 2424 2473 +3247 2 2 12 9 1313 3561 3132 +3248 2 2 12 9 567 2010 1878 +3249 2 2 12 9 1314 3133 3562 +3250 2 2 12 9 407 3001 1919 +3251 2 2 12 9 1379 1837 2506 +3252 2 2 12 9 396 1552 2632 +3253 2 2 12 9 808 3243 1743 +3254 2 2 12 9 809 1744 3244 +3255 2 2 12 9 613 2176 3356 +3256 2 2 12 9 1260 3173 2938 +3257 2 2 12 9 1261 2939 3174 +3258 2 2 12 9 470 2683 1538 +3259 2 2 12 9 948 2910 3531 +3260 2 2 12 9 1582 3200 3567 +3261 2 2 12 9 1583 3568 3201 +3262 2 2 12 9 697 1930 3043 +3263 2 2 12 9 669 2328 1770 +3264 2 2 12 9 1098 2623 1670 +3265 2 2 12 9 512 2174 1656 +3266 2 2 12 9 948 3531 1867 +3267 2 2 12 9 1477 3356 2176 +3268 2 2 12 9 867 1620 2409 +3269 2 2 12 9 1675 2014 3381 +3270 2 2 12 9 876 1621 2455 +3271 2 2 12 9 958 2750 2726 +3272 2 2 12 9 921 1613 2841 +3273 2 2 12 9 653 1664 3537 +3274 2 2 12 9 549 2227 1611 +3275 2 2 12 9 389 1944 2616 +3276 2 2 12 9 1103 3014 3249 +3277 2 2 12 9 1111 2022 2497 +3278 2 2 12 9 539 2286 1634 +3279 2 2 12 9 963 2602 3275 +3280 2 2 12 9 1009 3630 1827 +3281 2 2 12 9 857 1998 2392 +3282 2 2 12 9 1051 1791 3477 +3283 2 2 12 9 1129 1763 3437 +3284 2 2 12 9 826 2164 1814 +3285 2 2 12 9 1271 1700 2215 +3286 2 2 12 9 1272 2216 1701 +3287 2 2 12 9 545 3635 1570 +3288 2 2 12 9 792 2735 1782 +3289 2 2 12 9 804 1777 2379 +3290 2 2 12 9 699 1544 3301 +3291 2 2 12 9 860 2142 1660 +3292 2 2 12 9 861 1661 2143 +3293 2 2 12 9 649 2425 1907 +3294 2 2 12 9 1352 1670 2623 +3295 2 2 12 9 1678 3510 2334 +3296 2 2 12 9 1015 3200 1816 +3297 2 2 12 9 1016 1817 3201 +3298 2 2 12 9 920 2584 1562 +3299 2 2 12 9 621 2845 2872 +3300 2 2 12 9 742 2606 1544 +3301 2 2 12 9 765 3131 2179 +3302 2 2 12 9 642 2993 2108 +3303 2 2 12 9 892 3546 3486 +3304 2 2 12 9 1186 1638 3345 +3305 2 2 12 9 1152 3044 1635 +3306 2 2 12 9 460 3459 3515 +3307 2 2 12 9 838 3265 1581 +3308 2 2 12 9 438 3026 1492 +3309 2 2 12 9 813 2518 2188 +3310 2 2 12 9 660 3020 1570 +3311 2 2 12 9 931 2134 2086 +3312 2 2 12 9 1052 2428 2140 +3313 2 2 12 9 695 3352 1594 +3314 2 2 12 9 1207 3285 1839 +3315 2 2 12 9 1203 3077 2964 +3316 2 2 12 9 515 2055 1705 +3317 2 2 12 9 480 2972 1872 +3318 2 2 12 9 801 2664 2013 +3319 2 2 12 9 402 2015 2527 +3320 2 2 12 9 1018 1515 2940 +3321 2 2 12 9 914 2206 2707 +3322 2 2 12 9 1100 2336 1600 +3323 2 2 12 9 1101 1601 2337 +3324 2 2 12 9 464 1796 2011 +3325 2 2 12 9 465 2012 1797 +3326 2 2 12 9 555 2482 1673 +3327 2 2 12 9 1284 2060 3013 +3328 2 2 12 9 340 2593 1522 +3329 2 2 12 9 1246 2772 2212 +3330 2 2 12 9 854 2163 3388 +3331 2 2 12 9 701 1635 2855 +3332 2 2 12 9 1020 2596 3642 +3333 2 2 12 9 847 1565 2994 +3334 2 2 12 9 848 2995 1566 +3335 2 2 12 9 478 2573 2129 +3336 2 2 12 9 479 2130 2574 +3337 2 2 12 9 1074 1558 3211 +3338 2 2 12 9 869 2898 1530 +3339 2 2 12 9 1268 2352 3306 +3340 2 2 12 9 815 1698 2388 +3341 2 2 12 9 673 2826 2298 +3342 2 2 12 9 816 2389 1699 +3343 2 2 12 9 341 3441 2522 +3344 2 2 12 9 887 1780 2234 +3345 2 2 12 9 909 1559 2699 +3346 2 2 12 9 621 1839 3285 +3347 2 2 12 9 776 2133 2568 +3348 2 2 12 9 796 2032 1702 +3349 2 2 12 9 904 1494 3454 +3350 2 2 12 9 876 2580 3306 +3351 2 2 12 9 905 3455 1495 +3352 2 2 12 9 1139 2568 2133 +3353 2 2 12 9 799 2038 1732 +3354 2 2 12 9 1318 2758 2266 +3355 2 2 12 9 1319 2267 2759 +3356 2 2 12 9 1196 1643 3104 +3357 2 2 12 9 896 1770 2328 +3358 2 2 12 9 565 2828 2042 +3359 2 2 12 9 488 2805 2200 +3360 2 2 12 9 1054 1572 2723 +3361 2 2 12 9 641 1629 3404 +3362 2 2 12 9 52 1721 3218 +3363 2 2 12 9 169 3219 1722 +3364 2 2 12 9 458 3348 2504 +3365 2 2 12 9 764 3499 2005 +3366 2 2 12 9 673 1671 2826 +3367 2 2 12 9 47 48 2051 +3368 2 2 12 9 173 174 2052 +3369 2 2 12 9 456 2606 1739 +3370 2 2 12 9 797 3189 1592 +3371 2 2 12 9 1073 2066 2346 +3372 2 2 12 9 684 3113 3185 +3373 2 2 12 9 1004 2023 1861 +3374 2 2 12 9 1005 1862 2024 +3375 2 2 12 9 1849 2861 3595 +3376 2 2 12 9 430 1569 3269 +3377 2 2 12 9 434 1565 2712 +3378 2 2 12 9 435 2713 1566 +3379 2 2 12 9 680 1619 2327 +3380 2 2 12 9 672 3238 1778 +3381 2 2 12 9 983 3028 1493 +3382 2 2 12 9 643 3613 1643 +3383 2 2 12 9 543 3200 1582 +3384 2 2 12 9 544 1583 3201 +3385 2 2 12 9 756 1904 3279 +3386 2 2 12 9 358 2714 3470 +3387 2 2 12 9 757 3280 1905 +3388 2 2 12 9 871 1558 2695 +3389 2 2 12 9 454 2155 1888 +3390 2 2 12 9 1060 1729 2145 +3391 2 2 12 9 455 1889 2156 +3392 2 2 12 9 855 2268 2157 +3393 2 2 12 9 488 2093 2805 +3394 2 2 12 9 1069 3522 1596 +3395 2 2 12 9 1357 2486 1700 +3396 2 2 12 9 1358 1701 2487 +3397 2 2 12 9 535 3429 2854 +3398 2 2 12 9 660 1526 3020 +3399 2 2 12 9 415 2145 1729 +3400 2 2 12 9 803 2212 2772 +3401 2 2 12 9 799 1595 3188 +3402 2 2 12 9 1054 2571 1572 +3403 2 2 12 9 917 1882 2198 +3404 2 2 12 9 1097 1591 3250 +3405 2 2 12 9 1207 3038 1934 +3406 2 2 12 9 911 2440 2094 +3407 2 2 12 9 912 2095 2441 +3408 2 2 12 9 641 1592 3189 +3409 2 2 12 9 1076 1646 2446 +3410 2 2 12 9 272 2903 1647 +3411 2 2 12 9 1013 2891 1860 +3412 2 2 12 9 976 3020 1526 +3413 2 2 12 9 729 2175 1826 +3414 2 2 12 9 1674 2071 3256 +3415 2 2 12 9 383 2470 1556 +3416 2 2 12 9 1108 2042 2828 +3417 2 2 12 9 937 2821 3074 +3418 2 2 12 9 1002 2643 1573 +3419 2 2 12 9 937 3008 2826 +3420 2 2 12 9 808 3218 1721 +3421 2 2 12 9 809 1722 3219 +3422 2 2 12 9 535 2445 3429 +3423 2 2 12 9 1014 1809 2757 +3424 2 2 12 9 1602 1930 3474 +3425 2 2 12 9 1012 1963 2976 +3426 2 2 12 9 347 2595 2699 +3427 2 2 12 9 817 2589 1741 +3428 2 2 12 9 1486 3185 3113 +3429 2 2 12 9 940 1549 2380 +3430 2 2 12 9 501 1902 2037 +3431 2 2 12 9 888 2062 1920 +3432 2 2 12 9 814 1604 2493 +3433 2 2 12 9 964 1528 2936 +3434 2 2 12 9 965 2937 1529 +3435 2 2 12 9 554 2517 2997 +3436 2 2 12 9 558 2837 2100 +3437 2 2 12 9 375 2187 1753 +3438 2 2 12 9 492 1652 3536 +3439 2 2 12 9 1052 3193 1712 +3440 2 2 12 9 644 3407 1642 +3441 2 2 12 9 833 1782 2124 +3442 2 2 12 9 1604 2883 1024 +3443 2 2 12 9 931 3302 1512 +3444 2 2 12 9 453 2628 1555 +3445 2 2 12 9 1014 2184 3442 +3446 2 2 12 9 644 3188 1595 +3447 2 2 12 9 1938 2546 3498 +3448 2 2 12 9 480 1690 2972 +3449 2 2 12 9 304 305 2535 +3450 2 2 12 9 1477 3202 3399 +3451 2 2 12 9 890 1662 2702 +3452 2 2 12 9 891 2703 1663 +3453 2 2 12 9 1184 2251 2480 +3454 2 2 12 9 646 2824 2315 +3455 2 2 12 9 1379 3278 1879 +3456 2 2 12 9 752 1892 2979 +3457 2 2 12 9 846 2086 2134 +3458 2 2 12 9 753 2980 1893 +3459 2 2 12 9 714 2928 1639 +3460 2 2 12 9 1225 2100 2837 +3461 2 2 12 9 276 277 2238 +3462 2 2 12 9 411 1780 2240 +3463 2 2 12 9 956 2596 2280 +3464 2 2 12 9 537 2871 2226 +3465 2 2 12 9 189 190 2068 +3466 2 2 12 9 2082 2559 3558 +3467 2 2 12 9 2083 3559 2560 +3468 2 2 12 9 1189 2795 1999 +3469 2 2 12 9 1121 2739 2043 +3470 2 2 12 9 1122 2044 2740 +3471 2 2 12 9 975 2513 3003 +3472 2 2 12 9 933 1619 2842 +3473 2 2 12 9 272 1647 3148 +3474 2 2 12 9 641 3432 1629 +3475 2 2 12 9 346 1856 2657 +3476 2 2 12 9 498 2475 1966 +3477 2 2 12 9 744 1533 2994 +3478 2 2 12 9 745 2995 1534 +3479 2 2 12 9 925 2215 1700 +3480 2 2 12 9 926 1701 2216 +3481 2 2 12 9 916 2872 1603 +3482 2 2 12 9 1507 2049 2717 +3483 2 2 12 9 1247 3465 2067 +3484 2 2 12 9 660 1570 2998 +3485 2 2 12 9 710 1598 3466 +3486 2 2 12 9 711 3467 1599 +3487 2 2 12 9 1053 2285 1611 +3488 2 2 12 9 895 2460 1593 +3489 2 2 12 9 186 1632 2399 +3490 2 2 12 9 595 1559 2634 +3491 2 2 12 9 851 1634 2300 +3492 2 2 12 9 1121 2025 3319 +3493 2 2 12 9 1122 3320 2026 +3494 2 2 12 9 469 1553 2679 +3495 2 2 12 9 346 2253 1856 +3496 2 2 12 9 197 2454 1580 +3497 2 2 12 9 703 1789 3632 +3498 2 2 12 9 523 2124 1782 +3499 2 2 12 9 820 2273 3369 +3500 2 2 12 9 821 3370 2274 +3501 2 2 12 9 457 3316 1955 +3502 2 2 12 9 749 2061 2851 +3503 2 2 12 9 1161 2488 1683 +3504 2 2 12 9 986 3466 1598 +3505 2 2 12 9 987 1599 3467 +3506 2 2 12 9 727 3311 1622 +3507 2 2 12 9 728 1623 3312 +3508 2 2 12 9 1172 3354 2159 +3509 2 2 12 9 680 2842 1619 +3510 2 2 12 9 800 1875 2018 +3511 2 2 12 9 1364 3112 3242 +3512 2 2 12 9 1378 3526 2812 +3513 2 2 12 9 801 2013 1883 +3514 2 2 12 9 241 2600 1743 +3515 2 2 12 9 335 1744 2601 +3516 2 2 12 9 642 2684 2993 +3517 2 2 12 9 583 3085 2233 +3518 2 2 12 9 1141 3404 1629 +3519 2 2 12 9 883 3363 1666 +3520 2 2 12 9 279 280 1971 +3521 2 2 12 9 359 3024 1546 +3522 2 2 12 9 1234 2039 2233 +3523 2 2 12 9 707 2745 2255 +3524 2 2 12 9 708 2256 2746 +3525 2 2 12 9 868 1878 2010 +3526 2 2 12 9 419 3165 1870 +3527 2 2 12 9 1282 2517 3255 +3528 2 2 12 9 808 1766 3218 +3529 2 2 12 9 809 3219 1767 +3530 2 2 12 9 844 2160 2218 +3531 2 2 12 9 904 2155 2213 +3532 2 2 12 9 905 2214 2156 +3533 2 2 12 9 984 2686 2341 +3534 2 2 12 9 518 1675 3153 +3535 2 2 12 9 719 3124 1628 +3536 2 2 12 9 1321 1984 3161 +3537 2 2 12 9 1235 2707 2206 +3538 2 2 12 9 1606 2301 3066 +3539 2 2 12 9 1607 3067 2302 +3540 2 2 12 9 673 1633 2889 +3541 2 2 12 9 1273 2609 1828 +3542 2 2 12 9 1065 3349 2249 +3543 2 2 12 9 638 3481 2846 +3544 2 2 12 9 683 1563 3167 +3545 2 2 12 9 920 2774 1539 +3546 2 2 12 9 1107 2527 2015 +3547 2 2 12 9 1557 3178 1939 +3548 2 2 12 9 1090 1658 2449 +3549 2 2 12 9 652 1522 3157 +3550 2 2 12 9 1091 2450 1659 +3551 2 2 12 9 831 1645 2412 +3552 2 2 12 9 636 1746 3364 +3553 2 2 12 9 854 3388 2474 +3554 2 2 12 9 1074 3283 1558 +3555 2 2 12 9 789 2454 1783 +3556 2 2 12 9 1333 2298 2826 +3557 2 2 12 9 481 1585 2325 +3558 2 2 12 9 482 2326 1586 +3559 2 2 12 9 859 2187 1894 +3560 2 2 12 9 804 2004 2029 +3561 2 2 12 9 221 222 2230 +3562 2 2 12 9 449 1866 3123 +3563 2 2 12 9 1545 3387 3400 +3564 2 2 12 9 1086 2616 1944 +3565 2 2 12 9 644 1642 3458 +3566 2 2 12 9 1317 2233 3600 +3567 2 2 12 9 764 2176 3499 +3568 2 2 12 9 909 2811 1914 +3569 2 2 12 9 434 1574 2987 +3570 2 2 12 9 435 2988 1575 +3571 2 2 12 9 772 2704 3178 +3572 2 2 12 9 1313 3132 2434 +3573 2 2 12 9 533 2543 1631 +3574 2 2 12 9 1314 2435 3133 +3575 2 2 12 9 1062 2709 2907 +3576 2 2 12 9 1133 1924 2960 +3577 2 2 12 9 1134 2961 1925 +3578 2 2 12 9 916 1603 2951 +3579 2 2 12 9 945 2140 2428 +3580 2 2 12 9 1207 3300 3038 +3581 2 2 12 9 932 2239 1833 +3582 2 2 12 9 1009 2542 3630 +3583 2 2 12 9 693 3487 2460 +3584 2 2 12 9 426 1606 2875 +3585 2 2 12 9 427 2876 1607 +3586 2 2 12 9 522 2348 2539 +3587 2 2 12 9 378 2668 1688 +3588 2 2 12 9 440 1539 2774 +3589 2 2 12 9 563 1650 3421 +3590 2 2 12 9 867 2614 1620 +3591 2 2 12 9 645 1594 3507 +3592 2 2 12 9 718 2247 3577 +3593 2 2 12 9 700 1590 2499 +3594 2 2 12 9 464 2011 2288 +3595 2 2 12 9 465 2289 2012 +3596 2 2 12 9 307 2357 1703 +3597 2 2 12 9 502 2082 3558 +3598 2 2 12 9 503 3559 2083 +3599 2 2 12 9 1022 1966 2475 +3600 2 2 12 9 3344 1604 1024 +3601 2 2 12 9 1038 1748 3120 +3602 2 2 12 9 657 1795 2341 +3603 2 2 12 9 239 3243 1721 +3604 2 2 12 9 337 1722 3244 +3605 2 2 12 9 42 1800 3083 +3606 2 2 12 9 179 3084 1801 +3607 2 2 12 9 371 3385 3443 +3608 2 2 12 9 744 2994 1565 +3609 2 2 12 9 372 3444 3386 +3610 2 2 12 9 745 1566 2995 +3611 2 2 12 9 760 1816 2137 +3612 2 2 12 9 761 2138 1817 +3613 2 2 12 9 283 2932 1733 +3614 2 2 12 9 843 1629 3432 +3615 2 2 12 9 997 3637 1660 +3616 2 2 12 9 998 1661 3638 +3617 2 2 12 9 1331 2229 3249 +3618 2 2 12 9 842 2109 2200 +3619 2 2 12 9 1142 1642 3407 +3620 2 2 12 9 1594 3352 2522 +3621 2 2 12 9 698 2396 1689 +3622 2 2 12 9 782 2259 1624 +3623 2 2 12 9 1864 2152 3203 +3624 2 2 12 9 1816 3200 2137 +3625 2 2 12 9 839 2475 1823 +3626 2 2 12 9 1817 2138 3201 +3627 2 2 12 9 518 3246 1675 +3628 2 2 12 9 831 1640 3010 +3629 2 2 12 9 640 1596 3522 +3630 2 2 12 9 914 1673 2482 +3631 2 2 12 9 1536 2907 2709 +3632 2 2 12 9 516 1887 3107 +3633 2 2 12 9 367 3440 1613 +3634 2 2 12 9 263 2515 1786 +3635 2 2 12 9 313 1787 2516 +3636 2 2 12 9 716 3403 1860 +3637 2 2 12 9 294 1737 2959 +3638 2 2 12 9 1361 3289 2561 +3639 2 2 12 9 851 2635 1634 +3640 2 2 12 9 295 296 1994 +3641 2 2 12 9 489 1899 3573 +3642 2 2 12 9 490 3145 1633 +3643 2 2 12 9 805 3433 1681 +3644 2 2 12 9 973 2288 2011 +3645 2 2 12 9 952 2947 1756 +3646 2 2 12 9 1002 1573 2752 +3647 2 2 12 9 974 2012 2289 +3648 2 2 12 9 796 1811 2459 +3649 2 2 12 9 286 3192 1707 +3650 2 2 12 9 907 1553 3071 +3651 2 2 12 9 21 3551 3114 +3652 2 2 12 9 1088 2094 2440 +3653 2 2 12 9 1089 2441 2095 +3654 2 2 12 9 702 2757 1809 +3655 2 2 12 9 1273 3419 2897 +3656 2 2 12 9 24 2385 1720 +3657 2 2 12 9 501 2553 1627 +3658 2 2 12 9 1425 2699 2595 +3659 2 2 12 9 1298 2492 1758 +3660 2 2 12 9 1117 3143 2360 +3661 2 2 12 9 845 3458 1642 +3662 2 2 12 9 719 1747 2530 +3663 2 2 12 9 1150 2887 1979 +3664 2 2 12 9 1593 2460 3487 +3665 2 2 12 9 1360 2248 2787 +3666 2 2 12 9 721 1979 2887 +3667 2 2 12 9 566 1621 2766 +3668 2 2 12 9 658 1537 3111 +3669 2 2 12 9 500 3205 1974 +3670 2 2 12 9 652 1620 2614 +3671 2 2 12 9 2522 3352 1109 +3672 2 2 12 9 244 2651 1710 +3673 2 2 12 9 332 1711 2652 +3674 2 2 12 9 922 2724 1624 +3675 2 2 12 9 947 1621 2352 +3676 2 2 12 9 732 1684 2617 +3677 2 2 12 9 1587 3319 2677 +3678 2 2 12 9 1588 2678 3320 +3679 2 2 12 9 646 3275 1517 +3680 2 2 12 9 1281 2595 2664 +3681 2 2 12 9 723 1698 3596 +3682 2 2 12 9 724 3597 1699 +3683 2 2 12 9 806 1622 2852 +3684 2 2 12 9 394 1727 2879 +3685 2 2 12 9 807 2853 1623 +3686 2 2 12 9 1412 2914 2831 +3687 2 2 12 9 1350 2315 2824 +3688 2 2 12 9 50 1766 2763 +3689 2 2 12 9 171 2764 1767 +3690 2 2 12 9 485 1841 2139 +3691 2 2 12 9 346 2064 3041 +3692 2 2 12 9 666 2554 3461 +3693 2 2 12 9 689 2900 1846 +3694 2 2 12 9 690 1847 2901 +3695 2 2 12 9 1060 2145 3022 +3696 2 2 12 9 802 1552 2948 +3697 2 2 12 9 213 3104 1643 +3698 2 2 12 9 665 2414 1687 +3699 2 2 12 9 1031 1864 2915 +3700 2 2 12 9 539 1634 2635 +3701 2 2 12 9 185 186 2399 +3702 2 2 12 9 713 2446 1646 +3703 2 2 12 9 1360 2768 2237 +3704 2 2 12 9 470 1538 2892 +3705 2 2 12 9 874 2394 1608 +3706 2 2 12 9 755 2078 1985 +3707 2 2 12 9 1877 2462 2909 +3708 2 2 12 9 1073 3115 2211 +3709 2 2 12 9 22 2694 1792 +3710 2 2 12 9 531 2676 3347 +3711 2 2 12 9 519 2388 1698 +3712 2 2 12 9 262 1786 2731 +3713 2 2 12 9 314 2732 1787 +3714 2 2 12 9 520 1699 2389 +3715 2 2 12 9 30 1818 3015 +3716 2 2 12 9 2265 3023 3584 +3717 2 2 12 9 558 2918 1883 +3718 2 2 12 9 1185 2871 2079 +3719 2 2 12 9 390 2352 3374 +3720 2 2 12 9 892 2843 1564 +3721 2 2 12 9 1094 3153 1675 +3722 2 2 12 9 822 2778 1665 +3723 2 2 12 9 907 2679 1553 +3724 2 2 12 9 687 1924 2195 +3725 2 2 12 9 441 1681 2488 +3726 2 2 12 9 688 2196 1925 +3727 2 2 12 9 652 3003 1620 +3728 2 2 12 9 1202 1617 3284 +3729 2 2 12 9 1336 3372 2762 +3730 2 2 12 9 373 3093 2690 +3731 2 2 12 9 892 2498 3546 +3732 2 2 12 9 374 2691 3094 +3733 2 2 12 9 1191 1985 2078 +3734 2 2 12 9 1065 3175 3349 +3735 2 2 12 9 876 2240 1780 +3736 2 2 12 9 508 3399 2168 +3737 2 2 12 9 798 3076 1950 +3738 2 2 12 9 383 1649 2490 +3739 2 2 12 9 1271 2255 2745 +3740 2 2 12 9 1272 2746 2256 +3741 2 2 12 9 836 3431 1719 +3742 2 2 12 9 827 2293 2643 +3743 2 2 12 9 1277 3187 2408 +3744 2 2 12 9 463 1564 2843 +3745 2 2 12 9 466 1657 2473 +3746 2 2 12 9 802 2473 3445 +3747 2 2 12 9 358 2624 1612 +3748 2 2 12 9 603 2970 2902 +3749 2 2 12 9 281 1805 2674 +3750 2 2 12 9 884 2499 1590 +3751 2 2 12 9 380 3380 1591 +3752 2 2 12 9 1256 3470 2035 +3753 2 2 12 9 1170 1664 2484 +3754 2 2 12 9 581 2281 3644 +3755 2 2 12 9 582 3645 2282 +3756 2 2 12 9 256 257 2242 +3757 2 2 12 9 319 320 2243 +3758 2 2 12 9 990 3002 1556 +3759 2 2 12 9 469 2345 1669 +3760 2 2 12 9 1164 2467 2420 +3761 2 2 12 9 722 1653 3138 +3762 2 2 12 9 659 1546 3296 +3763 2 2 12 9 940 3393 1549 +3764 2 2 12 9 244 1710 3602 +3765 2 2 12 9 332 3603 1711 +3766 2 2 12 9 826 1877 2453 +3767 2 2 12 9 1372 1577 3264 +3768 2 2 12 9 291 1738 3270 +3769 2 2 12 9 1027 2708 2019 +3770 2 2 12 9 839 2015 2422 +3771 2 2 12 9 1054 1579 3500 +3772 2 2 12 9 340 3528 1670 +3773 2 2 12 9 493 2838 1970 +3774 2 2 12 9 1265 2829 1584 +3775 2 2 12 9 1263 2252 3633 +3776 2 2 12 9 382 2518 2072 +3777 2 2 12 9 1017 3578 1573 +3778 2 2 12 9 705 3066 1824 +3779 2 2 12 9 706 1825 3067 +3780 2 2 12 9 382 1630 3021 +3781 2 2 12 9 616 2295 3304 +3782 2 2 12 9 2114 2568 3348 +3783 2 2 12 9 363 3120 1748 +3784 2 2 12 9 515 2181 2497 +3785 2 2 12 9 537 2079 2871 +3786 2 2 12 9 2145 3511 3022 +3787 2 2 12 9 813 2188 1769 +3788 2 2 12 9 930 2532 2323 +3789 2 2 12 9 460 3515 1779 +3790 2 2 12 9 865 3184 2303 +3791 2 2 12 9 346 2004 2253 +3792 2 2 12 9 281 3492 1805 +3793 2 2 12 9 517 2685 1988 +3794 2 2 12 9 1413 3261 3101 +3795 2 2 12 9 228 229 2019 +3796 2 2 12 9 1102 2283 2671 +3797 2 2 12 9 1207 1934 3323 +3798 2 2 12 9 985 1687 2414 +3799 2 2 12 9 673 2889 1671 +3800 2 2 12 9 909 2634 1559 +3801 2 2 12 9 641 3404 1592 +3802 2 2 12 9 426 2639 1560 +3803 2 2 12 9 344 1592 3406 +3804 2 2 12 9 427 1561 2640 +3805 2 2 12 9 1008 2218 2160 +3806 2 2 12 9 383 1556 3002 +3807 2 2 12 9 890 2660 1662 +3808 2 2 12 9 891 1663 2661 +3809 2 2 12 9 297 298 2063 +3810 2 2 12 9 516 2361 1871 +3811 2 2 12 9 837 1773 2997 +3812 2 2 12 9 555 2609 2482 +3813 2 2 12 9 378 1768 2668 +3814 2 2 12 9 604 2831 2914 +3815 2 2 12 9 672 1641 3238 +3816 2 2 12 9 35 2469 1672 +3817 2 2 12 9 1494 3050 3454 +3818 2 2 12 9 1495 3455 3051 +3819 2 2 12 9 510 1791 2186 +3820 2 2 12 9 883 2151 2701 +3821 2 2 12 9 1202 3626 1641 +3822 2 2 12 9 347 2664 2595 +3823 2 2 12 9 1842 2380 3391 +3824 2 2 12 9 532 1916 2442 +3825 2 2 12 9 1129 3437 2785 +3826 2 2 12 9 1145 2489 3461 +3827 2 2 12 9 911 3006 1615 +3828 2 2 12 9 912 1616 3007 +3829 2 2 12 9 774 1863 2625 +3830 2 2 12 9 834 2882 1691 +3831 2 2 12 9 872 3238 1641 +3832 2 2 12 9 911 2987 1574 +3833 2 2 12 9 912 1575 2988 +3834 2 2 12 9 7 8 3101 +3835 2 2 12 9 1152 1635 3587 +3836 2 2 12 9 286 1707 2989 +3837 2 2 12 9 860 1660 2377 +3838 2 2 12 9 861 2378 1661 +3839 2 2 12 9 1394 1870 3165 +3840 2 2 12 9 460 1779 2225 +3841 2 2 12 9 818 2205 3249 +3842 2 2 12 9 644 1595 3407 +3843 2 2 12 9 749 1931 2061 +3844 2 2 12 9 228 2019 2708 +3845 2 2 12 9 1103 2807 2112 +3846 2 2 12 9 591 2767 2925 +3847 2 2 12 9 838 2418 1749 +3848 2 2 12 9 1229 2449 1658 +3849 2 2 12 9 1230 1659 2450 +3850 2 2 12 9 1308 3224 2263 +3851 2 2 12 9 1037 2028 2361 +3852 2 2 12 9 493 2686 2838 +3853 2 2 12 9 968 1880 2507 +3854 2 2 12 9 517 3152 1714 +3855 2 2 12 9 932 2258 2239 +3856 2 2 12 9 441 3273 2520 +3857 2 2 12 9 946 2957 1792 +3858 2 2 12 9 752 2103 1892 +3859 2 2 12 9 753 1893 2104 +3860 2 2 12 9 1301 2985 2692 +3861 2 2 12 9 1302 2693 2986 +3862 2 2 12 9 1114 1988 2685 +3863 2 2 12 9 1065 2349 1771 +3864 2 2 12 9 629 3400 3387 +3865 2 2 12 9 512 1656 2717 +3866 2 2 12 9 1051 1733 2932 +3867 2 2 12 9 478 3016 2573 +3868 2 2 12 9 479 2574 3017 +3869 2 2 12 9 1568 3515 3459 +3870 2 2 12 9 904 1888 2155 +3871 2 2 12 9 905 2156 1889 +3872 2 2 12 9 1066 2320 1941 +3873 2 2 12 9 1067 1942 2321 +3874 2 2 12 9 1341 2445 1983 +3875 2 2 12 9 3319 650 2677 +3876 2 2 12 9 584 2263 3224 +3877 2 2 12 9 3320 2678 651 +3878 2 2 12 9 828 2190 3540 +3879 2 2 12 9 1657 3445 2473 +3880 2 2 12 9 880 1720 2385 +3881 2 2 12 9 386 2785 1644 +3882 2 2 12 9 1179 3081 2410 +3883 2 2 12 9 1180 2411 3082 +3884 2 2 12 9 496 2952 2727 +3885 2 2 12 9 553 2806 1638 +3886 2 2 12 9 991 2200 2109 +3887 2 2 12 9 1059 2959 1737 +3888 2 2 12 9 504 1906 2199 +3889 2 2 12 9 460 3647 1914 +3890 2 2 12 9 256 2242 2043 +3891 2 2 12 9 320 2044 2243 +3892 2 2 12 9 1273 2482 2609 +3893 2 2 12 9 198 1783 2454 +3894 2 2 12 9 898 2029 2004 +3895 2 2 12 9 847 2591 1857 +3896 2 2 12 9 848 1858 2592 +3897 2 2 12 9 942 2239 2131 +3898 2 2 12 9 714 1639 3004 +3899 2 2 12 9 768 2375 3293 +3900 2 2 12 9 769 3294 2376 +3901 2 2 12 9 684 3185 1644 +3902 2 2 12 9 570 3099 2400 +3903 2 2 12 9 935 2055 2497 +3904 2 2 12 9 658 1665 2815 +3905 2 2 12 9 1025 1676 2368 +3906 2 2 12 9 828 1813 2511 +3907 2 2 12 9 844 2621 2160 +3908 2 2 12 9 832 2296 2556 +3909 2 2 12 9 556 2638 2201 +3910 2 2 12 9 1120 1943 2180 +3911 2 2 12 9 420 2610 1696 +3912 2 2 12 9 421 1697 2611 +3913 2 2 12 9 451 2434 1997 +3914 2 2 12 9 452 2000 2435 +3915 2 2 12 9 1263 3633 1908 +3916 2 2 12 9 1354 2211 3115 +3917 2 2 12 9 1276 2531 3434 +3918 2 2 12 9 773 2915 1864 +3919 2 2 12 9 1031 2384 2451 +3920 2 2 12 9 1032 2452 2386 +3921 2 2 12 9 596 1808 2663 +3922 2 2 12 9 608 2074 2917 +3923 2 2 12 9 875 1656 2398 +3924 2 2 12 9 1349 2442 1916 +3925 2 2 12 9 514 1704 2299 +3926 2 2 12 9 511 2749 2134 +3927 2 2 12 9 1405 2659 3468 +3928 2 2 12 9 550 2420 2467 +3929 2 2 12 9 1021 2244 2799 +3930 2 2 12 9 692 1678 2924 +3931 2 2 12 9 984 2341 1795 +3932 2 2 12 9 252 253 2088 +3933 2 2 12 9 323 324 2089 +3934 2 2 12 9 620 1838 2762 +3935 2 2 12 9 630 1662 2660 +3936 2 2 12 9 668 1812 3251 +3937 2 2 12 9 631 2661 1663 +3938 2 2 12 9 1183 3260 1597 +3939 2 2 12 9 886 1627 2553 +3940 2 2 12 9 291 2953 1738 +3941 2 2 12 9 872 2359 1778 +3942 2 2 12 9 11 12 2153 +3943 2 2 12 9 1132 3399 3202 +3944 2 2 12 9 1187 1804 2236 +3945 2 2 12 9 1530 2887 1752 +3946 2 2 12 9 51 52 3218 +3947 2 2 12 9 169 170 3219 +3948 2 2 12 9 568 2178 3049 +3949 2 2 12 9 217 218 2067 +3950 2 2 12 9 674 2128 1995 +3951 2 2 12 9 246 1660 3637 +3952 2 2 12 9 330 3638 1661 +3953 2 2 12 9 829 1900 2277 +3954 2 2 12 9 830 2278 1901 +3955 2 2 12 9 947 2766 1621 +3956 2 2 12 9 605 1674 3256 +3957 2 2 12 9 931 2045 2372 +3958 2 2 12 9 32 1950 3076 +3959 2 2 12 9 260 1843 2688 +3960 2 2 12 9 316 2689 1844 +3961 2 2 12 9 450 2119 2531 +3962 2 2 12 9 200 3497 2354 +3963 2 2 12 9 882 2077 3103 +3964 2 2 12 9 911 1615 2987 +3965 2 2 12 9 912 2988 1616 +3966 2 2 12 9 529 1778 2359 +3967 2 2 12 9 448 3604 1584 +3968 2 2 12 9 563 2324 1836 +3969 2 2 12 9 680 1612 2842 +3970 2 2 12 9 383 3002 1649 +3971 2 2 12 9 555 1673 3160 +3972 2 2 12 9 806 1761 2862 +3973 2 2 12 9 1262 3041 2064 +3974 2 2 12 9 807 2864 1762 +3975 2 2 12 9 719 2530 1835 +3976 2 2 12 9 826 1814 2866 +3977 2 2 12 9 562 1658 2641 +3978 2 2 12 9 564 2642 1659 +3979 2 2 12 9 1333 2826 3008 +3980 2 2 12 9 714 1706 2928 +3981 2 2 12 9 823 2275 1854 +3982 2 2 12 9 824 1855 2276 +3983 2 2 12 9 6 2956 214 +3984 2 2 12 9 206 207 2306 +3985 2 2 12 9 382 2680 2518 +3986 2 2 12 9 835 1841 3485 +3987 2 2 12 9 35 36 2469 +3988 2 2 12 9 368 1742 2742 +3989 2 2 12 9 1172 2159 3598 +3990 2 2 12 9 1081 3083 1800 +3991 2 2 12 9 1082 1801 3084 +3992 2 2 12 9 806 2852 2502 +3993 2 2 12 9 807 2503 2853 +3994 2 2 12 9 678 2087 3267 +3995 2 2 12 9 1635 1971 2855 +3996 2 2 12 9 429 2830 1809 +3997 2 2 12 9 471 2379 1777 +3998 2 2 12 9 876 3306 1621 +3999 2 2 12 9 879 2490 1649 +4000 2 2 12 9 1098 2284 2124 +4001 2 2 12 9 1308 2149 3224 +4002 2 2 12 9 400 3323 1934 +4003 2 2 12 9 1250 2279 1784 +4004 2 2 12 9 14 15 2954 +4005 2 2 12 9 1306 2838 2686 +4006 2 2 12 9 375 1753 2496 +4007 2 2 12 9 502 3558 1654 +4008 2 2 12 9 503 1655 3559 +4009 2 2 12 9 1264 2439 1927 +4010 2 2 12 9 942 1833 2239 +4011 2 2 12 9 953 2677 2404 +4012 2 2 12 9 954 2405 2678 +4013 2 2 12 9 1111 2497 2181 +4014 2 2 12 9 1292 2899 3615 +4015 2 2 12 9 387 1758 3151 +4016 2 2 12 9 1093 1714 3152 +4017 2 2 12 9 1337 2481 3514 +4018 2 2 12 9 1203 2190 3077 +4019 2 2 12 9 549 1611 3191 +4020 2 2 12 9 870 2567 2295 +4021 2 2 12 9 490 1913 3145 +4022 2 2 12 9 995 3132 1696 +4023 2 2 12 9 996 1697 3133 +4024 2 2 12 9 202 2294 3231 +4025 2 2 12 9 1003 2327 1932 +4026 2 2 12 9 737 2001 2710 +4027 2 2 12 9 738 2711 2002 +4028 2 2 12 9 624 3493 1667 +4029 2 2 12 9 625 1668 3494 +4030 2 2 12 9 839 3272 2421 +4031 2 2 12 9 470 2892 1648 +4032 2 2 12 9 913 1871 2361 +4033 2 2 12 9 879 1649 2874 +4034 2 2 12 9 836 1719 2431 +4035 2 2 12 9 715 1974 2803 +4036 2 2 12 9 1263 2791 2734 +4037 2 2 12 9 950 2301 2754 +4038 2 2 12 9 951 2755 2302 +4039 2 2 12 9 1465 3618 2591 +4040 2 2 12 9 1466 2592 3619 +4041 2 2 12 9 822 1768 2779 +4042 2 2 12 9 843 3432 1745 +4043 2 2 12 9 1093 2406 1714 +4044 2 2 12 9 493 1628 2850 +4045 2 2 12 9 1350 3496 1677 +4046 2 2 12 9 494 1694 2587 +4047 2 2 12 9 616 1923 2295 +4048 2 2 12 9 495 2588 1695 +4049 2 2 12 9 925 1700 2486 +4050 2 2 12 9 742 1837 2975 +4051 2 2 12 9 926 2487 1701 +4052 2 2 12 9 881 2310 3097 +4053 2 2 12 9 22 23 2694 +4054 2 2 12 9 817 1644 3185 +4055 2 2 12 9 795 2345 2036 +4056 2 2 12 9 205 3068 1853 +4057 2 2 12 9 973 2525 2816 +4058 2 2 12 9 974 2817 2526 +4059 2 2 12 9 713 1675 2446 +4060 2 2 12 9 936 3506 1603 +4061 2 2 12 9 1013 1856 2253 +4062 2 2 12 9 1098 1670 3528 +4063 2 2 12 9 845 1751 3458 +4064 2 2 12 9 230 231 2076 +4065 2 2 12 9 1009 2372 2045 +4066 2 2 12 9 395 2285 3290 +4067 2 2 12 9 1027 3628 1682 +4068 2 2 12 9 357 1749 2418 +4069 2 2 12 9 1209 2521 1757 +4070 2 2 12 9 850 1724 2924 +4071 2 2 12 9 883 2701 2347 +4072 2 2 12 9 854 2474 3255 +4073 2 2 12 9 985 3110 1687 +4074 2 2 12 9 1141 1629 2697 +4075 2 2 12 9 1155 3251 1812 +4076 2 2 12 9 1077 2710 2001 +4077 2 2 12 9 1078 2002 2711 +4078 2 2 12 9 765 2578 1670 +4079 2 2 12 9 863 1731 2348 +4080 2 2 12 9 929 2366 2057 +4081 2 2 12 9 805 1681 2520 +4082 2 2 12 9 930 2058 2367 +4083 2 2 12 9 779 1688 2668 +4084 2 2 12 9 1055 3107 1887 +4085 2 2 12 9 1072 2199 1906 +4086 2 2 12 9 1285 2085 3460 +4087 2 2 12 9 868 2561 3289 +4088 2 2 12 9 971 1738 2904 +4089 2 2 12 9 678 3643 2087 +4090 2 2 12 9 591 2669 1832 +4091 2 2 12 9 700 2499 1822 +4092 2 2 12 9 550 2701 2420 +4093 2 2 12 9 811 1836 2324 +4094 2 2 12 9 1228 3023 2265 +4095 2 2 12 9 19 20 2159 +4096 2 2 12 9 704 1972 3237 +4097 2 2 12 9 1402 2400 3099 +4098 2 2 12 9 1069 3224 2149 +4099 2 2 12 9 522 2500 1833 +4100 2 2 12 9 562 2641 2382 +4101 2 2 12 9 564 2383 2642 +4102 2 2 12 9 1217 1775 2639 +4103 2 2 12 9 1218 2640 1776 +4104 2 2 12 9 349 3284 2005 +4105 2 2 12 9 483 2117 1947 +4106 2 2 12 9 484 1948 2118 +4107 2 2 12 9 363 2431 1719 +4108 2 2 12 9 995 1696 2610 +4109 2 2 12 9 1389 3304 2295 +4110 2 2 12 9 840 2641 1658 +4111 2 2 12 9 996 2611 1697 +4112 2 2 12 9 841 1659 2642 +4113 2 2 12 9 1020 2280 2596 +4114 2 2 12 9 917 2850 1628 +4115 2 2 12 9 532 3095 1916 +4116 2 2 12 9 1142 2673 1642 +4117 2 2 12 9 1512 3302 2698 +4118 2 2 12 9 1169 1631 2725 +4119 2 2 12 9 29 30 3015 +4120 2 2 12 9 1740 3478 2962 +4121 2 2 12 9 1137 3053 1979 +4122 2 2 12 9 481 2893 1585 +4123 2 2 12 9 482 1586 2894 +4124 2 2 12 9 20 21 3114 +4125 2 2 12 9 1007 3421 1650 +4126 2 2 12 9 535 1983 2445 +4127 2 2 12 9 633 3418 3373 +4128 2 2 12 9 665 1740 2962 +4129 2 2 12 9 577 2722 1676 +4130 2 2 12 9 1027 1682 2708 +4131 2 2 12 9 480 2589 2141 +4132 2 2 12 9 1033 2979 1600 +4133 2 2 12 9 1034 1601 2980 +4134 2 2 12 9 992 2057 2366 +4135 2 2 12 9 993 2367 2058 +4136 2 2 12 9 1028 3065 1865 +4137 2 2 12 9 592 1908 3633 +4138 2 2 12 9 990 1649 3002 +4139 2 2 12 9 525 2313 1980 +4140 2 2 12 9 526 1981 2314 +4141 2 2 12 9 927 2900 1716 +4142 2 2 12 9 928 1717 2901 +4143 2 2 12 9 1280 3049 2178 +4144 2 2 12 9 6 215 2956 +4145 2 2 12 9 514 3616 1704 +4146 2 2 12 9 1309 2727 2952 +4147 2 2 12 9 52 3588 1721 +4148 2 2 12 9 169 1722 3589 +4149 2 2 12 9 199 200 2354 +4150 2 2 12 9 1587 2739 3319 +4151 2 2 12 9 1588 3320 2740 +4152 2 2 12 9 1452 3291 1686 +4153 2 2 12 9 1449 3633 2252 +4154 2 2 12 9 995 1997 2434 +4155 2 2 12 9 700 3533 1645 +4156 2 2 12 9 850 2334 1907 +4157 2 2 12 9 996 2435 2000 +4158 2 2 12 9 398 1760 2542 +4159 2 2 12 9 967 1707 3192 +4160 2 2 12 9 572 2152 2451 +4161 2 2 12 9 607 2736 1750 +4162 2 2 12 9 822 2779 3428 +4163 2 2 12 9 985 2663 1808 +4164 2 2 12 9 391 2353 3115 +4165 2 2 12 9 239 1721 3588 +4166 2 2 12 9 337 3589 1722 +4167 2 2 12 9 1194 2917 2074 +4168 2 2 12 9 703 2904 1738 +4169 2 2 12 9 849 1850 2919 +4170 2 2 12 9 789 3427 1634 +4171 2 2 12 9 1068 2543 2208 +4172 2 2 12 9 12 13 2706 +4173 2 2 12 9 459 2038 3489 +4174 2 2 12 9 1119 1647 2903 +4175 2 2 12 9 222 223 3236 +4176 2 2 12 9 903 1995 2128 +4177 2 2 12 9 1593 3585 1958 +4178 2 2 12 9 1081 2508 2169 +4179 2 2 12 9 1082 2170 2509 +4180 2 2 12 9 654 1696 3132 +4181 2 2 12 9 655 3133 1697 +4182 2 2 12 9 521 2131 2239 +4183 2 2 12 9 251 3226 1854 +4184 2 2 12 9 325 1855 3227 +4185 2 2 12 9 610 2552 3028 +4186 2 2 12 9 339 1691 2882 +4187 2 2 12 9 1521 2890 2311 +4188 2 2 12 9 1068 1949 2543 +4189 2 2 12 9 519 1698 3081 +4190 2 2 12 9 520 3082 1699 +4191 2 2 12 9 701 3587 1635 +4192 2 2 12 9 506 2142 2540 +4193 2 2 12 9 507 2541 2143 +4194 2 2 12 9 948 1648 2892 +4195 2 2 12 9 1188 3307 2207 +4196 2 2 12 9 1225 2419 2100 +4197 2 2 12 9 430 1706 2750 +4198 2 2 12 9 946 1627 2957 +4199 2 2 12 9 873 3059 1748 +4200 2 2 12 9 1075 2531 2119 +4201 2 2 12 9 1430 2354 3497 +4202 2 2 12 9 895 1727 2716 +4203 2 2 12 9 1042 1671 2889 +4204 2 2 12 9 747 1769 2550 +4205 2 2 12 9 405 2046 2116 +4206 2 2 12 9 994 2962 3478 +4207 2 2 12 9 936 1603 2845 +4208 2 2 12 9 899 1754 2556 +4209 2 2 12 9 927 1980 2313 +4210 2 2 12 9 558 2100 2777 +4211 2 2 12 9 928 2314 1981 +4212 2 2 12 9 978 1975 2544 +4213 2 2 12 9 979 2545 1976 +4214 2 2 12 9 1543 2902 2167 +4215 2 2 12 9 1072 1638 2913 +4216 2 2 12 9 1360 2787 2768 +4217 2 2 12 9 486 3454 3050 +4218 2 2 12 9 437 1689 3482 +4219 2 2 12 9 487 3051 3455 +4220 2 2 12 9 683 3167 1736 +4221 2 2 12 9 1315 2965 3095 +4222 2 2 12 9 1435 3602 1710 +4223 2 2 12 9 1436 1711 3603 +4224 2 2 12 9 1047 2938 3173 +4225 2 2 12 9 1048 3174 2939 +4226 2 2 12 9 578 3154 1679 +4227 2 2 12 9 579 1680 3155 +4228 2 2 12 9 1427 2710 1897 +4229 2 2 12 9 1428 1898 2711 +4230 2 2 12 9 730 2544 1975 +4231 2 2 12 9 731 1976 2545 +4232 2 2 12 9 857 2203 2810 +4233 2 2 12 9 517 1714 2685 +4234 2 2 12 9 917 2198 2769 +4235 2 2 12 9 1232 3237 1972 +4236 2 2 12 9 1133 2195 1924 +4237 2 2 12 9 1134 1925 2196 +4238 2 2 12 9 1301 2547 2782 +4239 2 2 12 9 1302 2783 2548 +4240 2 2 12 9 402 1687 3110 +4241 2 2 12 9 556 2293 3225 +4242 2 2 12 9 483 1909 2316 +4243 2 2 12 9 484 2317 1911 +4244 2 2 12 9 276 2238 3420 +4245 2 2 12 9 15 16 2283 +4246 2 2 12 9 1640 2835 3366 +4247 2 2 12 9 963 2315 2773 +4248 2 2 12 9 587 1761 2502 +4249 2 2 12 9 1439 2382 2641 +4250 2 2 12 9 1440 2642 2383 +4251 2 2 12 9 588 2503 1762 +4252 2 2 12 9 17 1651 2671 +4253 2 2 12 9 281 282 3492 +4254 2 2 12 9 1012 1913 2621 +4255 2 2 12 9 1493 3028 2552 +4256 2 2 12 9 1112 2150 2735 +4257 2 2 12 9 1295 1851 2925 +4258 2 2 12 9 239 240 3243 +4259 2 2 12 9 336 337 3244 +4260 2 2 12 9 665 2934 1740 +4261 2 2 12 9 533 2208 2543 +4262 2 2 12 9 723 1775 3548 +4263 2 2 12 9 1445 3253 1810 +4264 2 2 12 9 724 3549 1776 +4265 2 2 12 9 1260 2605 2313 +4266 2 2 12 9 1261 2314 2607 +4267 2 2 12 9 441 1602 3273 +4268 2 2 12 9 857 2810 2231 +4269 2 2 12 9 685 1690 2700 +4270 2 2 12 9 550 2467 3529 +4271 2 2 12 9 1383 3307 3582 +4272 2 2 12 9 781 2595 3337 +4273 2 2 12 9 1031 2451 2152 +4274 2 2 12 9 925 2464 2737 +4275 2 2 12 9 1513 3079 3315 +4276 2 2 12 9 926 2738 2465 +4277 2 2 12 9 418 3423 3612 +4278 2 2 12 9 971 3270 1738 +4279 2 2 12 9 1539 3255 2474 +4280 2 2 12 9 1277 2408 2113 +4281 2 2 12 9 1525 3529 2467 +4282 2 2 12 9 480 1741 2589 +4283 2 2 12 9 471 1664 2891 +4284 2 2 12 9 1418 2087 3643 +4285 2 2 12 9 832 3430 1984 +4286 2 2 12 9 750 3490 1708 +4287 2 2 12 9 751 1709 3491 +4288 2 2 12 9 804 2253 2004 +4289 2 2 12 9 381 1746 2569 +4290 2 2 12 9 418 3612 2594 +4291 2 2 12 9 197 198 2454 +4292 2 2 12 9 856 2808 2202 +4293 2 2 12 9 442 1665 2778 +4294 2 2 12 9 720 3142 1753 +4295 2 2 12 9 758 1759 2443 +4296 2 2 12 9 1376 3293 2375 +4297 2 2 12 9 1377 2376 3294 +4298 2 2 12 9 756 2245 3327 +4299 2 2 12 9 895 2879 1727 +4300 2 2 12 9 757 3328 2246 +4301 2 2 12 9 838 1749 3265 +4302 2 2 12 9 984 1795 3098 +4303 2 2 12 9 2106 3436 3162 +4304 2 2 12 9 881 3097 2675 +4305 2 2 12 9 1856 3601 2657 +4306 2 2 12 9 1274 1939 3178 +4307 2 2 12 9 363 3059 2343 +4308 2 2 12 9 815 2782 2547 +4309 2 2 12 9 816 2548 2783 +4310 2 2 12 9 1060 3390 1729 +4311 2 2 12 9 1104 2350 3087 +4312 2 2 12 9 803 2059 2212 +4313 2 2 12 9 1105 3088 2351 +4314 2 2 12 9 218 219 3032 +4315 2 2 12 9 363 2343 2431 +4316 2 2 12 9 856 2217 2808 +4317 2 2 12 9 1129 3584 1763 +4318 2 2 12 9 952 1756 3126 +4319 2 2 12 9 715 3410 1673 +4320 2 2 12 9 984 1832 2669 +4321 2 2 12 9 557 3030 2021 +4322 2 2 12 9 1023 1812 3109 +4323 2 2 12 9 280 281 2674 +4324 2 2 12 9 1173 2293 2870 +4325 2 2 12 9 1576 2338 3263 +4326 2 2 12 9 408 1667 3377 +4327 2 2 12 9 409 3378 1668 +4328 2 2 12 9 1545 3400 1894 +4329 2 2 12 9 875 2717 1656 +4330 2 2 12 9 915 2587 1694 +4331 2 2 12 9 24 25 2385 +4332 2 2 12 9 916 1695 2588 +4333 2 2 12 9 259 260 2688 +4334 2 2 12 9 316 317 2689 +4335 2 2 12 9 796 2459 2032 +4336 2 2 12 9 862 2066 3503 +4337 2 2 12 9 1176 2240 2455 +4338 2 2 12 9 1248 1679 3118 +4339 2 2 12 9 1249 3119 1680 +4340 2 2 12 9 353 1979 3053 +4341 2 2 12 9 887 2235 3216 +4342 2 2 12 9 1045 2161 2540 +4343 2 2 12 9 1046 2541 2162 +4344 2 2 12 9 1233 3313 3032 +4345 2 2 12 9 882 2197 2401 +4346 2 2 12 9 815 3596 1698 +4347 2 2 12 9 990 3100 1649 +4348 2 2 12 9 816 1699 3597 +4349 2 2 12 9 536 2802 2020 +4350 2 2 12 9 826 2453 2164 +4351 2 2 12 9 1128 1853 3375 +4352 2 2 12 9 509 1712 2495 +4353 2 2 12 9 1447 3471 3292 +4354 2 2 12 9 1354 3115 2353 +4355 2 2 12 9 350 1685 3395 +4356 2 2 12 9 911 2920 2440 +4357 2 2 12 9 912 2441 2921 +4358 2 2 12 9 797 1718 2504 +4359 2 2 12 9 714 3004 2494 +4360 2 2 12 9 542 2426 2027 +4361 2 2 12 9 287 288 2237 +4362 2 2 12 9 416 2821 1671 +4363 2 2 12 9 977 2192 2562 +4364 2 2 12 9 1084 2096 3149 +4365 2 2 12 9 1085 3150 2097 +4366 2 2 12 9 1210 3445 2425 +4367 2 2 12 9 866 3397 1790 +4368 2 2 12 9 639 2716 1727 +4369 2 2 12 9 1472 2960 2382 +4370 2 2 12 9 1473 2383 2961 +4371 2 2 12 9 733 1798 3056 +4372 2 2 12 9 734 3057 1799 +4373 2 2 12 9 1538 3031 2892 +4374 2 2 12 9 499 2734 2791 +4375 2 2 12 9 585 2408 3187 +4376 2 2 12 9 1050 1736 3167 +4377 2 2 12 9 1132 2099 3029 +4378 2 2 12 9 628 2251 1999 +4379 2 2 12 9 854 3255 2517 +4380 2 2 12 9 942 2536 1833 +4381 2 2 12 9 379 2459 1811 +4382 2 2 12 9 369 2692 2985 +4383 2 2 12 9 370 2986 2693 +4384 2 2 12 9 436 2039 3147 +4385 2 2 12 9 992 2649 1798 +4386 2 2 12 9 993 1799 2650 +4387 2 2 12 9 36 37 3357 +4388 2 2 12 9 184 185 3358 +4389 2 2 12 9 534 1686 3629 +4390 2 2 12 9 44 45 2271 +4391 2 2 12 9 176 177 2272 +4392 2 2 12 9 289 290 2248 +4393 2 2 12 9 1102 2790 2283 +4394 2 2 12 9 810 3222 2397 +4395 2 2 12 9 498 1823 2475 +4396 2 2 12 9 997 1710 2651 +4397 2 2 12 9 998 2652 1711 +4398 2 2 12 9 540 2296 1940 +4399 2 2 12 9 1526 2949 1807 +4400 2 2 12 9 1113 2141 2589 +4401 2 2 12 9 368 2877 1742 +4402 2 2 12 9 980 1740 2934 +4403 2 2 12 9 882 2401 2077 +4404 2 2 12 9 1296 3087 2350 +4405 2 2 12 9 1297 2351 3088 +4406 2 2 12 9 227 2708 1682 +4407 2 2 12 9 1253 2770 2544 +4408 2 2 12 9 932 1833 2500 +4409 2 2 12 9 1254 2545 2771 +4410 2 2 12 9 1108 3364 1746 +4411 2 2 12 9 1558 3283 2695 +4412 2 2 12 9 1174 1828 2609 +4413 2 2 12 9 1295 2767 2604 +4414 2 2 12 9 701 1849 3595 +4415 2 2 12 9 209 210 3546 +4416 2 2 12 9 1128 3128 1853 +4417 2 2 12 9 684 1644 3437 +4418 2 2 12 9 590 2768 2787 +4419 2 2 12 9 16 17 2671 +4420 2 2 12 9 668 3109 1812 +4421 2 2 12 9 486 3279 1904 +4422 2 2 12 9 487 1905 3280 +4423 2 2 12 9 988 2169 2508 +4424 2 2 12 9 989 2509 2170 +4425 2 2 12 9 576 1666 3363 +4426 2 2 12 9 1357 3571 1793 +4427 2 2 12 9 1358 1794 3572 +4428 2 2 12 9 871 2064 2657 +4429 2 2 12 9 1229 1924 3620 +4430 2 2 12 9 1230 3621 1925 +4431 2 2 12 9 1287 2797 1725 +4432 2 2 12 9 1288 1726 2798 +4433 2 2 12 9 973 2816 2288 +4434 2 2 12 9 974 2289 2817 +4435 2 2 12 9 647 1725 2936 +4436 2 2 12 9 648 2937 1726 +4437 2 2 12 9 780 3600 2233 +4438 2 2 12 9 1184 1999 2251 +4439 2 2 12 9 971 2787 2248 +4440 2 2 12 9 1497 2614 2342 +4441 2 2 12 9 626 2175 3135 +4442 2 2 12 9 517 2277 1900 +4443 2 2 12 9 518 1901 2278 +4444 2 2 12 9 677 3315 3079 +4445 2 2 12 9 523 2735 2150 +4446 2 2 12 9 1182 3583 2990 +4447 2 2 12 9 25 1834 2385 +4448 2 2 12 9 607 3031 2874 +4449 2 2 12 9 946 1792 2694 +4450 2 2 12 9 451 2720 1716 +4451 2 2 12 9 765 1652 3131 +4452 2 2 12 9 452 1717 2721 +4453 2 2 12 9 399 2456 2822 +4454 2 2 12 9 817 3025 2589 +4455 2 2 12 9 1011 2638 2290 +4456 2 2 12 9 696 1712 3193 +4457 2 2 12 9 967 2237 2768 +4458 2 2 12 9 961 3374 2733 +4459 2 2 12 9 583 3321 2189 +4460 2 2 12 9 1498 2832 3060 +4461 2 2 12 9 1499 3061 2834 +4462 2 2 12 9 893 2316 1909 +4463 2 2 12 9 894 1911 2317 +4464 2 2 12 9 1487 2846 3481 +4465 2 2 12 9 704 1681 3433 +4466 2 2 12 9 1521 2696 3340 +4467 2 2 12 9 11 2153 3624 +4468 2 2 12 9 977 1835 2530 +4469 2 2 12 9 948 2892 3031 +4470 2 2 12 9 1053 2922 1929 +4471 2 2 12 9 1382 2494 3004 +4472 2 2 12 9 997 2142 3324 +4473 2 2 12 9 998 3325 2143 +4474 2 2 12 9 962 2443 2604 +4475 2 2 12 9 1528 3524 2936 +4476 2 2 12 9 1529 2937 3525 +4477 2 2 12 9 743 1685 3409 +4478 2 2 12 9 490 2157 2160 +4479 2 2 12 9 1252 2431 2343 +4480 2 2 12 9 1362 2868 1819 +4481 2 2 12 9 1486 3025 3185 +4482 2 2 12 9 1363 1820 2869 +4483 2 2 12 9 1538 2874 3031 +4484 2 2 12 9 780 2233 2039 +4485 2 2 12 9 1469 3114 3551 +4486 2 2 12 9 341 2907 3441 +4487 2 2 12 9 955 2812 3526 +4488 2 2 12 9 516 3086 1887 +4489 2 2 12 9 927 2313 2605 +4490 2 2 12 9 928 2607 2314 +4491 2 2 12 9 634 3283 1879 +4492 2 2 12 9 1159 1861 3524 +4493 2 2 12 9 1160 3525 1862 +4494 2 2 12 9 1137 1979 3112 +4495 2 2 12 9 1123 3413 1967 +4496 2 2 12 9 600 1929 2922 +4497 2 2 12 9 1124 1968 3414 +4498 2 2 12 9 833 2124 2284 +4499 2 2 12 9 880 2385 1834 +4500 2 2 12 9 966 2877 3521 +4501 2 2 12 9 1039 3056 1798 +4502 2 2 12 9 992 2172 2792 +4503 2 2 12 9 993 2794 2173 +4504 2 2 12 9 1040 1799 3057 +4505 2 2 12 9 1477 2176 3202 +4506 2 2 12 9 272 273 2903 +4507 2 2 12 9 1008 2160 2157 +4508 2 2 12 9 490 2621 1913 +4509 2 2 12 9 204 1853 3128 +4510 2 2 12 9 244 245 2651 +4511 2 2 12 9 331 332 2652 +4512 2 2 12 9 1336 2762 2417 +4513 2 2 12 9 532 2442 3103 +4514 2 2 12 9 1004 1861 3121 +4515 2 2 12 9 1005 3122 1862 +4516 2 2 12 9 634 2695 3283 +4517 2 2 12 9 800 3005 1875 +4518 2 2 12 9 870 2295 1923 +4519 2 2 12 9 887 3216 3345 +4520 2 2 12 9 504 2106 3162 +4521 2 2 12 9 1341 2343 3059 +4522 2 2 12 9 521 2239 2258 +4523 2 2 12 9 716 2209 3601 +4524 2 2 12 9 866 3217 1807 +4525 2 2 12 9 1109 1916 3095 +4526 2 2 12 9 243 244 3602 +4527 2 2 12 9 332 333 3603 +4528 2 2 12 9 1043 1802 2629 +4529 2 2 12 9 1044 2630 1803 +4530 2 2 12 9 1065 1771 3175 +4531 2 2 12 9 467 2453 1877 +4532 2 2 12 9 1173 3225 2293 +4533 2 2 12 9 1617 2005 3284 +4534 2 2 12 9 1038 2415 3085 +4535 2 2 12 9 448 2511 1813 +4536 2 2 12 9 1130 2718 2985 +4537 2 2 12 9 1131 2986 2719 +4538 2 2 12 9 251 252 3226 +4539 2 2 12 9 324 325 3227 +4540 2 2 12 9 1274 3178 2704 +4541 2 2 12 9 282 1733 3492 +4542 2 2 12 9 858 2742 1742 +4543 2 2 12 9 298 299 3412 +4544 2 2 12 9 1355 2183 3523 +4545 2 2 12 9 978 2030 2565 +4546 2 2 12 9 979 2566 2031 +4547 2 2 12 9 400 1863 2551 +4548 2 2 12 9 978 2544 2770 +4549 2 2 12 9 979 2771 2545 +4550 2 2 12 9 1386 3392 1674 +4551 2 2 12 9 497 1759 3426 +4552 2 2 12 9 682 1729 3390 +4553 2 2 12 9 1234 3085 2415 +4554 2 2 12 9 457 1955 3384 +4555 2 2 12 9 641 3189 3532 +4556 2 2 12 9 748 3375 1853 +4557 2 2 12 9 523 1782 2735 +4558 2 2 12 9 37 38 2355 +4559 2 2 12 9 183 184 2356 +4560 2 2 12 9 540 1763 3584 +4561 2 2 12 9 224 225 2291 +4562 2 2 12 9 764 2099 3202 +4563 2 2 12 9 1308 2520 3273 +4564 2 2 12 9 617 1875 3005 +4565 2 2 12 9 1092 2310 2257 +4566 2 2 12 9 268 269 2311 +4567 2 2 12 9 494 2587 2666 +4568 2 2 12 9 1075 1781 3073 +4569 2 2 12 9 495 2667 2588 +4570 2 2 12 9 1066 3089 2316 +4571 2 2 12 9 1067 2317 3090 +4572 2 2 12 9 286 287 3192 +4573 2 2 12 9 360 1730 2769 +4574 2 2 12 9 876 1780 2580 +4575 2 2 12 9 271 272 3148 +4576 2 2 12 9 1570 3020 3415 +4577 2 2 12 9 1015 3060 2832 +4578 2 2 12 9 1016 2834 3061 +4579 2 2 12 9 628 2423 2251 +4580 2 2 12 9 910 3579 2722 +4581 2 2 12 9 1033 1980 2720 +4582 2 2 12 9 1034 2721 1981 +4583 2 2 12 9 922 2647 2617 +4584 2 2 12 9 357 2228 2675 +4585 2 2 12 9 1676 2722 3579 +4586 2 2 12 9 1523 3361 2975 +4587 2 2 12 9 877 1750 2736 +4588 2 2 12 9 371 3443 1846 +4589 2 2 12 9 1264 3135 2175 +4590 2 2 12 9 372 1847 3444 +4591 2 2 12 9 387 3151 2603 +4592 2 2 12 9 1409 2154 3402 +4593 2 2 12 9 787 2565 2030 +4594 2 2 12 9 788 2031 2566 +4595 2 2 12 9 607 1750 3031 +4596 2 2 12 9 1263 1908 2791 +4597 2 2 12 9 1039 3426 1759 +4598 2 2 12 9 290 291 3270 +4599 2 2 12 9 716 2471 2209 +4600 2 2 12 9 1004 3121 1662 +4601 2 2 12 9 1005 1663 3122 +4602 2 2 12 9 373 1941 2320 +4603 2 2 12 9 374 2321 1942 +4604 2 2 12 9 420 1696 2792 +4605 2 2 12 9 1203 2964 2207 +4606 2 2 12 9 421 2794 1697 +4607 2 2 12 9 793 2476 2177 +4608 2 2 12 9 693 2460 1870 +4609 2 2 12 9 463 2602 1810 +4610 2 2 12 9 776 1952 3297 +4611 2 2 12 9 2295 2567 3580 +4612 2 2 12 9 524 2416 1876 +4613 2 2 12 9 508 2168 2429 +4614 2 2 12 9 30 3129 1818 +4615 2 2 12 9 644 3543 3188 +4616 2 2 12 9 1234 3147 2039 +4617 2 2 12 9 296 3223 1994 +4618 2 2 12 9 884 1989 2529 +4619 2 2 12 9 721 3112 1979 +4620 2 2 12 9 514 1881 3182 +4621 2 2 12 9 1367 3197 1734 +4622 2 2 12 9 669 1770 2911 +4623 2 2 12 9 1368 1735 3198 +4624 2 2 12 9 1147 3473 2472 +4625 2 2 12 9 1260 2313 3173 +4626 2 2 12 9 1261 3174 2314 +4627 2 2 12 9 415 1729 2950 +4628 2 2 12 9 945 3286 2681 +4629 2 2 12 9 373 2320 3093 +4630 2 2 12 9 743 3409 2091 +4631 2 2 12 9 374 3094 2321 +4632 2 2 12 9 394 3146 2483 +4633 2 2 12 9 877 2698 1750 +4634 2 2 12 9 687 3620 1924 +4635 2 2 12 9 688 1925 3621 +4636 2 2 12 9 962 2604 2767 +4637 2 2 12 9 1370 3365 1982 +4638 2 2 12 9 22 1792 3551 +4639 2 2 12 9 1216 2283 2790 +4640 2 2 12 9 1286 2822 2456 +4641 2 2 12 9 1277 2397 3222 +4642 2 2 12 9 1227 2617 2647 +4643 2 2 12 9 1061 3518 2069 +4644 2 2 12 9 1063 2070 3519 +4645 2 2 12 9 1149 3418 2756 +4646 2 2 12 9 361 2967 1715 +4647 2 2 12 9 1238 2368 3579 +4648 2 2 12 9 1510 3385 2565 +4649 2 2 12 9 1511 2566 3386 +4650 2 2 12 9 866 2159 3114 +4651 2 2 12 9 1339 1903 2468 +4652 2 2 12 9 1322 1868 2780 +4653 2 2 12 9 966 1742 2877 +4654 2 2 12 9 1323 2781 1869 +4655 2 2 12 9 991 1821 3039 +4656 2 2 12 9 817 3185 3025 +4657 2 2 12 9 535 2814 1983 +4658 2 2 12 9 1241 2666 2587 +4659 2 2 12 9 1242 2588 2667 +4660 2 2 12 9 238 3261 3303 +4661 2 2 12 9 1123 1967 3618 +4662 2 2 12 9 1124 3619 1968 +4663 2 2 12 9 1414 3624 2153 +4664 2 2 12 9 1188 2032 2459 +4665 2 2 12 9 937 1954 3008 +4666 2 2 12 9 665 1687 2934 +4667 2 2 12 9 9 10 2387 +4668 2 2 12 9 1301 2692 2146 +4669 2 2 12 9 1302 2148 2693 +4670 2 2 12 9 1217 2639 2875 +4671 2 2 12 9 1218 2876 2640 +4672 2 2 12 9 647 3524 1861 +4673 2 2 12 9 648 1862 3525 +4674 2 2 12 9 718 1871 2501 +4675 2 2 12 9 591 1832 2767 +4676 2 2 12 9 1584 2829 1764 +4677 2 2 12 9 1315 1991 2965 +4678 2 2 12 9 240 1743 3243 +4679 2 2 12 9 336 3244 1744 +4680 2 2 12 9 881 2257 2310 +4681 2 2 12 9 1155 1812 3495 +4682 2 2 12 9 1443 2322 3561 +4683 2 2 12 9 1444 3562 2323 +4684 2 2 12 9 1281 2664 1840 +4685 2 2 12 9 499 2791 1765 +4686 2 2 12 9 515 2497 2055 +4687 2 2 12 9 890 2043 2242 +4688 2 2 12 9 891 2243 2044 +4689 2 2 12 9 759 3469 1677 +4690 2 2 12 9 371 1846 2605 +4691 2 2 12 9 372 2607 1847 +4692 2 2 12 9 307 308 2357 +4693 2 2 12 9 1179 2410 3483 +4694 2 2 12 9 1180 3484 2411 +4695 2 2 12 9 866 1790 3217 +4696 2 2 12 9 264 265 2350 +4697 2 2 12 9 311 312 2351 +4698 2 2 12 9 1047 1935 2938 +4699 2 2 12 9 1048 2939 1936 +4700 2 2 12 9 515 1705 2835 +4701 2 2 12 9 645 1771 3576 +4702 2 2 12 9 665 2962 1715 +4703 2 2 12 9 692 2924 1724 +4704 2 2 12 9 1150 1752 2887 +4705 2 2 12 9 344 3406 1851 +4706 2 2 12 9 701 2468 1903 +4707 2 2 12 9 880 2458 1902 +4708 2 2 12 9 654 2322 2057 +4709 2 2 12 9 655 2058 2323 +4710 2 2 12 9 1019 1983 2814 +4711 2 2 12 9 868 2430 1878 +4712 2 2 12 9 903 2128 2682 +4713 2 2 12 9 654 3561 2322 +4714 2 2 12 9 1234 2415 3147 +4715 2 2 12 9 655 2323 3562 +4716 2 2 12 9 963 2658 2602 +4717 2 2 12 9 957 1849 2855 +4718 2 2 12 9 1262 2050 2539 +4719 2 2 12 9 1178 3474 2575 +4720 2 2 12 9 976 3415 3020 +4721 2 2 12 9 1093 3152 2554 +4722 2 2 12 9 1094 2555 3153 +4723 2 2 12 9 668 1703 3109 +4724 2 2 12 9 491 3495 1812 +4725 2 2 12 9 1455 3601 2209 +4726 2 2 12 9 1278 2091 3409 +4727 2 2 12 9 959 2885 2332 +4728 2 2 12 9 960 2333 2886 +4729 2 2 12 9 962 1951 2443 +4730 2 2 12 9 378 1688 3143 +4731 2 2 12 9 950 1824 3066 +4732 2 2 12 9 951 3067 1825 +4733 2 2 12 9 551 1857 2591 +4734 2 2 12 9 552 2592 1858 +4735 2 2 12 9 972 2912 2370 +4736 2 2 12 9 957 2674 1805 +4737 2 2 12 9 791 2054 3389 +4738 2 2 12 9 297 2063 3223 +4739 2 2 12 9 1676 3579 2368 +4740 2 2 12 9 1088 1708 2858 +4741 2 2 12 9 1089 2859 1709 +4742 2 2 12 9 966 2777 1742 +4743 2 2 12 9 1280 3127 2335 +4744 2 2 12 9 1049 1926 3343 +4745 2 2 12 9 620 2762 3372 +4746 2 2 12 9 723 3548 2410 +4747 2 2 12 9 724 2411 3549 +4748 2 2 12 9 948 3031 1750 +4749 2 2 12 9 1030 2294 2633 +4750 2 2 12 9 496 1842 2952 +4751 2 2 12 9 538 2207 2964 +4752 2 2 12 9 1037 1773 2999 +4753 2 2 12 9 1167 1846 3443 +4754 2 2 12 9 1168 3444 1847 +4755 2 2 12 9 980 3205 1740 +4756 2 2 12 9 51 3218 1766 +4757 2 2 12 9 170 1767 3219 +4758 2 2 12 9 832 2556 3430 +4759 2 2 12 9 1515 3428 2779 +4760 2 2 12 9 935 2551 1863 +4761 2 2 12 9 900 2837 1883 +4762 2 2 12 9 1052 2140 3015 +4763 2 2 12 9 1253 2544 3154 +4764 2 2 12 9 1254 3155 2545 +4765 2 2 12 9 1096 2977 2802 +4766 2 2 12 9 844 2381 1963 +4767 2 2 12 9 414 2395 1933 +4768 2 2 12 9 1096 1867 3531 +4769 2 2 12 9 981 2890 1899 +4770 2 2 12 9 1412 3158 3080 +4771 2 2 12 9 381 3425 1746 +4772 2 2 12 9 849 2456 1850 +4773 2 2 12 9 363 1748 3059 +4774 2 2 12 9 483 1947 2384 +4775 2 2 12 9 578 2202 3154 +4776 2 2 12 9 579 3155 2203 +4777 2 2 12 9 484 2386 1948 +4778 2 2 12 9 1177 3573 1899 +4779 2 2 12 9 1395 3521 2877 +4780 2 2 12 9 554 2997 1773 +4781 2 2 12 9 1037 2361 2884 +4782 2 2 12 9 532 3103 3379 +4783 2 2 12 9 694 1764 2829 +4784 2 2 12 9 557 2021 2909 +4785 2 2 12 9 1755 3472 2976 +4786 2 2 12 9 949 2262 2395 +4787 2 2 12 9 647 2936 3524 +4788 2 2 12 9 648 3525 2937 +4789 2 2 12 9 701 2855 1849 +4790 2 2 12 9 1174 3272 2524 +4791 2 2 12 9 1498 2410 3548 +4792 2 2 12 9 1499 3549 2411 +4793 2 2 12 9 667 2576 3010 +4794 2 2 12 9 343 2818 1734 +4795 2 2 12 9 342 1735 2819 +4796 2 2 12 9 380 1920 3380 +4797 2 2 12 9 657 1730 3365 +4798 2 2 12 9 27 28 2599 +4799 2 2 12 9 1446 2603 3151 +4800 2 2 12 9 344 1851 2801 +4801 2 2 12 9 1298 2844 2191 +4802 2 2 12 9 910 1876 2416 +4803 2 2 12 9 925 2737 2215 +4804 2 2 12 9 1017 2235 2234 +4805 2 2 12 9 926 2216 2738 +4806 2 2 12 9 363 1719 3120 +4807 2 2 12 9 417 3039 1821 +4808 2 2 12 9 1521 3340 2890 +4809 2 2 12 9 597 3184 2062 +4810 2 2 12 9 1212 3338 1761 +4811 2 2 12 9 685 2700 1859 +4812 2 2 12 9 1213 1762 3339 +4813 2 2 12 9 730 2938 1935 +4814 2 2 12 9 731 1936 2939 +4815 2 2 12 9 1251 1822 3641 +4816 2 2 12 9 832 2390 1940 +4817 2 2 12 9 718 3383 1739 +4818 2 2 12 9 717 1757 3253 +4819 2 2 12 9 1115 2964 3077 +4820 2 2 12 9 1239 2504 3348 +4821 2 2 12 9 684 3437 1763 +4822 2 2 12 9 962 2767 1832 +4823 2 2 12 9 1241 3501 1838 +4824 2 2 12 9 802 3445 2632 +4825 2 2 12 9 913 2361 2028 +4826 2 2 12 9 1242 1839 3502 +4827 2 2 12 9 428 2725 1859 +4828 2 2 12 9 397 1806 2880 +4829 2 2 12 9 19 2159 3354 +4830 2 2 12 9 1225 3408 2419 +4831 2 2 12 9 577 2533 2799 +4832 2 2 12 9 1527 2472 3473 +4833 2 2 12 9 1061 2929 2581 +4834 2 2 12 9 1063 2582 2930 +4835 2 2 12 9 940 2967 2074 +4836 2 2 12 9 743 2927 1937 +4837 2 2 12 9 1208 1994 3223 +4838 2 2 12 9 1838 3501 2762 +4839 2 2 12 9 850 1907 2425 +4840 2 2 12 9 599 1790 3397 +4841 2 2 12 9 47 2051 3018 +4842 2 2 12 9 174 3019 2052 +4843 2 2 12 9 378 2779 1768 +4844 2 2 12 9 623 3530 2612 +4845 2 2 12 9 872 1778 3238 +4846 2 2 12 9 1239 2836 2504 +4847 2 2 12 9 1141 1851 3406 +4848 2 2 12 9 480 3106 1690 +4849 2 2 12 9 758 2443 1951 +4850 2 2 12 9 1073 3554 1728 +4851 2 2 12 9 839 2421 2015 +4852 2 2 12 9 1266 3327 2245 +4853 2 2 12 9 1267 2246 3328 +4854 2 2 12 9 190 3075 2068 +4855 2 2 12 9 1159 2016 3534 +4856 2 2 12 9 1160 3535 2017 +4857 2 2 12 9 948 1750 2910 +4858 2 2 12 9 712 2523 2863 +4859 2 2 12 9 1012 2976 3472 +4860 2 2 12 9 947 2352 2252 +4861 2 2 12 9 1137 3182 1881 +4862 2 2 12 9 793 1986 2476 +4863 2 2 12 9 1311 2848 2019 +4864 2 2 12 9 1338 2036 2345 +4865 2 2 12 9 208 209 2498 +4866 2 2 12 9 352 1816 2991 +4867 2 2 12 9 351 2992 1817 +4868 2 2 12 9 1195 2177 2476 +4869 2 2 12 9 219 220 2665 +4870 2 2 12 9 872 2042 2340 +4871 2 2 12 9 1501 3441 3257 +4872 2 2 12 9 1217 1819 2868 +4873 2 2 12 9 1218 2869 1820 +4874 2 2 12 9 1109 3095 2965 +4875 2 2 12 9 661 1899 2890 +4876 2 2 12 9 291 292 2953 +4877 2 2 12 9 1171 2975 3361 +4878 2 2 12 9 1389 3353 3304 +4879 2 2 12 9 867 2409 2232 +4880 2 2 12 9 896 3142 1845 +4881 2 2 12 9 386 1969 3402 +4882 2 2 12 9 514 3182 2489 +4883 2 2 12 9 285 286 2989 +4884 2 2 12 9 927 2605 1846 +4885 2 2 12 9 1279 2590 2974 +4886 2 2 12 9 928 1847 2607 +4887 2 2 12 9 1006 3232 1753 +4888 2 2 12 9 959 2780 1868 +4889 2 2 12 9 960 1869 2781 +4890 2 2 12 9 1103 2112 3014 +4891 2 2 12 9 908 1875 2653 +4892 2 2 12 9 682 3390 3552 +4893 2 2 12 9 953 1854 3226 +4894 2 2 12 9 954 3227 1855 +4895 2 2 12 9 617 2653 1875 +4896 2 2 12 9 901 3357 2355 +4897 2 2 12 9 902 2356 3358 +4898 2 2 12 9 486 2120 3279 +4899 2 2 12 9 487 3280 2121 +4900 2 2 12 9 1028 2401 2197 +4901 2 2 12 9 354 2866 1814 +4902 2 2 12 9 988 2069 3518 +4903 2 2 12 9 989 3519 2070 +4904 2 2 12 9 1202 3284 2636 +4905 2 2 12 9 1628 3124 1882 +4906 2 2 12 9 959 1843 2626 +4907 2 2 12 9 960 2627 1844 +4908 2 2 12 9 1253 3154 2202 +4909 2 2 12 9 1254 2203 3155 +4910 2 2 12 9 725 3630 1760 +4911 2 2 12 9 811 2324 2132 +4912 2 2 12 9 1423 3035 1834 +4913 2 2 12 9 352 3060 1816 +4914 2 2 12 9 351 1817 3061 +4915 2 2 12 9 681 1865 3065 +4916 2 2 12 9 1150 2132 2324 +4917 2 2 12 9 1108 1746 3425 +4918 2 2 12 9 1018 3254 1815 +4919 2 2 12 9 1123 3018 2051 +4920 2 2 12 9 1124 2052 3019 +4921 2 2 12 9 945 2428 3286 +4922 2 2 12 9 1114 1950 3042 +4923 2 2 12 9 1148 2068 3075 +4924 2 2 12 9 913 2501 1871 +4925 2 2 12 9 436 1959 3009 +4926 2 2 12 9 1270 2179 3398 +4927 2 2 12 9 750 1829 3490 +4928 2 2 12 9 751 3491 1830 +4929 2 2 12 9 486 3050 1725 +4930 2 2 12 9 487 1726 3051 +4931 2 2 12 9 953 2404 2129 +4932 2 2 12 9 954 2130 2405 +4933 2 2 12 9 929 2057 2322 +4934 2 2 12 9 930 2323 2058 +4935 2 2 12 9 1222 3347 2676 +4936 2 2 12 9 1185 2963 2461 +4937 2 2 12 9 866 1807 3598 +4938 2 2 12 9 402 2422 2015 +4939 2 2 12 9 504 2199 2823 +4940 2 2 12 9 1070 2656 2254 +4941 2 2 12 9 1350 3613 3496 +4942 2 2 12 9 959 2626 2885 +4943 2 2 12 9 960 2886 2627 +4944 2 2 12 9 981 2311 2890 +4945 2 2 12 9 956 2260 2596 +4946 2 2 12 9 710 3036 1967 +4947 2 2 12 9 711 1968 3037 +4948 2 2 12 9 661 2890 3340 +4949 2 2 12 9 1014 3442 1809 +4950 2 2 12 9 1413 3303 3261 +4951 2 2 12 9 1335 1966 2538 +4952 2 2 12 9 1120 3405 1943 +4953 2 2 12 9 1202 2636 2344 +4954 2 2 12 9 341 1991 2907 +4955 2 2 12 9 264 2350 2515 +4956 2 2 12 9 312 2516 2351 +4957 2 2 12 9 500 1740 3205 +4958 2 2 12 9 669 2911 3569 +4959 2 2 12 9 777 3266 2809 +4960 2 2 12 9 1010 3080 1876 +4961 2 2 12 9 959 2688 1843 +4962 2 2 12 9 960 1844 2689 +4963 2 2 12 9 527 2069 2508 +4964 2 2 12 9 528 2509 2070 +4965 2 2 12 9 192 193 2579 +4966 2 2 12 9 744 3341 1800 +4967 2 2 12 9 745 1801 3342 +4968 2 2 12 9 712 3472 1755 +4969 2 2 12 9 339 1915 2707 +4970 2 2 12 9 237 3303 1736 +4971 2 2 12 9 858 2100 2419 +4972 2 2 12 9 1621 3306 2352 +4973 2 2 12 9 907 3071 1878 +4974 2 2 12 9 462 1807 3217 +4975 2 2 12 9 997 2651 3637 +4976 2 2 12 9 259 2688 1868 +4977 2 2 12 9 998 3638 2652 +4978 2 2 12 9 317 1869 2689 +4979 2 2 12 9 1108 2828 3364 +4980 2 2 12 9 720 1753 3232 +4981 2 2 12 9 1578 3190 3111 +4982 2 2 12 9 500 3478 1740 +4983 2 2 12 9 1019 2476 1986 +4984 2 2 12 9 1097 2909 2021 +4985 2 2 12 9 359 3405 1784 +4986 2 2 12 9 225 3276 2291 +4987 2 2 12 9 1382 3004 2359 +4988 2 2 12 9 1128 2633 2294 +4989 2 2 12 9 1597 3364 2828 +4990 2 2 12 9 1795 3646 3098 +4991 2 2 12 9 1119 2059 3078 +4992 2 2 12 9 852 2629 2325 +4993 2 2 12 9 853 2326 2630 +4994 2 2 12 9 1412 1919 2914 +4995 2 2 12 9 498 3545 1823 +4996 2 2 12 9 1104 2515 2350 +4997 2 2 12 9 1105 2351 2516 +4998 2 2 12 9 1279 2863 2523 +4999 2 2 12 9 696 3193 1818 +5000 2 2 12 9 1211 3333 2485 +5001 2 2 12 9 263 264 2515 +5002 2 2 12 9 312 313 2516 +5003 2 2 12 9 33 3042 1950 +5004 2 2 12 9 1135 2911 2139 +5005 2 2 12 9 1369 3010 2576 +5006 2 2 12 9 715 2803 3410 +5007 2 2 12 9 1364 2489 3182 +5008 2 2 12 9 5 7 3261 +5009 2 2 12 9 446 3062 2369 +5010 2 2 12 9 512 2717 2049 +5011 2 2 12 9 999 1831 3206 +5012 2 2 12 9 837 2113 2408 +5013 2 2 12 9 418 2506 3423 +5014 2 2 12 9 1164 2038 2467 +5015 2 2 12 9 1237 2369 3062 +5016 2 2 12 9 1040 1823 3545 +5017 2 2 12 9 1111 2413 2022 +5018 2 2 12 9 949 2395 2945 +5019 2 2 12 9 1615 3006 2033 +5020 2 2 12 9 1616 2034 3007 +5021 2 2 12 9 936 1828 3506 +5022 2 2 12 9 938 1945 3063 +5023 2 2 12 9 939 3064 1946 +5024 2 2 12 9 1120 3207 2896 +5025 2 2 12 9 1190 3646 1795 +5026 2 2 12 9 536 2077 2401 +5027 2 2 12 9 559 2254 2656 +5028 2 2 12 9 1032 2625 1934 +5029 2 2 12 9 658 3111 3190 +5030 2 2 12 9 1140 2594 2500 +5031 2 2 12 9 887 2234 2235 +5032 2 2 12 9 931 2372 2134 +5033 2 2 12 9 566 3398 2179 +5034 2 2 12 9 803 3078 2059 +5035 2 2 12 9 669 3569 2437 +5036 2 2 12 9 801 1883 2918 +5037 2 2 12 9 838 2823 2199 +5038 2 2 12 9 1554 2809 3266 +5039 2 2 12 9 448 1813 3604 +5040 2 2 12 9 10 3624 2387 +5041 2 2 12 9 1149 3148 3418 +5042 2 2 12 9 1084 1967 3036 +5043 2 2 12 9 1085 3037 1968 +5044 2 2 12 9 726 2092 2748 +5045 2 2 12 9 686 3476 1791 +5046 2 2 12 9 30 31 3129 +5047 2 2 12 9 670 1815 3254 +5048 2 2 12 9 899 2856 1957 +5049 2 2 12 9 845 2952 1842 +5050 2 2 12 9 1268 2733 3374 +5051 2 2 12 9 1283 2091 2644 +5052 2 2 12 9 5 3261 238 +5053 2 2 12 9 2198 3538 2769 +5054 2 2 12 9 217 2067 3465 +5055 2 2 12 9 766 2849 1965 +5056 2 2 12 9 390 2252 2352 +5057 2 2 12 9 985 2414 3450 +5058 2 2 12 9 1079 3281 1790 +5059 2 2 12 9 511 2134 2372 +5060 2 2 12 9 1031 2915 2384 +5061 2 2 12 9 914 2707 1915 +5062 2 2 12 9 707 1786 3240 +5063 2 2 12 9 986 1977 3466 +5064 2 2 12 9 987 3467 1978 +5065 2 2 12 9 708 3241 1787 +5066 2 2 12 9 985 3450 2727 +5067 2 2 12 9 1730 1982 3365 +5068 2 2 12 9 898 2004 3041 +5069 2 2 12 9 1200 2712 1857 +5070 2 2 12 9 1201 1858 2713 +5071 2 2 12 9 1647 3418 3148 +5072 2 2 12 9 778 2207 3307 +5073 2 2 12 9 1384 2126 2743 +5074 2 2 12 9 1385 2744 2127 +5075 2 2 12 9 1050 1852 2827 +5076 2 2 12 9 661 3514 1899 +5077 2 2 12 9 461 3408 2444 +5078 2 2 12 9 949 2572 3411 +5079 2 2 12 9 1047 3033 1935 +5080 2 2 12 9 1048 1936 3034 +5081 2 2 12 9 873 2505 3429 +5082 2 2 12 9 968 2861 1880 +5083 2 2 12 9 1237 2269 2369 +5084 2 2 12 9 539 3014 2112 +5085 2 2 12 9 1164 3489 2038 +5086 2 2 12 9 512 1789 3488 +5087 2 2 12 9 377 3506 1828 +5088 2 2 12 9 416 2974 2590 +5089 2 2 12 9 762 3367 1765 +5090 2 2 12 9 603 3636 2724 +5091 2 2 12 9 481 1873 2893 +5092 2 2 12 9 482 2894 1874 +5093 2 2 12 9 524 1876 3080 +5094 2 2 12 9 934 1859 2700 +5095 2 2 12 9 540 3239 1763 +5096 2 2 12 9 1176 3131 2329 +5097 2 2 12 9 904 3454 1904 +5098 2 2 12 9 905 1905 3455 +5099 2 2 12 9 1518 3271 2287 +5100 2 2 12 9 621 2872 1839 +5101 2 2 12 9 510 3477 1791 +5102 2 2 12 9 555 3160 2421 +5103 2 2 12 9 477 3430 1754 +5104 2 2 12 9 299 300 2564 +5105 2 2 12 9 237 238 3303 +5106 2 2 12 9 775 1872 2972 +5107 2 2 12 9 899 2296 3023 +5108 2 2 12 9 558 1883 2837 +5109 2 2 12 9 673 2298 2297 +5110 2 2 12 9 1121 3556 2025 +5111 2 2 12 9 1122 2026 3557 +5112 2 2 12 9 1152 3587 1903 +5113 2 2 12 9 429 1809 3442 +5114 2 2 12 9 825 1779 3515 +5115 2 2 12 9 604 2080 2831 +5116 2 2 12 9 1037 2999 2028 +5117 2 2 12 9 1127 3292 3471 +5118 2 2 12 9 1022 2538 1966 +5119 2 2 12 9 1624 2724 3636 +5120 2 2 12 9 620 2919 1850 +5121 2 2 12 9 1055 1937 2927 +5122 2 2 12 9 634 1879 3475 +5123 2 2 12 9 988 2508 2069 +5124 2 2 12 9 989 2070 2509 +5125 2 2 12 9 1019 3054 1983 +5126 2 2 12 9 959 1868 2688 +5127 2 2 12 9 960 2689 1869 +5128 2 2 12 9 399 1864 3203 +5129 2 2 12 9 426 2875 2639 +5130 2 2 12 9 427 2640 2876 +5131 2 2 12 9 1113 2167 2902 +5132 2 2 12 9 1320 2958 2098 +5133 2 2 12 9 1062 2907 1991 +5134 2 2 12 9 1292 3605 2184 +5135 2 2 12 9 1015 1816 3060 +5136 2 2 12 9 1016 3061 1817 +5137 2 2 12 9 408 3377 1897 +5138 2 2 12 9 409 1898 3378 +5139 2 2 12 9 560 2098 2958 +5140 2 2 12 9 601 2213 2754 +5141 2 2 12 9 602 2755 2214 +5142 2 2 12 9 1786 3330 2731 +5143 2 2 12 9 1787 2732 3331 +5144 2 2 12 9 478 2129 2404 +5145 2 2 12 9 479 2405 2130 +5146 2 2 12 9 241 242 2600 +5147 2 2 12 9 334 335 2601 +5148 2 2 12 9 1291 3168 2090 +5149 2 2 12 9 21 22 3551 +5150 2 2 12 9 1294 2339 2793 +5151 2 2 12 9 1076 3246 1964 +5152 2 2 12 9 485 3485 1841 +5153 2 2 12 9 800 2185 3005 +5154 2 2 12 9 424 2513 2983 +5155 2 2 12 9 918 2223 2666 +5156 2 2 12 9 919 2667 2224 +5157 2 2 12 9 1181 3577 2247 +5158 2 2 12 9 683 3334 1953 +5159 2 2 12 9 1177 2481 2194 +5160 2 2 12 9 432 1935 3033 +5161 2 2 12 9 433 3034 1936 +5162 2 2 12 9 1025 2368 2519 +5163 2 2 12 9 1345 3639 1796 +5164 2 2 12 9 1346 1797 3640 +5165 2 2 12 9 781 3123 1866 +5166 2 2 12 9 889 2844 2009 +5167 2 2 12 9 1587 2677 2088 +5168 2 2 12 9 1588 2089 2678 +5169 2 2 12 9 836 3376 2928 +5170 2 2 12 9 1139 2227 3108 +5171 2 2 12 9 1039 1928 3346 +5172 2 2 12 9 752 1997 2784 +5173 2 2 12 9 460 1914 3459 +5174 2 2 12 9 753 2786 2000 +5175 2 2 12 9 1110 2533 2166 +5176 2 2 12 9 504 2823 2106 +5177 2 2 12 9 208 2498 3599 +5178 2 2 12 9 1421 2472 3591 +5179 2 2 12 9 1081 1800 3341 +5180 2 2 12 9 1082 3342 1801 +5181 2 2 12 9 468 3586 2241 +5182 2 2 12 9 386 3402 2154 +5183 2 2 12 9 654 3132 3561 +5184 2 2 12 9 863 2348 2536 +5185 2 2 12 9 655 3562 3133 +5186 2 2 12 9 975 2261 2358 +5187 2 2 12 9 1052 3015 1818 +5188 2 2 12 9 195 3299 2054 +5189 2 2 12 9 949 2945 2572 +5190 2 2 12 9 510 3460 2085 +5191 2 2 12 9 1153 2297 2298 +5192 2 2 12 9 1345 1884 2818 +5193 2 2 12 9 1346 2819 1885 +5194 2 2 12 9 995 2610 2784 +5195 2 2 12 9 1141 2925 1851 +5196 2 2 12 9 996 2786 2611 +5197 2 2 12 9 1469 3551 1792 +5198 2 2 12 9 1398 3486 3546 +5199 2 2 12 9 504 3162 3220 +5200 2 2 12 9 359 1943 3405 +5201 2 2 12 9 768 2120 2797 +5202 2 2 12 9 769 2798 2121 +5203 2 2 12 9 220 221 3040 +5204 2 2 12 9 530 2232 2645 +5205 2 2 12 9 818 2021 3030 +5206 2 2 12 9 957 1971 2674 +5207 2 2 12 9 1219 2534 2347 +5208 2 2 12 9 424 2983 2457 +5209 2 2 12 9 910 2722 1876 +5210 2 2 12 9 1478 3161 1984 +5211 2 2 12 9 932 2500 2594 +5212 2 2 12 9 28 2140 2599 +5213 2 2 12 9 1061 3116 3518 +5214 2 2 12 9 1063 3519 3117 +5215 2 2 12 9 1479 3423 2506 +5216 2 2 12 9 941 2358 2261 +5217 2 2 12 9 702 1809 2996 +5218 2 2 12 9 813 2072 2518 +5219 2 2 12 9 942 2158 2536 +5220 2 2 12 9 1032 1934 3038 +5221 2 2 12 9 1071 2958 3516 +5222 2 2 12 9 860 2304 2540 +5223 2 2 12 9 861 2541 2305 +5224 2 2 12 9 1243 2741 3631 +5225 2 2 12 9 701 1903 3587 +5226 2 2 12 9 1052 1818 3193 +5227 2 2 12 9 1212 2784 2610 +5228 2 2 12 9 1213 2611 2786 +5229 2 2 12 9 1639 2928 3376 +5230 2 2 12 9 1281 3337 2595 +5231 2 2 12 9 1072 1906 2916 +5232 2 2 12 9 380 2427 3371 +5233 2 2 12 9 1339 2905 2363 +5234 2 2 12 9 1246 3420 2238 +5235 2 2 12 9 691 3505 2484 +5236 2 2 12 9 1111 2181 2412 +5237 2 2 12 9 1155 2136 2590 +5238 2 2 12 9 1013 3403 1856 +5239 2 2 12 9 1796 3639 2011 +5240 2 2 12 9 1797 2012 3640 +5241 2 2 12 9 1258 2429 2168 +5242 2 2 12 9 791 3206 1831 +5243 2 2 12 9 1175 2648 2684 +5244 2 2 12 9 1397 2845 3513 +5245 2 2 12 9 681 3350 1865 +5246 2 2 12 9 1454 3130 1918 +5247 2 2 12 9 1206 3298 1838 +5248 2 2 12 9 1207 1839 3300 +5249 2 2 12 9 878 3355 2353 +5250 2 2 12 9 765 2179 2578 +5251 2 2 12 9 280 2674 1971 +5252 2 2 12 9 718 3577 1871 +5253 2 2 12 9 1121 3319 2739 +5254 2 2 12 9 1122 2740 3320 +5255 2 2 12 9 577 2166 2533 +5256 2 2 12 9 808 2559 2082 +5257 2 2 12 9 809 2083 2560 +5258 2 2 12 9 524 3080 3158 +5259 2 2 12 9 516 1871 3086 +5260 2 2 12 9 1156 2054 3299 +5261 2 2 12 9 405 3210 2046 +5262 2 2 12 9 831 2412 2181 +5263 2 2 12 9 1375 1990 2656 +5264 2 2 12 9 748 1804 3375 +5265 2 2 12 9 1029 3180 1806 +5266 2 2 12 9 417 1821 3590 +5267 2 2 12 9 567 1878 3071 +5268 2 2 12 9 13 1910 2706 +5269 2 2 12 9 1181 1887 3086 +5270 2 2 12 9 235 2827 1852 +5271 2 2 12 9 897 2905 1996 +5272 2 2 12 9 338 2092 3392 +5273 2 2 12 9 348 2698 3302 +5274 2 2 12 9 1501 3257 1990 +5275 2 2 12 9 710 1967 3413 +5276 2 2 12 9 711 3414 1968 +5277 2 2 12 9 466 2424 3252 +5278 2 2 12 9 1177 1899 3514 +5279 2 2 12 9 985 1808 3110 +5280 2 2 12 9 554 2644 2091 +5281 2 2 12 9 725 1827 3630 +5282 2 2 12 9 522 2539 2050 +5283 2 2 12 9 1399 2444 3408 +5284 2 2 12 9 227 228 2708 +5285 2 2 12 9 1294 2793 2830 +5286 2 2 12 9 934 2926 1859 +5287 2 2 12 9 428 1859 2926 +5288 2 2 12 9 1480 3308 3431 +5289 2 2 12 9 415 2194 2481 +5290 2 2 12 9 1019 2814 2476 +5291 2 2 12 9 852 2281 2629 +5292 2 2 12 9 853 2630 2282 +5293 2 2 12 9 1068 2748 2092 +5294 2 2 12 9 1578 3220 3162 +5295 2 2 12 9 49 50 2763 +5296 2 2 12 9 171 172 2764 +5297 2 2 12 9 1383 3582 2438 +5298 2 2 12 9 927 1846 2900 +5299 2 2 12 9 928 2901 1847 +5300 2 2 12 9 401 3098 3646 +5301 2 2 12 9 1335 3262 3144 +5302 2 2 12 9 720 1845 3142 +5303 2 2 12 9 531 3347 2463 +5304 2 2 12 9 414 2407 2820 +5305 2 2 12 9 412 1957 2856 +5306 2 2 12 9 429 2184 3605 +5307 2 2 12 9 540 1940 3239 +5308 2 2 12 9 1027 2019 2848 +5309 2 2 12 9 897 1996 2813 +5310 2 2 12 9 935 2022 2662 +5311 2 2 12 9 982 2830 2793 +5312 2 2 12 9 1678 2334 2924 +5313 2 2 12 9 1451 2250 3209 +5314 2 2 12 9 707 3330 1786 +5315 2 2 12 9 708 1787 3331 +5316 2 2 12 9 980 2803 1974 +5317 2 2 12 9 877 2369 2269 +5318 2 2 12 9 549 3108 2227 +5319 2 2 12 9 1125 2737 2464 +5320 2 2 12 9 1126 2465 2738 +5321 2 2 12 9 822 3428 2778 +5322 2 2 12 9 962 1832 3137 +5323 2 2 12 9 666 3242 2788 +5324 2 2 12 9 863 2536 2158 +5325 2 2 12 9 1223 2690 3461 +5326 2 2 12 9 270 271 2696 +5327 2 2 12 9 725 1842 3391 +5328 2 2 12 9 790 1881 3196 +5329 2 2 12 9 14 2954 1910 +5330 2 2 12 9 1118 3102 2116 +5331 2 2 12 9 1275 2209 2471 +5332 2 2 12 9 1308 2263 2520 +5333 2 2 12 9 739 3534 2016 +5334 2 2 12 9 740 2017 3535 +5335 2 2 12 9 1143 2164 2453 +5336 2 2 12 9 1041 2831 2080 +5337 2 2 12 9 1140 3475 1879 +5338 2 2 12 9 1092 2637 2310 +5339 2 2 12 9 1265 2457 2983 +5340 2 2 12 9 513 2206 2897 +5341 2 2 12 9 995 2784 1997 +5342 2 2 12 9 996 2000 2786 +5343 2 2 12 9 389 2028 2999 +5344 2 2 12 9 350 3395 2390 +5345 2 2 12 9 1096 1865 3350 +5346 2 2 12 9 1244 1882 3124 +5347 2 2 12 9 701 3595 2468 +5348 2 2 12 9 984 3098 1832 +5349 2 2 12 9 815 2388 2782 +5350 2 2 12 9 816 2783 2389 +5351 2 2 12 9 1145 2690 3093 +5352 2 2 12 9 416 2590 2136 +5353 2 2 12 9 1146 3094 2691 +5354 2 2 12 9 1143 3614 2010 +5355 2 2 12 9 1004 3212 2023 +5356 2 2 12 9 703 1959 2904 +5357 2 2 12 9 1005 2024 3213 +5358 2 2 12 9 1312 2983 2513 +5359 2 2 12 9 562 2382 2960 +5360 2 2 12 9 564 2961 2383 +5361 2 2 12 9 1000 2684 2648 +5362 2 2 12 9 1097 1877 2909 +5363 2 2 12 9 868 2010 2561 +5364 2 2 12 9 485 1845 3416 +5365 2 2 12 9 245 246 3637 +5366 2 2 12 9 330 331 3638 +5367 2 2 12 9 1146 2691 3555 +5368 2 2 12 9 1003 1932 2941 +5369 2 2 12 9 1501 3507 2522 +5370 2 2 12 9 1098 3528 2284 +5371 2 2 12 9 1162 2820 2407 +5372 2 2 12 9 561 3221 2493 +5373 2 2 12 9 1335 2538 3262 +5374 2 2 12 9 1106 2715 3382 +5375 2 2 12 9 1195 3209 2250 +5376 2 2 12 9 1563 3422 3482 +5377 2 2 12 9 1188 3582 3307 +5378 2 2 12 9 572 3298 2152 +5379 2 2 12 9 405 2116 3102 +5380 2 2 12 9 774 2978 1911 +5381 2 2 12 9 768 3293 2120 +5382 2 2 12 9 769 2121 3294 +5383 2 2 12 9 567 2793 2339 +5384 2 2 12 9 1369 3048 2171 +5385 2 2 12 9 1154 2914 1919 +5386 2 2 12 9 1734 3197 1895 +5387 2 2 12 9 533 2705 2360 +5388 2 2 12 9 1735 1896 3198 +5389 2 2 12 9 1447 2204 3471 +5390 2 2 12 9 1117 2360 2705 +5391 2 2 12 9 377 2951 3506 +5392 2 2 12 9 1165 3459 1914 +5393 2 2 12 9 1027 2432 2765 +5394 2 2 12 9 983 1952 3028 +5395 2 2 12 9 1476 2567 2270 +5396 2 2 12 9 878 2477 3355 +5397 2 2 12 9 1083 2232 2409 +5398 2 2 12 9 261 262 2731 +5399 2 2 12 9 314 315 2732 +5400 2 2 12 9 568 2519 2368 +5401 2 2 12 9 254 255 2739 +5402 2 2 12 9 321 322 2740 +5403 2 2 12 9 766 2968 1933 +5404 2 2 12 9 878 2309 2477 +5405 2 2 12 9 635 3105 1926 +5406 2 2 12 9 1146 3555 3366 +5407 2 2 12 9 510 2186 3460 +5408 2 2 12 9 1563 1953 3422 +5409 2 2 12 9 727 1895 3197 +5410 2 2 12 9 860 2540 2142 +5411 2 2 12 9 861 2143 2541 +5412 2 2 12 9 728 3198 1896 +5413 2 2 12 9 211 3314 2065 +5414 2 2 12 9 565 2344 3055 +5415 2 2 12 9 1232 2615 3504 +5416 2 2 12 9 1007 2800 1912 +5417 2 2 12 9 1144 2046 3210 +5418 2 2 12 9 1083 2645 2232 +5419 2 2 12 9 346 2657 2064 +5420 2 2 12 9 1312 2513 3367 +5421 2 2 12 9 994 1965 2849 +5422 2 2 12 9 1021 3058 2646 +5423 2 2 12 9 1401 3371 2427 +5424 2 2 12 9 1329 3269 2307 +5425 2 2 12 9 1182 3257 3441 +5426 2 2 12 9 783 2011 3639 +5427 2 2 12 9 784 3640 2012 +5428 2 2 12 9 1195 2476 2814 +5429 2 2 12 9 843 1970 2838 +5430 2 2 12 9 453 1962 2807 +5431 2 2 12 9 839 1823 3272 +5432 2 2 12 9 889 2191 2844 +5433 2 2 12 9 823 2573 2122 +5434 2 2 12 9 824 2123 2574 +5435 2 2 12 9 1045 2540 2304 +5436 2 2 12 9 1046 2305 2541 +5437 2 2 12 9 540 3584 3023 +5438 2 2 12 9 486 1904 3454 +5439 2 2 12 9 487 3455 1905 +5440 2 2 12 9 1220 3252 1886 +5441 2 2 12 9 376 1921 3346 +5442 2 2 12 9 1675 3246 2446 +5443 2 2 12 9 609 3235 2608 +5444 2 2 12 9 957 2855 1971 +5445 2 2 12 9 1095 3239 1940 +5446 2 2 12 9 1524 3532 3189 +5447 2 2 12 9 338 3326 2092 +5448 2 2 12 9 667 3010 3366 +5449 2 2 12 9 733 3056 1921 +5450 2 2 12 9 1679 1935 3118 +5451 2 2 12 9 1680 3119 1936 +5452 2 2 12 9 734 1922 3057 +5453 2 2 12 9 559 2656 1990 +5454 2 2 12 9 1080 3162 3436 +5455 2 2 12 9 1156 3389 2054 +5456 2 2 12 9 1584 3604 2003 +5457 2 2 12 9 248 249 2775 +5458 2 2 12 9 327 328 2776 +5459 2 2 12 9 941 2261 3157 +5460 2 2 12 9 899 2556 2296 +5461 2 2 12 9 909 2699 2811 +5462 2 2 12 9 900 2013 3368 +5463 2 2 12 9 235 236 2827 +5464 2 2 12 9 611 2577 3259 +5465 2 2 12 9 909 1914 3647 +5466 2 2 12 9 639 2257 3291 +5467 2 2 12 9 1525 3188 3543 +5468 2 2 12 9 385 3149 2096 +5469 2 2 12 9 384 2097 3150 +5470 2 2 12 9 823 2129 2573 +5471 2 2 12 9 824 2574 2130 +5472 2 2 12 9 596 3262 2538 +5473 2 2 12 9 1032 2386 2978 +5474 2 2 12 9 1554 3266 2420 +5475 2 2 12 9 1043 3228 1941 +5476 2 2 12 9 1044 1942 3229 +5477 2 2 12 9 1043 2629 2281 +5478 2 2 12 9 1640 3366 3010 +5479 2 2 12 9 1044 2282 2630 +5480 2 2 12 9 1328 1894 3400 +5481 2 2 12 9 773 1909 2915 +5482 2 2 12 9 618 2662 2022 +5483 2 2 12 9 610 3028 1952 +5484 2 2 12 9 606 3523 2198 +5485 2 2 12 9 1569 2186 3476 +5486 2 2 12 9 610 3258 2552 +5487 2 2 12 9 1153 2298 3592 +5488 2 2 12 9 990 2608 2923 +5489 2 2 12 9 377 1922 2951 +5490 2 2 12 9 1068 3326 1949 +5491 2 2 12 9 1380 2748 2208 +5492 2 2 12 9 1405 2878 3592 +5493 2 2 12 9 697 3474 1930 +5494 2 2 12 9 429 2804 2830 +5495 2 2 12 9 509 2495 2800 +5496 2 2 12 9 1928 3527 3346 +5497 2 2 12 9 514 2489 3616 +5498 2 2 12 9 489 2030 2770 +5499 2 2 12 9 491 2771 2031 +5500 2 2 12 9 1486 2167 3025 +5501 2 2 12 9 1253 2808 2770 +5502 2 2 12 9 527 2033 3006 +5503 2 2 12 9 528 3007 2034 +5504 2 2 12 9 1070 2254 3362 +5505 2 2 12 9 1166 2065 3314 +5506 2 2 12 9 1283 2644 2884 +5507 2 2 12 9 876 2455 2240 +5508 2 2 12 9 207 3599 2306 +5509 2 2 12 9 1191 2078 3563 +5510 2 2 12 9 611 1954 3074 +5511 2 2 12 9 695 1916 3352 +5512 2 2 12 9 1146 3366 2835 +5513 2 2 12 9 652 2261 3003 +5514 2 2 12 9 1390 2612 3530 +5515 2 2 12 9 1430 3497 1973 +5516 2 2 12 9 275 276 3420 +5517 2 2 12 9 846 2020 2802 +5518 2 2 12 9 1132 3202 2099 +5519 2 2 12 9 871 2695 2064 +5520 2 2 12 9 1094 3381 2576 +5521 2 2 12 9 865 3380 1920 +5522 2 2 12 9 943 1897 3377 +5523 2 2 12 9 944 3378 1898 +5524 2 2 12 9 1703 2357 3109 +5525 2 2 12 9 518 1964 3246 +5526 2 2 12 9 46 47 3018 +5527 2 2 12 9 174 175 3019 +5528 2 2 12 9 955 2562 2192 +5529 2 2 12 9 937 3074 1954 +5530 2 2 12 9 943 2122 2573 +5531 2 2 12 9 944 2574 2123 +5532 2 2 12 9 347 2013 2664 +5533 2 2 12 9 1539 2474 2584 +5534 2 2 12 9 988 3518 2743 +5535 2 2 12 9 989 2744 3519 +5536 2 2 12 9 1489 2788 3242 +5537 2 2 12 9 1474 3373 3078 +5538 2 2 12 9 1279 3251 2590 +5539 2 2 12 9 1189 2646 3058 +5540 2 2 12 9 33 34 3042 +5541 2 2 12 9 1339 2468 3517 +5542 2 2 12 9 931 2086 3302 +5543 2 2 12 9 1603 3506 2951 +5544 2 2 12 9 818 3030 2205 +5545 2 2 12 9 527 2929 2069 +5546 2 2 12 9 528 2070 2930 +5547 2 2 12 9 1058 2871 2461 +5548 2 2 12 9 805 2520 2263 +5549 2 2 12 9 923 3565 3558 +5550 2 2 12 9 924 3559 3566 +5551 2 2 12 9 940 2074 3393 +5552 2 2 12 9 918 2666 2654 +5553 2 2 12 9 919 2655 2667 +5554 2 2 12 9 870 2270 2567 +5555 2 2 12 9 475 2025 2702 +5556 2 2 12 9 476 2703 2026 +5557 2 2 12 9 1206 2152 3298 +5558 2 2 12 9 571 2310 2637 +5559 2 2 12 9 527 3006 2094 +5560 2 2 12 9 528 2095 3007 +5561 2 2 12 9 187 188 3069 +5562 2 2 12 9 1425 2811 2699 +5563 2 2 12 9 378 3143 2056 +5564 2 2 12 9 707 2728 2745 +5565 2 2 12 9 708 2746 2729 +5566 2 2 12 9 895 1958 2879 +5567 2 2 12 9 1348 2493 3221 +5568 2 2 12 9 1012 3472 1913 +5569 2 2 12 9 360 2870 1982 +5570 2 2 12 9 1458 2211 3451 +5571 2 2 12 9 1086 1944 3052 +5572 2 2 12 9 892 3486 2843 +5573 2 2 12 9 945 2599 2140 +5574 2 2 12 9 1021 2533 2613 +5575 2 2 12 9 1197 2120 3293 +5576 2 2 12 9 1198 3294 2121 +5577 2 2 12 9 1753 3142 2496 +5578 2 2 12 9 828 2511 3077 +5579 2 2 12 9 190 191 3075 +5580 2 2 12 9 41 42 3083 +5581 2 2 12 9 179 180 3084 +5582 2 2 12 9 1226 2501 2672 +5583 2 2 12 9 884 2628 3641 +5584 2 2 12 9 1270 2578 2179 +5585 2 2 12 9 1402 2510 2400 +5586 2 2 12 9 850 2924 2334 +5587 2 2 12 9 407 2244 2646 +5588 2 2 12 9 976 2518 2680 +5589 2 2 12 9 1353 2306 3599 +5590 2 2 12 9 586 2873 2480 +5591 2 2 12 9 1397 3079 2478 +5592 2 2 12 9 961 1906 3220 +5593 2 2 12 9 1035 3163 3233 +5594 2 2 12 9 213 214 3104 +5595 2 2 12 9 1036 3234 3164 +5596 2 2 12 9 1446 2947 2603 +5597 2 2 12 9 242 3610 2600 +5598 2 2 12 9 334 2601 3611 +5599 2 2 12 9 1452 3351 3291 +5600 2 2 12 9 962 3137 1951 +5601 2 2 12 9 400 2551 3136 +5602 2 2 12 9 1254 2771 2810 +5603 2 2 12 9 1164 2420 3266 +5604 2 2 12 9 1030 1926 3105 +5605 2 2 12 9 347 3368 2013 +5606 2 2 12 9 1365 2608 3235 +5607 2 2 12 9 1845 1961 3416 +5608 2 2 12 9 712 1913 3472 +5609 2 2 12 9 1381 3576 2349 +5610 2 2 12 9 203 204 3128 +5611 2 2 12 9 1338 2679 3448 +5612 2 2 12 9 913 2672 2501 +5613 2 2 12 9 1457 2742 2436 +5614 2 2 12 9 2128 3282 2682 +5615 2 2 12 9 1350 2824 3613 +5616 2 2 12 9 1498 3548 2832 +5617 2 2 12 9 1499 2834 3549 +5618 2 2 12 9 1328 2477 2309 +5619 2 2 12 9 283 284 2932 +5620 2 2 12 9 1165 3304 3353 +5621 2 2 12 9 1026 2637 2687 +5622 2 2 12 9 953 3226 2088 +5623 2 2 12 9 954 2089 3227 +5624 2 2 12 9 492 1938 3498 +5625 2 2 12 9 489 2770 2808 +5626 2 2 12 9 396 1996 2905 +5627 2 2 12 9 551 3618 1967 +5628 2 2 12 9 552 1968 3619 +5629 2 2 12 9 504 3220 1906 +5630 2 2 12 9 1140 1879 3278 +5631 2 2 12 9 1175 3329 3165 +5632 2 2 12 9 1003 3127 2327 +5633 2 2 12 9 827 2643 2182 +5634 2 2 12 9 293 294 2959 +5635 2 2 12 9 871 2400 2510 +5636 2 2 12 9 964 2146 2692 +5637 2 2 12 9 965 2693 2148 +5638 2 2 12 9 988 2743 2126 +5639 2 2 12 9 989 2127 2744 +5640 2 2 12 9 600 3435 2192 +5641 2 2 12 9 473 2009 2844 +5642 2 2 12 9 1013 1860 3403 +5643 2 2 12 9 1186 3629 2228 +5644 2 2 12 9 201 1973 3497 +5645 2 2 12 9 683 3564 3334 +5646 2 2 12 9 1387 3620 3169 +5647 2 2 12 9 1388 3170 3621 +5648 2 2 12 9 432 3118 1935 +5649 2 2 12 9 433 1936 3119 +5650 2 2 12 9 967 3192 2237 +5651 2 2 12 9 978 2770 2030 +5652 2 2 12 9 979 2031 2771 +5653 2 2 12 9 1053 1929 3290 +5654 2 2 12 9 980 1974 3205 +5655 2 2 12 9 490 2160 2621 +5656 2 2 12 9 1071 2583 2563 +5657 2 2 12 9 1192 2128 3631 +5658 2 2 12 9 1389 2393 3353 +5659 2 2 12 9 341 2965 1991 +5660 2 2 12 9 1007 1912 3421 +5661 2 2 12 9 1024 2563 2583 +5662 2 2 12 9 1116 2701 2151 +5663 2 2 12 9 1035 2502 2852 +5664 2 2 12 9 1036 2853 2503 +5665 2 2 12 9 1959 3632 3009 +5666 2 2 12 9 1293 2198 3523 +5667 2 2 12 9 1184 2480 2873 +5668 2 2 12 9 1294 2830 2804 +5669 2 2 12 9 1068 2208 2748 +5670 2 2 12 9 883 2347 2534 +5671 2 2 12 9 277 3044 2238 +5672 2 2 12 9 535 2854 3209 +5673 2 2 12 9 819 3271 2107 +5674 2 2 12 9 524 2262 2867 +5675 2 2 12 9 1197 3359 2245 +5676 2 2 12 9 1198 2246 3360 +5677 2 2 12 9 953 2088 2677 +5678 2 2 12 9 954 2678 2089 +5679 2 2 12 9 983 3297 1952 +5680 2 2 12 9 491 2810 2771 +5681 2 2 12 9 592 2596 2260 +5682 2 2 12 9 851 3625 2427 +5683 2 2 12 9 973 2117 3089 +5684 2 2 12 9 974 3090 2118 +5685 2 2 12 9 1084 3446 1967 +5686 2 2 12 9 1085 1968 3447 +5687 2 2 12 9 959 2332 2780 +5688 2 2 12 9 960 2781 2333 +5689 2 2 12 9 517 1900 3152 +5690 2 2 12 9 842 2200 2805 +5691 2 2 12 9 518 3153 1901 +5692 2 2 12 9 971 2248 3270 +5693 2 2 12 9 1489 3634 2788 +5694 2 2 12 9 1248 2745 2728 +5695 2 2 12 9 1249 2729 2746 +5696 2 2 12 9 581 2816 2525 +5697 2 2 12 9 582 2526 2817 +5698 2 2 12 9 1110 2613 2533 +5699 2 2 12 9 195 196 3299 +5700 2 2 12 9 1401 2427 3625 +5701 2 2 12 9 934 3106 2141 +5702 2 2 12 9 1037 2884 2644 +5703 2 2 12 9 443 3563 2078 +5704 2 2 12 9 1117 2056 3143 +5705 2 2 12 9 1417 2090 3168 +5706 2 2 12 9 593 2942 2375 +5707 2 2 12 9 978 3385 1975 +5708 2 2 12 9 594 2376 2943 +5709 2 2 12 9 979 1976 3386 +5710 2 2 12 9 1414 2153 2895 +5711 2 2 12 9 497 2366 2860 +5712 2 2 12 9 613 3499 2176 +5713 2 2 12 9 1308 3273 2149 +5714 2 2 12 9 792 1955 3316 +5715 2 2 12 9 1023 3109 2357 +5716 2 2 12 9 1241 2654 2666 +5717 2 2 12 9 401 1951 3137 +5718 2 2 12 9 1242 2667 2655 +5719 2 2 12 9 211 212 3314 +5720 2 2 12 9 420 2792 2172 +5721 2 2 12 9 421 2173 2794 +5722 2 2 12 9 248 2775 3176 +5723 2 2 12 9 328 3177 2776 +5724 2 2 12 9 1021 2646 2244 +5725 2 2 12 9 703 3632 1959 +5726 2 2 12 9 777 3008 1954 +5727 2 2 12 9 1109 3352 1916 +5728 2 2 12 9 1119 3078 3373 +5729 2 2 12 9 624 2122 3493 +5730 2 2 12 9 625 3494 2123 +5731 2 2 12 9 1185 2461 2871 +5732 2 2 12 9 1513 3315 2184 +5733 2 2 12 9 1027 2765 3628 +5734 2 2 12 9 18 19 3354 +5735 2 2 12 9 4 239 3588 +5736 2 2 12 9 3 3589 337 +5737 2 2 12 9 277 278 3044 +5738 2 2 12 9 1086 2432 2622 +5739 2 2 12 9 563 3421 1912 +5740 2 2 12 9 658 3190 2075 +5741 2 2 12 9 595 2634 3560 +5742 2 2 12 9 1488 3091 3211 +5743 2 2 12 9 1208 2805 2093 +5744 2 2 12 9 1079 2550 3281 +5745 2 2 12 9 4 3588 52 +5746 2 2 12 9 3 169 3589 +5747 2 2 12 9 265 266 3606 +5748 2 2 12 9 310 311 3607 +5749 2 2 12 9 977 3011 1929 +5750 2 2 12 9 1110 1958 3585 +5751 2 2 12 9 621 3513 2845 +5752 2 2 12 9 674 3631 2128 +5753 2 2 12 9 368 2753 2430 +5754 2 2 12 9 1120 2180 3207 +5755 2 2 12 9 1061 2069 2929 +5756 2 2 12 9 1000 2648 2290 +5757 2 2 12 9 1063 2930 2070 +5758 2 2 12 9 200 201 3497 +5759 2 2 12 9 881 2675 2228 +5760 2 2 12 9 355 2245 3359 +5761 2 2 12 9 380 3371 1920 +5762 2 2 12 9 356 3360 2246 +5763 2 2 12 9 1320 3516 2958 +5764 2 2 12 9 1448 3043 2226 +5765 2 2 12 9 1136 3096 3181 +5766 2 2 12 9 1401 2597 3371 +5767 2 2 12 9 207 208 3599 +5768 2 2 12 9 10 11 3624 +5769 2 2 12 9 584 2622 2432 +5770 2 2 12 9 896 3073 2496 +5771 2 2 12 9 801 2918 2193 +5772 2 2 12 9 949 2867 2262 +5773 2 2 12 9 1074 3211 3091 +5774 2 2 12 9 994 3478 1965 +5775 2 2 12 9 1310 1918 3130 +5776 2 2 12 9 1113 2589 3025 +5777 2 2 12 9 461 2419 3408 +5778 2 2 12 9 436 3009 2039 +5779 2 2 12 9 879 2683 2189 +5780 2 2 12 9 1307 3136 2551 +5781 2 2 12 9 1481 3274 2114 +5782 2 2 12 9 1482 2115 3277 +5783 2 2 12 9 1822 2499 3641 +5784 2 2 12 9 789 2009 3427 +5785 2 2 12 9 994 2849 2730 +5786 2 2 12 9 1421 3422 1953 +5787 2 2 12 9 846 2134 2749 +5788 2 2 12 9 1441 2260 3070 +5789 2 2 12 9 938 3063 2451 +5790 2 2 12 9 939 2452 3064 +5791 2 2 12 9 992 2366 2649 +5792 2 2 12 9 993 2650 2367 +5793 2 2 12 9 378 2056 2940 +5794 2 2 12 9 1075 3073 2328 +5795 2 2 12 9 553 2580 2806 +5796 2 2 12 9 1674 3392 2092 +5797 2 2 12 9 500 1965 3478 +5798 2 2 12 9 1096 3350 1867 +5799 2 2 12 9 216 217 3465 +5800 2 2 12 9 1517 2843 3486 +5801 2 2 12 9 1096 3531 2977 +5802 2 2 12 9 1092 2687 2637 +5803 2 2 12 9 249 250 3622 +5804 2 2 12 9 326 327 3623 +5805 2 2 12 9 437 3482 3422 +5806 2 2 12 9 1356 2106 2823 +5807 2 2 12 9 835 3402 1969 +5808 2 2 12 9 1451 3209 2854 +5809 2 2 12 9 1000 2290 2638 +5810 2 2 12 9 346 3041 2004 +5811 2 2 12 9 1081 2169 3083 +5812 2 2 12 9 1082 3084 2170 +5813 2 2 12 9 858 2436 2742 +5814 2 2 12 9 610 1952 3274 +5815 2 2 12 9 1354 3451 2211 +5816 2 2 12 9 1080 2075 3190 +5817 2 2 12 9 497 2860 2604 +5818 2 2 12 9 611 3277 1954 +5819 2 2 12 9 225 226 3276 +5820 2 2 12 9 667 2555 2576 +5821 2 2 12 9 1025 2519 2483 +5822 2 2 12 9 972 3464 2107 +5823 2 2 12 9 1555 2628 2529 +5824 2 2 12 9 968 3517 2468 +5825 2 2 12 9 956 2280 3544 +5826 2 2 12 9 1259 2098 3648 +5827 2 2 12 9 1149 3340 2696 +5828 2 2 12 9 247 248 3176 +5829 2 2 12 9 328 329 3177 +5830 2 2 12 9 676 3431 3308 +5831 2 2 12 9 1807 2949 3598 +5832 2 2 12 9 1145 3093 3616 +5833 2 2 12 9 1002 2182 2643 +5834 2 2 12 9 559 1990 3257 +5835 2 2 12 9 1245 2730 2849 +5836 2 2 12 9 366 3457 1939 +5837 2 2 12 9 1492 3026 2210 +5838 2 2 12 9 885 1953 3334 +5839 2 2 12 9 419 2290 2648 +5840 2 2 12 9 1280 2335 2969 +5841 2 2 12 9 1786 2515 3240 +5842 2 2 12 9 1787 3241 2516 +5843 2 2 12 9 1527 2963 3591 +5844 2 2 12 9 436 3147 3263 +5845 2 2 12 9 1612 2624 2842 +5846 2 2 12 9 348 2086 2977 +5847 2 2 12 9 1094 2576 2555 +5848 2 2 12 9 397 2880 3540 +5849 2 2 12 9 866 3598 2159 +5850 2 2 12 9 551 1967 3446 +5851 2 2 12 9 552 3447 1968 +5852 2 2 12 9 296 297 3223 +5853 2 2 12 9 1285 2726 2494 +5854 2 2 12 9 1019 1986 3394 +5855 2 2 12 9 941 3157 2593 +5856 2 2 12 9 1002 2752 2329 +5857 2 2 12 9 1152 2238 3044 +5858 2 2 12 9 657 3365 2546 +5859 2 2 12 9 1491 3560 2634 +5860 2 2 12 9 546 2215 2737 +5861 2 2 12 9 547 2738 2216 +5862 2 2 12 9 622 2584 2474 +5863 2 2 12 9 443 2078 3394 +5864 2 2 12 9 1510 2552 3258 +5865 2 2 12 9 961 2362 3374 +5866 2 2 12 9 41 3083 2169 +5867 2 2 12 9 180 2170 3084 +5868 2 2 12 9 1376 2375 2942 +5869 2 2 12 9 1377 2943 2376 +5870 2 2 12 9 1415 3176 2775 +5871 2 2 12 9 1416 2776 3177 +5872 2 2 12 9 513 3419 2478 +5873 2 2 12 9 1188 2459 3582 +5874 2 2 12 9 1210 2632 3445 +5875 2 2 12 9 716 3601 3403 +5876 2 2 12 9 1065 3356 3479 +5877 2 2 12 9 1511 3259 2577 +5878 2 2 12 9 1030 3105 1973 +5879 2 2 12 9 443 3394 1986 +5880 2 2 12 9 1026 2483 2519 +5881 2 2 12 9 1164 3266 3489 +5882 2 2 12 9 1061 2760 3116 +5883 2 2 12 9 1063 3117 2761 +5884 2 2 12 9 349 2636 3284 +5885 2 2 12 9 1172 3598 2949 +5886 2 2 12 9 1488 2433 3091 +5887 2 2 12 9 385 2449 3139 +5888 2 2 12 9 384 3140 2450 +5889 2 2 12 9 793 3029 1986 +5890 2 2 12 9 612 3180 2458 +5891 2 2 12 9 524 2867 2416 +5892 2 2 12 9 516 2884 2361 +5893 2 2 12 9 911 2094 3006 +5894 2 2 12 9 912 3007 2095 +5895 2 2 12 9 553 2916 2733 +5896 2 2 12 9 1576 3263 3147 +5897 2 2 12 9 541 1993 3343 +5898 2 2 12 9 1047 3173 3571 +5899 2 2 12 9 1048 3572 3174 +5900 2 2 12 9 791 1962 3206 +5901 2 2 12 9 477 1984 3430 +5902 2 2 12 9 1253 2202 2808 +5903 2 2 12 9 1001 2073 3134 +5904 2 2 12 9 471 2891 2379 +5905 2 2 12 9 573 3038 3300 +5906 2 2 12 9 1144 2984 2046 +5907 2 2 12 9 1335 3144 2532 +5908 2 2 12 9 819 2287 3271 +5909 2 2 12 9 629 2477 3400 +5910 2 2 12 9 1087 2895 2153 +5911 2 2 12 9 906 2344 2636 +5912 2 2 12 9 867 2342 2614 +5913 2 2 12 9 865 2062 3184 +5914 2 2 12 9 1246 2238 2865 +5915 2 2 12 9 1112 1928 3305 +5916 2 2 12 9 1139 3108 2568 +5917 2 2 12 9 1622 3311 2852 +5918 2 2 12 9 855 2297 3092 +5919 2 2 12 9 1623 2853 3312 +5920 2 2 12 9 755 3054 2078 +5921 2 2 12 9 275 3420 2212 +5922 2 2 12 9 1359 2716 3351 +5923 2 2 12 9 1254 2810 2203 +5924 2 2 12 9 392 2318 2760 +5925 2 2 12 9 393 2761 2319 +5926 2 2 12 9 410 2969 2335 +5927 2 2 12 9 1136 3181 2598 +5928 2 2 12 9 920 2144 2888 +5929 2 2 12 9 1654 3558 3565 +5930 2 2 12 9 1655 3566 3559 +5931 2 2 12 9 1602 2149 3273 +5932 2 2 12 9 527 2094 2929 +5933 2 2 12 9 528 2930 2095 +5934 2 2 12 9 966 3521 2210 +5935 2 2 12 9 1257 3411 2035 +5936 2 2 12 9 1018 2940 2056 +5937 2 2 12 9 376 3346 3527 +5938 2 2 12 9 1856 3403 3601 +5939 2 2 12 9 982 2165 2996 +5940 2 2 12 9 643 3125 2620 +5941 2 2 12 9 907 3448 2679 +5942 2 2 12 9 491 2031 3495 +5943 2 2 12 9 1112 3527 1928 +5944 2 2 12 9 1142 3144 3262 +5945 2 2 12 9 722 3138 2485 +5946 2 2 12 9 1452 2135 3351 +5947 2 2 12 9 897 2363 2905 +5948 2 2 12 9 305 306 3512 +5949 2 2 12 9 447 3134 2073 +5950 2 2 12 9 489 3573 2030 +5951 2 2 12 9 568 2789 2519 +5952 2 2 12 9 242 243 3610 +5953 2 2 12 9 333 334 3611 +5954 2 2 12 9 1157 3330 2255 +5955 2 2 12 9 1158 2256 3331 +5956 2 2 12 9 1343 3116 2760 +5957 2 2 12 9 934 2141 2970 +5958 2 2 12 9 1344 2761 3117 +5959 2 2 12 9 1030 1973 3231 +5960 2 2 12 9 218 3032 2067 +5961 2 2 12 9 914 2897 2206 +5962 2 2 12 9 950 2754 2213 +5963 2 2 12 9 951 2214 2755 +5964 2 2 12 9 437 3591 2963 +5965 2 2 12 9 560 3648 2098 +5966 2 2 12 9 1026 2687 2483 +5967 2 2 12 9 521 3207 2180 +5968 2 2 12 9 1370 2546 3365 +5969 2 2 12 9 1229 3139 2449 +5970 2 2 12 9 1230 2450 3140 +5971 2 2 12 9 1027 2848 2432 +5972 2 2 12 9 1239 2568 3108 +5973 2 2 12 9 897 2813 2241 +5974 2 2 12 9 1113 3025 2167 +5975 2 2 12 9 559 3329 2254 +5976 2 2 12 9 1328 3400 2477 +5977 2 2 12 9 1573 3578 2752 +5978 2 2 12 9 1409 3416 1961 +5979 2 2 12 9 423 3381 2014 +5980 2 2 12 9 639 3291 3351 +5981 2 2 12 9 523 3553 2008 +5982 2 2 12 9 1231 2008 3553 +5983 2 2 12 9 1211 2485 3138 +5984 2 2 12 9 550 2347 2701 +5985 2 2 12 9 1257 2035 3470 +5986 2 2 12 9 906 3055 2344 +5987 2 2 12 9 1326 2193 2918 +5988 2 2 12 9 497 2649 2366 +5989 2 2 12 9 498 2367 2650 +5990 2 2 12 9 956 3544 2512 +5991 2 2 12 9 411 2329 2752 +5992 2 2 12 9 1006 2225 3232 +5993 2 2 12 9 1456 2512 3544 +5994 2 2 12 9 884 2529 2628 +5995 2 2 12 9 908 2653 2570 +5996 2 2 12 9 744 2033 3341 +5997 2 2 12 9 745 3342 2034 +5998 2 2 12 9 1394 3165 3329 +5999 2 2 12 9 1003 3268 2335 +6000 2 2 12 9 1053 3290 2285 +6001 2 2 12 9 707 2255 3330 +6002 2 2 12 9 708 3331 2256 +6003 2 2 12 9 1010 2799 2244 +6004 2 2 12 9 203 3128 2294 +6005 2 2 12 9 1464 3334 3564 +6006 2 2 12 9 1035 3311 2330 +6007 2 2 12 9 1036 2331 3312 +6008 2 2 12 9 1307 2551 2662 +6009 2 2 12 9 557 2909 2462 +6010 2 2 12 9 639 3351 2716 +6011 2 2 12 9 598 3091 2433 +6012 2 2 12 9 1011 2908 2201 +6013 2 2 12 9 371 1975 3385 +6014 2 2 12 9 372 3386 1976 +6015 2 2 12 9 623 2631 3530 +6016 2 2 12 9 348 3302 2086 +6017 2 2 12 9 758 2150 3305 +6018 2 2 12 9 1056 2288 2816 +6019 2 2 12 9 1057 2817 2289 +6020 2 2 12 9 513 2973 2206 +6021 2 2 12 9 1173 2108 2993 +6022 2 2 12 9 489 2808 2217 +6023 2 2 12 9 410 3268 2682 +6024 2 2 12 9 1152 2865 2238 +6025 2 2 12 9 1153 3092 2297 +6026 2 2 12 9 2025 3556 2702 +6027 2 2 12 9 2026 2703 3557 +6028 2 2 12 9 1490 3005 2185 +6029 2 2 12 9 394 2483 2687 +6030 2 2 12 9 1220 2922 2670 +6031 2 2 12 9 1121 2043 3556 +6032 2 2 12 9 1122 3557 2044 +6033 2 2 12 9 1128 2294 3128 +6034 2 2 12 9 420 3338 2610 +6035 2 2 12 9 480 2141 3106 +6036 2 2 12 9 491 2231 2810 +6037 2 2 12 9 421 2611 3339 +6038 2 2 12 9 1068 2092 3326 +6039 2 2 12 9 1332 3256 2071 +6040 2 2 12 9 1649 3100 2874 +6041 2 2 12 9 1026 2598 2637 +6042 2 2 12 9 1175 2254 3329 +6043 2 2 12 9 632 3503 2066 +6044 2 2 12 9 456 2933 2575 +6045 2 2 12 9 1109 2965 2522 +6046 2 2 12 9 828 3077 2190 +6047 2 2 12 9 915 2417 2762 +6048 2 2 12 9 265 3606 2350 +6049 2 2 12 9 311 2351 3607 +6050 2 2 12 9 252 2088 3226 +6051 2 2 12 9 324 3227 2089 +6052 2 2 12 9 906 2424 3055 +6053 2 2 12 9 608 3393 2074 +6054 2 2 12 9 1536 2709 3487 +6055 2 2 12 9 543 2920 2137 +6056 2 2 12 9 544 2138 2921 +6057 2 2 12 9 890 3556 2043 +6058 2 2 12 9 891 2044 3557 +6059 2 2 12 9 1187 3480 1993 +6060 2 2 12 9 516 3107 2884 +6061 2 2 12 9 1343 2760 2318 +6062 2 2 12 9 1344 2319 2761 +6063 2 2 12 9 1125 2332 2885 +6064 2 2 12 9 1126 2886 2333 +6065 2 2 12 9 1251 2205 3030 +6066 2 2 12 9 1088 2858 2581 +6067 2 2 12 9 1089 2582 2859 +6068 2 2 12 9 1447 3292 3053 +6069 2 2 12 9 630 2780 2332 +6070 2 2 12 9 631 2333 2781 +6071 2 2 12 9 298 3412 2063 +6072 2 2 12 9 935 2662 2551 +6073 2 2 12 9 1104 3317 2728 +6074 2 2 12 9 1105 2729 3318 +6075 2 2 12 9 1107 2803 2527 +6076 2 2 12 9 1247 2620 3125 +6077 2 2 12 9 1474 3078 2403 +6078 2 2 12 9 20 3114 2159 +6079 2 2 12 9 1437 2981 3534 +6080 2 2 12 9 1438 3535 2982 +6081 2 2 12 9 1471 2570 2653 +6082 2 2 12 9 915 2762 3501 +6083 2 2 12 9 637 2265 3179 +6084 2 2 12 9 1004 2047 3212 +6085 2 2 12 9 1005 3213 2048 +6086 2 2 12 9 1112 3305 2150 +6087 2 2 12 9 684 2537 3113 +6088 2 2 12 9 980 2527 2803 +6089 2 2 12 9 764 3202 2176 +6090 2 2 12 9 1283 2884 3107 +6091 2 2 12 9 1110 2166 3146 +6092 2 2 12 9 1477 3479 3356 +6093 2 2 12 9 633 3373 3022 +6094 2 2 12 9 1139 2133 3510 +6095 2 2 12 9 2010 3614 2561 +6096 2 2 12 9 1086 2765 2432 +6097 2 2 12 9 779 2668 3436 +6098 2 2 12 9 1069 2616 2622 +6099 2 2 12 9 1130 2782 2388 +6100 2 2 12 9 1131 2389 2783 +6101 2 2 12 9 646 2315 3275 +6102 2 2 12 9 530 3471 2204 +6103 2 2 12 9 932 3612 2258 +6104 2 2 12 9 1376 2942 3214 +6105 2 2 12 9 1377 3215 2943 +6106 2 2 12 9 414 2820 2945 +6107 2 2 12 9 1192 3282 2128 +6108 2 2 12 9 1324 3233 3163 +6109 2 2 12 9 1325 3164 3234 +6110 2 2 12 9 1226 2672 3208 +6111 2 2 12 9 1474 3022 3373 +6112 2 2 12 9 1100 3214 2942 +6113 2 2 12 9 1527 3591 2472 +6114 2 2 12 9 1101 2943 3215 +6115 2 2 12 9 941 3396 2358 +6116 2 2 12 9 1233 2665 3221 +6117 2 2 12 9 1127 2645 2751 +6118 2 2 12 9 1411 3530 2631 +6119 2 2 12 9 1611 2285 3191 +6120 2 2 12 9 1791 3476 2186 +6121 2 2 12 9 1378 2005 3499 +6122 2 2 12 9 571 2637 2598 +6123 2 2 12 9 1018 2056 3254 +6124 2 2 12 9 794 3574 2053 +6125 2 2 12 9 1090 3045 3171 +6126 2 2 12 9 1091 3172 3046 +6127 2 2 12 9 1348 3221 2665 +6128 2 2 12 9 1026 2789 2598 +6129 2 2 12 9 396 3517 2507 +6130 2 2 12 9 929 2860 2366 +6131 2 2 12 9 1041 2262 3158 +6132 2 2 12 9 791 3389 2112 +6133 2 2 12 9 896 2496 3142 +6134 2 2 12 9 392 2760 2581 +6135 2 2 12 9 393 2582 2761 +6136 2 2 12 9 1608 2394 3574 +6137 2 2 12 9 1123 2051 3413 +6138 2 2 12 9 1124 3414 2052 +6139 2 2 12 9 477 2107 3464 +6140 2 2 12 9 618 2022 3456 +6141 2 2 12 9 687 3169 3620 +6142 2 2 12 9 688 3621 3170 +6143 2 2 12 9 362 2247 3361 +6144 2 2 12 9 1051 3477 2105 +6145 2 2 12 9 1332 2682 3268 +6146 2 2 12 9 714 2494 2726 +6147 2 2 12 9 1083 2751 2645 +6148 2 2 12 9 1320 2658 2773 +6149 2 2 12 9 1221 2854 3429 +6150 2 2 12 9 973 3089 2525 +6151 2 2 12 9 974 2526 3090 +6152 2 2 12 9 929 2322 2801 +6153 2 2 12 9 353 3053 3292 +6154 2 2 12 9 1129 3179 2265 +6155 2 2 12 9 1275 2778 3428 +6156 2 2 12 9 607 2874 3100 +6157 2 2 12 9 666 2788 2554 +6158 2 2 12 9 376 3527 2125 +6159 2 2 12 9 1006 2264 3560 +6160 2 2 12 9 1032 3038 2452 +6161 2 2 12 9 1290 3503 2572 +6162 2 2 12 9 341 2522 2965 +6163 2 2 12 9 626 3135 2704 +6164 2 2 12 9 1296 2350 3606 +6165 2 2 12 9 1297 3607 2351 +6166 2 2 12 9 1161 2226 3043 +6167 2 2 12 9 1429 3263 2338 +6168 2 2 12 9 1140 2050 3475 +6169 2 2 12 9 1086 2622 2616 +6170 2 2 12 9 584 2432 2848 +6171 2 2 12 9 1463 2747 3469 +6172 2 2 12 9 1003 2335 3127 +6173 2 2 12 9 1125 3541 2047 +6174 2 2 12 9 1126 2048 3542 +6175 2 2 12 9 1337 3511 2145 +6176 2 2 12 9 574 2447 3567 +6177 2 2 12 9 836 2431 3376 +6178 2 2 12 9 575 3568 2448 +6179 2 2 12 9 643 3496 3613 +6180 2 2 12 9 590 2338 2931 +6181 2 2 12 9 392 2581 2858 +6182 2 2 12 9 393 2859 2582 +6183 2 2 12 9 1178 2575 2933 +6184 2 2 12 9 1199 3113 2537 +6185 2 2 12 9 818 3249 2229 +6186 2 2 12 9 1026 2519 2789 +6187 2 2 12 9 501 2037 3593 +6188 2 2 12 9 1320 2773 3516 +6189 2 2 12 9 1391 2775 3622 +6190 2 2 12 9 1392 3623 2776 +6191 2 2 12 9 1306 2686 2669 +6192 2 2 12 9 1196 2847 3125 +6193 2 2 12 9 1030 3231 2294 +6194 2 2 12 9 972 2107 3271 +6195 2 2 12 9 540 3023 2296 +6196 2 2 12 9 676 3424 3431 +6197 2 2 12 9 1054 2249 3349 +6198 2 2 12 9 506 3324 2142 +6199 2 2 12 9 507 2143 3325 +6200 2 2 12 9 524 3158 2262 +6201 2 2 12 9 1112 2125 3527 +6202 2 2 12 9 1175 3165 2648 +6203 2 2 12 9 1104 3087 3317 +6204 2 2 12 9 1105 3318 3088 +6205 2 2 12 9 679 3468 2151 +6206 2 2 12 9 1197 3279 2120 +6207 2 2 12 9 1198 2121 3280 +6208 2 2 12 9 543 2440 2920 +6209 2 2 12 9 544 2921 2441 +6210 2 2 12 9 1062 2795 2833 +6211 2 2 12 9 1206 3203 2152 +6212 2 2 12 9 1247 3125 2847 +6213 2 2 12 9 1331 3014 2635 +6214 2 2 12 9 1485 2423 3295 +6215 2 2 12 9 1200 2373 3169 +6216 2 2 12 9 1201 3170 2374 +6217 2 2 12 9 1364 3182 3112 +6218 2 2 12 9 652 3157 2261 +6219 2 2 12 9 585 3052 2408 +6220 2 2 12 9 950 3066 2301 +6221 2 2 12 9 951 2302 3067 +6222 2 2 12 9 1116 2151 3468 +6223 2 2 12 9 1240 2258 3612 +6224 2 2 12 9 250 2275 3622 +6225 2 2 12 9 326 3623 2276 +6226 2 2 12 9 1169 2935 2705 +6227 2 2 12 9 840 3171 2161 +6228 2 2 12 9 841 2162 3172 +6229 2 2 12 9 1725 3050 2936 +6230 2 2 12 9 1726 2937 3051 +6231 2 2 12 9 411 3578 2234 +6232 2 2 12 9 1055 2927 3107 +6233 2 2 12 9 539 2635 3014 +6234 2 2 12 9 1035 2330 3163 +6235 2 2 12 9 1036 3164 2331 +6236 2 2 12 9 1013 2379 2891 +6237 2 2 12 9 812 2093 3550 +6238 2 2 12 9 1038 3424 2415 +6239 2 2 12 9 1069 2149 3522 +6240 2 2 12 9 1359 3351 2135 +6241 2 2 12 9 1097 3250 2303 +6242 2 2 12 9 952 3126 2528 +6243 2 2 12 9 1290 2945 2820 +6244 2 2 12 9 569 2528 3156 +6245 2 2 12 9 1171 3361 2247 +6246 2 2 12 9 975 3003 2261 +6247 2 2 12 9 1141 2697 2925 +6248 2 2 12 9 1061 2581 2760 +6249 2 2 12 9 1063 2761 2582 +6250 2 2 12 9 1239 3108 2836 +6251 2 2 12 9 1147 2472 3186 +6252 2 2 12 9 1035 3233 2502 +6253 2 2 12 9 1036 2503 3234 +6254 2 2 12 9 640 3208 2672 +6255 2 2 12 9 1157 2731 3330 +6256 2 2 12 9 1158 3331 2732 +6257 2 2 12 9 379 3582 2459 +6258 2 2 12 9 338 3245 2308 +6259 2 2 12 9 632 2572 3503 +6260 2 2 12 9 985 2727 2663 +6261 2 2 12 9 458 2114 3348 +6262 2 2 12 9 357 2418 2913 +6263 2 2 12 9 622 3388 3161 +6264 2 2 12 9 287 2237 3192 +6265 2 2 12 9 543 2137 3200 +6266 2 2 12 9 1093 2554 2788 +6267 2 2 12 9 544 3201 2138 +6268 2 2 12 9 1594 2522 3507 +6269 2 2 12 9 221 2230 3040 +6270 2 2 12 9 364 3510 2133 +6271 2 2 12 9 1043 2281 3228 +6272 2 2 12 9 1309 2663 2727 +6273 2 2 12 9 1044 3229 2282 +6274 2 2 12 9 964 2936 3050 +6275 2 2 12 9 1292 2184 3315 +6276 2 2 12 9 965 3051 2937 +6277 2 2 12 9 1038 3085 2479 +6278 2 2 12 9 1136 2598 2789 +6279 2 2 12 9 1170 2484 3505 +6280 2 2 12 9 1273 2897 2482 +6281 2 2 12 9 414 2945 2395 +6282 2 2 12 9 247 3176 2377 +6283 2 2 12 9 329 2378 3177 +6284 2 2 12 9 586 2480 2984 +6285 2 2 12 9 523 2150 3553 +6286 2 2 12 9 949 3411 2867 +6287 2 2 12 9 510 2105 3477 +6288 2 2 12 9 662 2164 3539 +6289 2 2 12 9 1315 3295 2423 +6290 2 2 12 9 603 2902 3636 +6291 2 2 12 9 1189 2833 2795 +6292 2 2 12 9 1135 2308 3245 +6293 2 2 12 9 373 3462 2110 +6294 2 2 12 9 374 2111 3463 +6295 2 2 12 9 640 3522 2149 +6296 2 2 12 9 1054 3500 2249 +6297 2 2 12 9 914 2482 2897 +6298 2 2 12 9 1137 3112 3182 +6299 2 2 12 9 977 2530 3011 +6300 2 2 12 9 629 3451 3355 +6301 2 2 12 9 984 2669 2686 +6302 2 2 12 9 385 3139 3149 +6303 2 2 12 9 384 3150 3140 +6304 2 2 12 9 963 2773 2658 +6305 2 2 12 9 1321 3388 2163 +6306 2 2 12 9 1099 2931 2338 +6307 2 2 12 9 682 3166 2881 +6308 2 2 12 9 619 3186 2472 +6309 2 2 12 9 1327 2681 3286 +6310 2 2 12 9 1065 2249 3356 +6311 2 2 12 9 1295 2604 2860 +6312 2 2 12 9 417 3590 2268 +6313 2 2 12 9 779 3436 2106 +6314 2 2 12 9 934 2700 3106 +6315 2 2 12 9 549 2836 3108 +6316 2 2 12 9 548 3058 2613 +6317 2 2 12 9 1257 2416 2867 +6318 2 2 12 9 1072 2913 2418 +6319 2 2 12 9 1719 3431 3424 +6320 2 2 12 9 879 2189 3321 +6321 2 2 12 9 680 2327 3127 +6322 2 2 12 9 266 2391 3606 +6323 2 2 12 9 310 3607 2392 +6324 2 2 12 9 1455 2657 3601 +6325 2 2 12 9 1274 2704 3135 +6326 2 2 12 9 1771 2349 3576 +6327 2 2 12 9 1024 2583 3344 +6328 2 2 12 9 381 2340 3425 +6329 2 2 12 9 1480 2944 3308 +6330 2 2 12 9 1515 2779 2940 +6331 2 2 12 9 429 3442 2184 +6332 2 2 12 9 1252 3376 2431 +6333 2 2 12 9 1412 2831 3158 +6334 2 2 12 9 556 3225 2638 +6335 2 2 12 9 1059 2174 3488 +6336 2 2 12 9 1071 2563 2958 +6337 2 2 12 9 571 2741 3097 +6338 2 2 12 9 1115 3077 2511 +6339 2 2 12 9 534 3216 2235 +6340 2 2 12 9 1241 2587 3501 +6341 2 2 12 9 1242 3502 2588 +6342 2 2 12 9 572 3063 2654 +6343 2 2 12 9 573 2655 3064 +6344 2 2 12 9 1136 3049 2969 +6345 2 2 12 9 290 3270 2248 +6346 2 2 12 9 893 3093 2320 +6347 2 2 12 9 894 2321 3094 +6348 2 2 12 9 459 3489 2115 +6349 2 2 12 9 1125 2885 2737 +6350 2 2 12 9 1126 2738 2886 +6351 2 2 12 9 943 3493 2122 +6352 2 2 12 9 944 2123 3494 +6353 2 2 12 9 1280 2969 3049 +6354 2 2 12 9 581 3228 2281 +6355 2 2 12 9 582 2282 3229 +6356 2 2 12 9 1656 3550 2398 +6357 2 2 12 9 548 2833 3058 +6358 2 2 12 9 1183 3055 2424 +6359 2 2 12 9 249 3622 2775 +6360 2 2 12 9 327 2776 3623 +6361 2 2 12 9 762 3575 3204 +6362 2 2 12 9 1510 3258 3443 +6363 2 2 12 9 1511 3444 3259 +6364 2 2 12 9 1406 3248 3186 +6365 2 2 12 9 568 3049 2789 +6366 2 2 12 9 1549 3391 2380 +6367 2 2 12 9 1079 2402 3194 +6368 2 2 12 9 559 2990 3329 +6369 2 2 12 9 803 2403 3078 +6370 2 2 12 9 1604 3344 2493 +6371 2 2 12 9 1021 2613 3058 +6372 2 2 12 9 571 3097 2310 +6373 2 2 12 9 659 3296 2461 +6374 2 2 12 9 612 2458 3035 +6375 2 2 12 9 1239 3348 2568 +6376 2 2 12 9 865 2303 3250 +6377 2 2 12 9 1283 3107 2927 +6378 2 2 12 9 550 3529 2347 +6379 2 2 12 9 1227 3627 2433 +6380 2 2 12 9 598 2433 3627 +6381 2 2 12 9 613 3356 2249 +6382 2 2 12 9 391 3115 2346 +6383 2 2 12 9 591 2925 2697 +6384 2 2 12 9 1750 2698 2910 +6385 2 2 12 9 955 2192 3435 +6386 2 2 12 9 1193 3156 2528 +6387 2 2 12 9 454 3163 2330 +6388 2 2 12 9 455 2331 3164 +6389 2 2 12 9 1293 3523 2183 +6390 2 2 12 9 1321 3161 3388 +6391 2 2 12 9 397 3540 2190 +6392 2 2 12 9 707 3240 2728 +6393 2 2 12 9 708 2729 3241 +6394 2 2 12 9 923 3558 2559 +6395 2 2 12 9 924 2560 3559 +6396 2 2 12 9 1102 3635 2790 +6397 2 2 12 9 521 2258 3207 +6398 2 2 12 9 1496 3196 2299 +6399 2 2 12 9 1154 3000 2914 +6400 2 2 12 9 468 2514 3417 +6401 2 2 12 9 896 2328 3073 +6402 2 2 12 9 597 2210 3521 +6403 2 2 12 9 642 2183 3362 +6404 2 2 12 9 1073 2346 3115 +6405 2 2 12 9 629 3355 2477 +6406 2 2 12 9 1246 2212 3420 +6407 2 2 12 9 1143 3539 2164 +6408 2 2 12 9 560 2958 2563 +6409 2 2 12 9 1243 3097 2741 +6410 2 2 12 9 1543 3636 2902 +6411 2 2 12 9 997 3324 2266 +6412 2 2 12 9 998 2267 3325 +6413 2 2 12 9 561 2493 3344 +6414 2 2 12 9 525 3173 2313 +6415 2 2 12 9 526 2314 3174 +6416 2 2 12 9 1269 3009 3632 +6417 2 2 12 9 1387 3149 3139 +6418 2 2 12 9 1388 3140 3150 +6419 2 2 12 9 1163 3012 3141 +6420 2 2 12 9 573 2452 3038 +6421 2 2 12 9 361 2730 2946 +6422 2 2 12 9 1224 2555 3555 +6423 2 2 12 9 943 2573 3016 +6424 2 2 12 9 944 3017 2574 +6425 2 2 12 9 531 3554 2211 +6426 2 2 12 9 774 2625 2978 +6427 2 2 12 9 1065 3479 2349 +6428 2 2 12 9 548 2709 2833 +6429 2 2 12 9 1000 2993 2684 +6430 2 2 12 9 933 2842 2624 +6431 2 2 12 9 1605 3204 3575 +6432 2 2 12 9 963 3275 2315 +6433 2 2 12 9 1073 2211 3554 +6434 2 2 12 9 1303 2881 3166 +6435 2 2 12 9 1214 3191 2285 +6436 2 2 12 9 1387 3169 2373 +6437 2 2 12 9 1388 2374 3170 +6438 2 2 12 9 1921 3056 3346 +6439 2 2 12 9 882 3103 2442 +6440 2 2 12 9 1062 2833 2709 +6441 2 2 12 9 1017 2234 3578 +6442 2 2 12 9 1147 3186 3248 +6443 2 2 12 9 1406 3570 2851 +6444 2 2 12 9 512 3488 2174 +6445 2 2 12 9 613 2249 3500 +6446 2 2 12 9 572 2451 3063 +6447 2 2 12 9 1279 2974 2863 +6448 2 2 12 9 573 3064 2452 +6449 2 2 12 9 566 2766 3398 +6450 2 2 12 9 1453 3605 3615 +6451 2 2 12 9 1087 2851 3570 +6452 2 2 12 9 382 3021 2680 +6453 2 2 12 9 1365 2923 2608 +6454 2 2 12 9 1209 3481 2521 +6455 2 2 12 9 1537 2362 3111 +6456 2 2 12 9 886 3194 2402 +6457 2 2 12 9 802 3260 2473 +6458 2 2 12 9 1167 3443 3258 +6459 2 2 12 9 1168 3259 3444 +6460 2 2 12 9 952 2603 2947 +6461 2 2 12 9 1333 3008 2809 +6462 2 2 12 9 583 2479 3085 +6463 2 2 12 9 340 2284 3528 +6464 2 2 12 9 1056 2816 3644 +6465 2 2 12 9 1057 3645 2817 +6466 2 2 12 9 1394 3329 2990 +6467 2 2 12 9 718 2501 3383 +6468 2 2 12 9 638 2521 3481 +6469 2 2 12 9 574 3567 2832 +6470 2 2 12 9 575 2834 3568 +6471 2 2 12 9 958 3460 2186 +6472 2 2 12 9 425 3516 2773 +6473 2 2 12 9 978 2565 3385 +6474 2 2 12 9 979 3386 2566 +6475 2 2 12 9 1290 2572 2945 +6476 2 2 12 9 1130 2985 2782 +6477 2 2 12 9 1131 2783 2986 +6478 2 2 12 9 1426 3398 2766 +6479 2 2 12 9 1219 2347 3529 +6480 2 2 12 9 619 3570 3186 +6481 2 2 12 9 1154 2796 3000 +6482 2 2 12 9 915 3501 2587 +6483 2 2 12 9 916 2588 3502 +6484 2 2 12 9 622 2474 3388 +6485 2 2 12 9 1032 2978 2625 +6486 2 2 12 9 546 2885 2626 +6487 2 2 12 9 547 2627 2886 +6488 2 2 12 9 1194 3141 3012 +6489 2 2 12 9 1042 2863 2974 +6490 2 2 12 9 1760 3630 2542 +6491 2 2 12 9 410 2335 3268 +6492 2 2 12 9 546 2737 2885 +6493 2 2 12 9 547 2886 2738 +6494 2 2 12 9 348 2910 2698 +6495 2 2 12 9 897 2241 3586 +6496 2 2 12 9 1186 3345 3216 +6497 2 2 12 9 667 3555 2555 +6498 2 2 12 9 305 3512 2535 +6499 2 2 12 9 586 2984 2971 +6500 2 2 12 9 1008 2268 3590 +6501 2 2 12 9 1054 3349 2571 +6502 2 2 12 9 586 2796 2873 +6503 2 2 12 9 1293 3538 2198 +6504 2 2 12 9 1117 2705 2935 +6505 2 2 12 9 1317 2490 3321 +6506 2 2 12 9 467 3614 2453 +6507 2 2 12 9 1354 3355 3451 +6508 2 2 12 9 444 3453 3211 +6509 2 2 12 9 995 2434 3132 +6510 2 2 12 9 996 3133 2435 +6511 2 2 12 9 1634 3427 2300 +6512 2 2 12 9 1076 2446 3246 +6513 2 2 12 9 532 3379 3295 +6514 2 2 12 9 1053 2670 2922 +6515 2 2 12 9 530 2645 3471 +6516 2 2 12 9 1086 3052 2765 +6517 2 2 12 9 983 2881 3297 +6518 2 2 12 9 1192 3181 3096 +6519 2 2 12 9 1245 2946 2730 +6520 2 2 12 9 345 2532 3144 +6521 2 2 12 9 1154 3001 2873 +6522 2 2 12 9 2078 3054 3394 +6523 2 2 12 9 1154 2873 2796 +6524 2 2 12 9 1151 2680 3021 +6525 2 2 12 9 1000 2638 3225 +6526 2 2 12 9 565 3626 2344 +6527 2 2 12 9 534 3629 3216 +6528 2 2 12 9 1075 2328 3434 +6529 2 2 12 9 1832 3098 3137 +6530 2 2 12 9 1491 2634 3647 +6531 2 2 12 9 586 3012 2796 +6532 2 2 12 9 1071 3516 2747 +6533 2 2 12 9 1193 3337 3156 +6534 2 2 12 9 777 2809 3008 +6535 2 2 12 9 1140 3278 2594 +6536 2 2 12 9 1301 2782 2985 +6537 2 2 12 9 1302 2986 2783 +6538 2 2 12 9 1183 2473 3260 +6539 2 2 12 9 401 3137 3098 +6540 2 2 12 9 1144 2917 2971 +6541 2 2 12 9 499 2358 3396 +6542 2 2 12 9 390 3374 2362 +6543 2 2 12 9 1149 2696 3148 +6544 2 2 12 9 1633 3145 2889 +6545 2 2 12 9 401 3646 2312 +6546 2 2 12 9 1442 2812 3435 +6547 2 2 12 9 1106 3382 2407 +6548 2 2 12 9 378 2940 2779 +6549 2 2 12 9 1066 2525 3089 +6550 2 2 12 9 1067 3090 2526 +6551 2 2 12 9 1485 3295 3379 +6552 2 2 12 9 637 3353 2393 +6553 2 2 12 9 1212 2610 3338 +6554 2 2 12 9 1213 3339 2611 +6555 2 2 12 9 508 2349 3479 +6556 2 2 12 9 1193 2528 3126 +6557 2 2 12 9 1461 3237 3504 +6558 2 2 12 9 1226 3383 2501 +6559 2 2 12 9 909 3647 2634 +6560 2 2 12 9 1240 3612 3423 +6561 2 2 12 9 1391 3622 2275 +6562 2 2 12 9 1392 2276 3623 +6563 2 2 12 9 1354 2353 3355 +6564 2 2 12 9 1144 2971 2984 +6565 2 2 12 9 1303 3297 2881 +6566 2 2 12 9 669 3434 2328 +6567 2 2 12 9 428 3449 2725 +6568 2 2 12 9 509 3286 2428 +6569 2 2 12 9 595 3560 2264 +6570 2 2 12 9 37 2355 3357 +6571 2 2 12 9 184 3358 2356 +6572 2 2 12 9 1129 2265 3584 +6573 2 2 12 9 887 3345 2806 +6574 2 2 12 9 1236 2535 3512 +6575 2 2 12 9 1102 2998 3635 +6576 2 2 12 9 386 3594 2785 +6577 2 2 12 9 551 3446 2373 +6578 2 2 12 9 552 2374 3447 +6579 2 2 12 9 619 2895 3570 +6580 2 2 12 9 1450 3452 3267 +6581 2 2 12 9 1038 3120 3424 +6582 2 2 12 9 587 2502 3233 +6583 2 2 12 9 588 3234 2503 +6584 2 2 12 9 1463 3469 3313 +6585 2 2 12 9 1488 3211 3453 +6586 2 2 12 9 1194 2971 2917 +6587 2 2 12 9 1151 2485 3333 +6588 2 2 12 9 879 3321 2490 +6589 2 2 12 9 422 2406 3634 +6590 2 2 12 9 1110 3585 2613 +6591 2 2 12 9 560 2287 3648 +6592 2 2 12 9 1389 2295 3580 +6593 2 2 12 9 941 3247 3396 +6594 2 2 12 9 1093 3634 2406 +6595 2 2 12 9 1522 2593 3157 +6596 2 2 12 9 1689 2396 3482 +6597 2 2 12 9 584 3224 2622 +6598 2 2 12 9 604 2914 3000 +6599 2 2 12 9 1058 2461 3296 +6600 2 2 12 9 1163 3000 2796 +6601 2 2 12 9 1202 2344 3626 +6602 2 2 12 9 442 3544 2280 +6603 2 2 12 9 1281 3156 3337 +6604 2 2 12 9 1754 3430 2556 +6605 2 2 12 9 1143 2339 3539 +6606 2 2 12 9 1153 2878 3452 +6607 2 2 12 9 571 2598 3181 +6608 2 2 12 9 676 2415 3424 +6609 2 2 12 9 678 2878 3643 +6610 2 2 12 9 1397 3581 3079 +6611 2 2 12 9 1190 2312 3646 +6612 2 2 12 9 418 2594 3278 +6613 2 2 12 9 571 3181 2741 +6614 2 2 12 9 1532 3450 2414 +6615 2 2 12 9 1563 3482 2396 +6616 2 2 12 9 968 3595 2861 +6617 2 2 12 9 1304 3047 3102 +6618 2 2 12 9 955 3435 2812 +6619 2 2 12 9 873 3429 2445 +6620 2 2 12 9 1178 2933 3208 +6621 2 2 12 9 933 2463 3347 +6622 2 2 12 9 759 3313 3469 +6623 2 2 12 9 1142 3262 2673 +6624 2 2 12 9 413 3349 3175 +6625 2 2 12 9 1232 3504 3237 +6626 2 2 12 9 1163 2796 3012 +6627 2 2 12 9 1257 2867 3411 +6628 2 2 12 9 1592 3404 3406 +6629 2 2 12 9 1690 3106 2700 +6630 2 2 12 9 1453 2804 3605 +6631 2 2 12 9 677 2899 3315 +6632 2 2 12 9 2022 2413 3456 +6633 2 2 12 9 1163 3141 2946 +6634 2 2 12 9 1169 3401 2935 +6635 2 2 12 9 936 2478 3419 +6636 2 2 12 9 1184 2873 3001 +6637 2 2 12 9 271 3148 2696 +6638 2 2 12 9 586 2971 3012 +6639 2 2 12 9 1015 2832 3567 +6640 2 2 12 9 1016 3568 2834 +6641 2 2 12 9 1638 2806 3345 +6642 2 2 12 9 678 3267 3452 +6643 2 2 12 9 1289 2966 3195 +6644 2 2 12 9 1387 3139 3620 +6645 2 2 12 9 1388 3621 3140 +6646 2 2 12 9 677 3079 3581 +6647 2 2 12 9 1155 2590 3251 +6648 2 2 12 9 1227 3199 3627 +6649 2 2 12 9 1143 2453 3614 +6650 2 2 12 9 1189 3058 2833 +6651 2 2 12 9 1227 2647 3199 +6652 2 2 12 9 585 2765 3052 +6653 2 2 12 9 1243 2675 3097 +6654 2 2 12 9 1135 3569 2911 +6655 2 2 12 9 1405 3643 2878 +6656 2 2 12 9 1000 3225 2993 +6657 2 2 12 9 1104 2728 3240 +6658 2 2 12 9 1105 3241 2729 +6659 2 2 12 9 1060 2514 3390 +6660 2 2 12 9 419 2648 3165 +6661 2 2 12 9 1104 3240 2515 +6662 2 2 12 9 1105 2516 3241 +6663 2 2 12 9 1107 3410 2803 +6664 2 2 12 9 1194 3012 2971 +6665 2 2 12 9 633 3022 3511 +6666 2 2 12 9 1296 3606 2391 +6667 2 2 12 9 1297 2392 3607 +6668 2 2 12 9 1069 2622 3224 +6669 2 2 12 9 1292 3615 3605 +6670 2 2 12 9 410 2682 3282 +6671 2 2 12 9 1125 2464 3541 +6672 2 2 12 9 1126 3542 2465 +6673 2 2 12 9 1060 3417 2514 +6674 2 2 12 9 405 3102 3047 +6675 2 2 12 9 1163 2946 3183 +6676 2 2 12 9 1582 3567 2447 +6677 2 2 12 9 1583 2448 3568 +6678 2 2 12 9 968 2507 3517 +6679 2 2 12 9 1673 3410 3160 +6680 2 2 12 9 1761 3338 2862 +6681 2 2 12 9 1762 2864 3339 +6682 2 2 12 9 1192 2741 3181 +6683 2 2 12 9 559 3257 2990 +6684 2 2 12 9 497 3426 2649 +6685 2 2 12 9 1177 3514 2481 +6686 2 2 12 9 498 2650 3545 +6687 2 2 12 9 1145 3616 2489 +6688 2 2 12 9 535 3209 2814 +6689 2 2 12 9 1141 3406 3404 +6690 2 2 12 9 362 3199 2647 +6691 2 2 12 9 1477 3399 3479 +6692 2 2 12 9 400 3136 3323 +6693 2 2 12 9 1136 2789 3049 +6694 2 2 12 9 214 2956 3104 +6695 2 2 12 9 1929 3011 3290 +6696 2 2 12 9 1200 3169 3287 +6697 2 2 12 9 1201 3288 3170 +6698 2 2 12 9 411 2752 3578 +6699 2 2 12 9 1334 3323 3136 +6700 2 2 12 9 1330 3456 2413 +6701 2 2 12 9 1248 2728 3317 +6702 2 2 12 9 1249 3318 2729 +6703 2 2 12 9 1578 3162 3190 +6704 2 2 12 9 596 2673 3262 +6705 2 2 12 9 1386 3245 3392 +6706 2 2 12 9 1292 3315 2899 +6707 2 2 12 9 379 2438 3582 +6708 2 2 12 9 410 3096 2969 +6709 2 2 12 9 1386 2437 3569 +6710 2 2 12 9 1523 3627 3199 +6711 2 2 12 9 1196 3104 2956 +6712 2 2 12 9 1136 2969 3096 +6713 2 2 12 9 501 3593 2553 +6714 2 2 12 9 403 3541 2464 +6715 2 2 12 9 404 2465 3542 +6716 2 2 12 9 1245 3183 2946 +6717 2 2 12 9 413 2571 3349 +6718 2 2 12 9 1169 2725 3449 +6719 2 2 12 9 1376 3359 3293 +6720 2 2 12 9 1377 3294 3360 +6721 2 2 12 9 1042 2889 3145 +6722 2 2 12 9 1458 3451 3387 +6723 2 2 12 9 1041 3158 2831 +6724 2 2 12 9 508 3479 3399 +6725 2 2 12 9 561 3344 2583 +6726 2 2 12 9 1536 3487 3583 +6727 2 2 12 9 412 3580 2567 +6728 2 2 12 9 1151 3415 2680 +6729 2 2 12 9 1677 3496 2620 +6730 2 2 12 9 373 2690 3462 +6731 2 2 12 9 374 3463 2691 +6732 2 2 12 9 532 3295 3095 +6733 2 2 12 9 395 3290 3011 +6734 2 2 12 9 1075 3434 2531 +6735 2 2 12 9 1277 3222 3187 +6736 2 2 12 9 1457 3448 2753 +6737 2 2 12 9 643 2620 3496 +6738 2 2 12 9 1118 3379 3103 +6739 2 2 12 9 1376 3214 3359 +6740 2 2 12 9 1377 3360 3215 +6741 2 2 12 9 1357 3033 3571 +6742 2 2 12 9 1358 3572 3034 +6743 2 2 12 9 361 2946 3141 +6744 2 2 12 9 1270 3398 3247 +6745 2 2 12 9 1153 3452 3092 +6746 2 2 12 9 338 3392 3245 +6747 2 2 12 9 360 2769 3538 +6748 2 2 12 9 629 3387 3451 +6749 2 2 12 9 661 3340 2756 +6750 2 2 12 9 1047 3571 3033 +6751 2 2 12 9 1048 3034 3572 +6752 2 2 12 9 1240 3520 2896 +6753 2 2 12 9 209 3546 2498 +6754 2 2 12 9 693 3583 3487 +6755 2 2 12 9 1197 3293 3359 +6756 2 2 12 9 1198 3360 3294 +6757 2 2 12 9 1195 2814 3209 +6758 2 2 12 9 1525 3543 3529 +6759 2 2 12 9 1383 2553 3593 +6760 2 2 12 9 682 3552 3166 +6761 2 2 12 9 976 2680 3415 +6762 2 2 12 9 1080 3190 3162 +6763 2 2 12 9 1370 3498 2546 +6764 2 2 12 9 968 2468 3595 +6765 2 2 12 9 1470 2564 3438 +6766 2 2 12 9 1149 2756 3340 +6767 2 2 12 9 1035 2852 3311 +6768 2 2 12 9 1036 3312 2853 +6769 2 2 12 9 1226 3208 2933 +6770 2 2 12 9 1708 3490 2858 +6771 2 2 12 9 1709 2859 3491 +6772 2 2 12 9 699 2896 3520 +6773 2 2 12 9 551 2591 3618 +6774 2 2 12 9 552 3619 2592 +6775 2 2 12 9 604 3000 3183 +6776 2 2 12 9 1219 3529 3543 +6777 2 2 12 9 1475 3438 2564 +6778 2 2 12 9 1223 3462 2690 +6779 2 2 12 9 1224 2691 3463 +6780 2 2 12 9 548 2613 3585 +6781 2 2 12 9 1193 3123 3337 +6782 2 2 12 9 467 2561 3614 +6783 2 2 12 9 1148 3195 2966 +6784 2 2 12 9 1523 3199 3361 +6785 2 2 12 9 1315 3095 3295 +6786 2 2 12 9 1163 3183 3000 +6787 2 2 12 9 1274 3135 3439 +6788 2 2 12 9 355 3359 3214 +6789 2 2 12 9 356 3215 3360 +6790 2 2 12 9 1312 3367 3204 +6791 2 2 12 9 1205 3187 3222 +6792 2 2 12 9 1127 3471 2645 +6793 2 2 12 9 1400 3166 3552 +6794 2 2 12 9 216 3465 2847 +6795 2 2 12 9 884 3641 2499 +6796 2 2 12 9 1426 3247 3398 +6797 2 2 12 9 907 2753 3448 +6798 2 2 12 9 1597 3260 2948 +6799 2 2 12 9 1173 2993 3225 +6800 2 2 12 9 1093 2788 3634 +6801 2 2 12 9 910 2714 3579 +6802 2 2 12 9 802 2948 3260 +6803 2 2 12 9 245 3637 2651 +6804 2 2 12 9 331 2652 3638 +6805 2 2 12 9 1145 3461 2690 +6806 2 2 12 9 1099 3308 2944 +6807 2 2 12 9 932 2594 3612 +6808 2 2 12 9 890 2702 3556 +6809 2 2 12 9 891 3557 2703 +6810 2 2 12 9 1474 3417 3022 +6811 2 2 12 9 1116 3468 2659 +6812 2 2 12 9 916 3502 2872 +6813 2 2 12 9 420 2862 3338 +6814 2 2 12 9 421 3339 2864 +6815 2 2 12 9 1472 3369 3483 +6816 2 2 12 9 1473 3484 3370 +6817 2 2 12 9 762 3204 3367 +6818 2 2 12 9 1182 2990 3257 +6819 2 2 12 9 1215 2919 3372 +6820 2 2 12 9 1386 3569 3245 +6821 2 2 12 9 496 2727 3450 +6822 2 2 12 9 1406 3186 3570 +6823 2 2 12 9 1546 3024 3296 +6824 2 2 12 9 678 3452 2878 +6825 2 2 12 9 1613 3440 3505 +6826 2 2 12 9 410 3282 3096 +6827 2 2 12 9 425 2747 3516 +6828 2 2 12 9 1179 3483 3369 +6829 2 2 12 9 1180 3370 3484 +6830 2 2 12 9 1644 2785 3437 +6831 2 2 12 9 1207 3323 3285 +6832 2 2 12 9 1224 3555 2691 +6833 2 2 12 9 667 3366 3555 +6834 2 2 12 9 1247 2847 3465 +6835 2 2 12 9 670 2935 3401 +6836 2 2 12 9 1839 2872 3502 +6837 2 2 12 9 620 3372 2919 +6838 2 2 12 9 1233 3221 3617 +6839 2 2 12 9 1238 3579 2714 +6840 2 2 12 9 545 2790 3635 +6841 2 2 12 9 687 3287 3169 +6842 2 2 12 9 688 3170 3288 +6843 2 2 12 9 1138 3159 3267 +6844 2 2 12 9 1060 3022 3417 +6845 2 2 12 9 1450 3267 3159 +6846 2 2 12 9 1233 3617 3313 +6847 2 2 12 9 1266 3335 3327 +6848 2 2 12 9 1267 3328 3336 +6849 2 2 12 9 1019 3394 3054 +6850 2 2 12 9 366 2955 3457 +6851 2 2 12 9 1135 3245 3569 +6852 2 2 12 9 1039 3346 3056 +6853 2 2 12 9 1170 3505 3440 +6854 2 2 12 9 614 2743 3518 +6855 2 2 12 9 615 3519 2744 +6856 2 2 12 9 1058 3296 3024 +6857 2 2 12 9 1192 3096 3282 +6858 2 2 12 9 614 3518 3116 +6859 2 2 12 9 615 3117 3519 +6860 2 2 12 9 348 2977 3531 +6861 2 2 12 9 1571 3322 3563 +6862 2 2 12 9 1421 3591 3422 +6863 2 2 12 9 1334 3285 3323 +6864 2 2 12 9 429 3605 2804 +6865 2 2 12 9 1790 3281 3217 +6866 2 2 12 9 1129 2785 3594 +6867 2 2 12 9 1153 3592 2878 +6868 2 2 12 9 781 3337 3123 +6869 2 2 12 9 1324 3327 3335 +6870 2 2 12 9 1325 3336 3328 +6871 2 2 12 9 578 3317 3087 +6872 2 2 12 9 579 3088 3318 +6873 2 2 12 9 1411 3236 3530 +6874 2 2 12 9 1192 3631 2741 +6875 2 2 12 9 1390 3530 3236 +6876 2 2 12 9 585 3628 2765 +6877 2 2 12 9 1871 3577 3086 +6878 2 2 12 9 362 3361 3199 +6879 2 2 12 9 1087 3570 2895 +6880 2 2 12 9 437 3422 3591 +6881 2 2 12 9 1166 3613 2824 +6882 2 2 12 9 1107 3160 3410 +6883 2 2 12 9 1719 3424 3120 +6884 2 2 12 9 1324 3335 3233 +6885 2 2 12 9 1325 3234 3336 +6886 2 2 12 9 1450 3092 3452 +6887 2 2 12 9 485 3416 3485 +6888 2 2 12 9 462 3217 3281 +6889 2 2 12 9 1259 3457 2955 +6890 2 2 12 9 1264 3439 3135 +6891 2 2 12 9 2047 3541 3212 +6892 2 2 12 9 2048 3213 3542 +6893 2 2 12 9 865 3250 3380 +6894 2 2 12 9 587 3233 3335 +6895 2 2 12 9 588 3336 3234 +6896 2 2 12 9 1591 3380 3250 +6897 2 2 12 9 348 3531 2910 +6898 2 2 12 9 581 3644 2816 +6899 2 2 12 9 582 2817 3645 +6900 2 2 12 9 1181 3086 3577 +6901 2 2 12 9 403 3212 3541 +6902 2 2 12 9 404 3542 3213 +6903 2 2 12 9 1159 3534 2981 +6904 2 2 12 9 1160 2982 3535 +6905 2 2 12 9 621 3285 3513 +6906 2 2 12 9 1426 3396 3247 +6907 2 2 12 9 1464 3564 3101 +6908 2 2 12 9 1409 3485 3416 +6909 2 2 12 9 1570 3635 2998 +6910 2 2 12 9 1413 3101 3564 +6911 2 2 12 9 1434 3179 3594 +6912 2 2 12 9 1169 3449 3401 +6913 2 2 12 9 943 3377 3493 +6914 2 2 12 9 944 3494 3378 +6915 2 2 12 9 1334 3513 3285 +6916 2 2 12 9 1667 3493 3377 +6917 2 2 12 9 1668 3378 3494 +6918 2 2 12 9 1229 3620 3139 +6919 2 2 12 9 1230 3140 3621 +6920 2 2 12 9 1577 3401 3449 +6921 2 2 12 9 1129 3594 3179 +6922 2 2 12 9 561 3617 3221 +6923 2 2 12 9 1191 3563 3322 +6924 2 2 12 9 1463 3313 3617 +6925 2 2 12 9 1340 3547 3552 +6926 2 2 12 9 1186 3216 3629 +6927 2 2 12 9 1240 3423 3520 +6928 2 2 12 9 1479 3520 3423 +6929 2 2 12 9 1313 3508 3561 +6930 2 2 12 9 1314 3562 3509 +6931 2 2 12 9 243 3602 3610 +6932 2 2 12 9 333 3611 3603 +6933 2 2 12 9 1400 3552 3547 +6934 2 2 12 9 1334 3581 3513 +6935 2 2 12 9 1443 3561 3508 +6936 2 2 12 9 1444 3509 3562 +6937 2 2 12 9 1397 3513 3581 +6938 2 2 12 9 1435 3610 3602 +6939 2 2 12 9 1436 3603 3611 +6940 2 2 13 11 6754 3899 4643 +6941 2 2 13 11 6325 3789 4827 +6942 2 2 13 11 6326 4828 3790 +6943 2 2 13 11 4769 3899 6754 +6944 2 2 13 11 4741 6325 4827 +6945 2 2 13 11 4742 4828 6326 +6946 2 2 13 11 4469 4994 5539 +6947 2 2 13 11 6465 4881 4039 +6948 2 2 13 11 5539 4994 3847 +6949 2 2 13 11 6217 4855 5027 +6950 2 2 13 11 6218 5028 4856 +6951 2 2 13 11 5066 5829 3774 +6952 2 2 13 11 6107 4090 4935 +6953 2 2 13 11 4698 4881 6465 +6954 2 2 13 11 6025 5002 3650 +6955 2 2 13 11 4782 5101 6705 +6956 2 2 13 11 3999 4855 6217 +6957 2 2 13 11 4000 6218 4856 +6958 2 2 13 11 5089 3840 5587 +6959 2 2 13 11 4594 6501 5305 +6960 2 2 13 11 4543 5002 6025 +6961 2 2 13 11 5829 4873 3774 +6962 2 2 13 11 6693 4148 4831 +6963 2 2 13 11 6209 4103 4940 +6964 2 2 13 11 4634 6107 4935 +6965 2 2 13 11 4128 4771 6903 +6966 2 2 13 11 4129 6904 4772 +6967 2 2 13 11 4808 6693 4831 +6968 2 2 13 11 6947 4762 3701 +6969 2 2 13 11 5465 4068 6859 +6970 2 2 13 11 6903 4771 4868 +6971 2 2 13 11 6904 4869 4772 +6972 2 2 13 11 4657 6209 4940 +6973 2 2 13 11 6802 4888 4687 +6974 2 2 13 11 4846 6947 3701 +6975 2 2 13 11 4501 5089 5587 +6976 2 2 13 11 4790 4852 6823 +6977 2 2 13 11 3922 6802 4687 +6978 2 2 13 11 4622 4878 6342 +6979 2 2 13 11 5715 5071 4131 +6980 2 2 13 11 5101 3909 6705 +6981 2 2 13 11 6510 5331 3754 +6982 2 2 13 11 6485 4632 5117 +6983 2 2 13 11 4544 6032 4923 +6984 2 2 13 11 6001 4111 4423 +6985 2 2 13 11 6032 3669 4923 +6986 2 2 13 11 5267 3994 5848 +6987 2 2 13 11 6241 4995 3739 +6988 2 2 13 11 6342 4878 3923 +6989 2 2 13 11 6155 4943 4158 +6990 2 2 13 11 4111 5268 4423 +6991 2 2 13 11 5953 4033 4868 +6992 2 2 13 11 5954 4869 4034 +6993 2 2 13 11 4575 5071 5715 +6994 2 2 13 11 6823 4852 4009 +6995 2 2 13 11 6501 3938 5305 +6996 2 2 13 11 4530 5201 6238 +6997 2 2 13 11 3921 4632 6485 +6998 2 2 13 11 5848 3994 4945 +6999 2 2 13 11 5165 6180 4243 +7000 2 2 13 11 6691 4019 4470 +7001 2 2 13 11 315 6049 5157 +7002 2 2 13 11 261 5158 6050 +7003 2 2 13 11 6468 3765 5203 +7004 2 2 13 11 6469 5204 3766 +7005 2 2 13 11 4070 5509 4441 +7006 2 2 13 11 4071 4442 5510 +7007 2 2 13 11 5084 5261 6311 +7008 2 2 13 11 4340 6037 5313 +7009 2 2 13 11 4341 5316 6038 +7010 2 2 13 11 3985 4928 4512 +7011 2 2 13 11 3656 4757 5637 +7012 2 2 13 11 6422 4895 3924 +7013 2 2 13 11 6423 3925 4896 +7014 2 2 13 11 3950 4659 4873 +7015 2 2 13 11 3761 4930 4531 +7016 2 2 13 11 3963 5312 4520 +7017 2 2 13 11 4737 4899 6322 +7018 2 2 13 11 5086 4033 5953 +7019 2 2 13 11 5087 5954 4034 +7020 2 2 13 11 6648 5815 4389 +7021 2 2 13 11 6649 4390 5816 +7022 2 2 13 11 3950 4656 5617 +7023 2 2 13 11 4098 5279 5591 +7024 2 2 13 11 4097 4920 5590 +7025 2 2 13 11 4098 5591 4921 +7026 2 2 13 11 4222 5067 5335 +7027 2 2 13 11 4097 5590 5304 +7028 2 2 13 11 3985 4512 4954 +7029 2 2 13 11 3967 5176 4976 +7030 2 2 13 11 4647 4895 6422 +7031 2 2 13 11 4648 6423 4896 +7032 2 2 13 11 3915 4582 5743 +7033 2 2 13 11 3756 6419 4509 +7034 2 2 13 11 4424 4678 6276 +7035 2 2 13 11 289 4712 290 +7036 2 2 13 11 4086 4443 5454 +7037 2 2 13 11 5769 6275 3972 +7038 2 2 13 11 4716 4995 6241 +7039 2 2 13 11 291 4793 292 +7040 2 2 13 11 4164 4968 5034 +7041 2 2 13 11 3781 4881 4698 +7042 2 2 13 11 275 4721 276 +7043 2 2 13 11 4130 6744 4562 +7044 2 2 13 11 4612 4943 6155 +7045 2 2 13 11 4070 4441 6303 +7046 2 2 13 11 3950 5617 4659 +7047 2 2 13 11 4071 6304 4442 +7048 2 2 13 11 6275 4836 3972 +7049 2 2 13 11 6859 4068 4540 +7050 2 2 13 11 4601 6180 5165 +7051 2 2 13 11 277 4797 278 +7052 2 2 13 11 4345 5248 5249 +7053 2 2 13 11 3984 4571 4894 +7054 2 2 13 11 4035 4858 4596 +7055 2 2 13 11 3785 5041 4925 +7056 2 2 13 11 4413 5280 6033 +7057 2 2 13 11 3742 5004 4496 +7058 2 2 13 11 3734 4594 5305 +7059 2 2 13 11 3975 4764 4635 +7060 2 2 13 11 4027 6536 4519 +7061 2 2 13 11 3998 4551 5107 +7062 2 2 13 11 110 4993 6581 +7063 2 2 13 11 4937 5571 5961 +7064 2 2 13 11 4689 5331 6510 +7065 2 2 13 11 4152 4890 4662 +7066 2 2 13 11 4068 5269 4540 +7067 2 2 13 11 4004 4571 6293 +7068 2 2 13 11 4100 4463 6797 +7069 2 2 13 11 4470 4019 5379 +7070 2 2 13 11 4019 4737 6322 +7071 2 2 13 11 4014 4994 5795 +7072 2 2 13 11 3902 4663 5102 +7073 2 2 13 11 3903 5103 4664 +7074 2 2 13 11 3984 5765 4571 +7075 2 2 13 11 3712 4540 5269 +7076 2 2 13 11 3882 4581 6736 +7077 2 2 13 11 3999 5160 4475 +7078 2 2 13 11 4000 4476 5161 +7079 2 2 13 11 3934 4731 4703 +7080 2 2 13 11 3935 4704 4732 +7081 2 2 13 11 4483 5917 5728 +7082 2 2 13 11 3762 4855 4618 +7083 2 2 13 11 3763 4619 4856 +7084 2 2 13 11 4977 5593 6130 +7085 2 2 13 11 3853 4681 5303 +7086 2 2 13 11 318 4627 319 +7087 2 2 13 11 257 4628 258 +7088 2 2 13 11 4163 6139 4591 +7089 2 2 13 11 4111 5025 4774 +7090 2 2 13 11 4270 4590 6146 +7091 2 2 13 11 3995 4634 5301 +7092 2 2 13 11 3939 5307 4620 +7093 2 2 13 11 3917 4596 6702 +7094 2 2 13 11 3878 5495 4485 +7095 2 2 13 11 3803 4780 5655 +7096 2 2 13 11 3851 5115 4496 +7097 2 2 13 11 3926 5228 6126 +7098 2 2 13 11 3916 4882 4661 +7099 2 2 13 11 4086 5618 4443 +7100 2 2 13 11 3661 5477 4584 +7101 2 2 13 11 5074 6545 5843 +7102 2 2 13 11 4596 4858 6702 +7103 2 2 13 11 4280 4965 6074 +7104 2 2 13 11 4281 6075 4966 +7105 2 2 13 11 5201 3910 6238 +7106 2 2 13 11 3868 5513 4883 +7107 2 2 13 11 4092 4682 4891 +7108 2 2 13 11 4201 4801 4803 +7109 2 2 13 11 3998 5749 4551 +7110 2 2 13 11 113 114 4616 +7111 2 2 13 11 4259 5402 4941 +7112 2 2 13 11 4629 6468 5203 +7113 2 2 13 11 4630 5204 6469 +7114 2 2 13 11 4175 4595 5303 +7115 2 2 13 11 4044 5006 5205 +7116 2 2 13 11 4045 5206 5007 +7117 2 2 13 11 4773 6806 5397 +7118 2 2 13 11 3948 4746 4877 +7119 2 2 13 11 4515 6581 4993 +7120 2 2 13 11 5257 6534 5832 +7121 2 2 13 11 5258 5833 6535 +7122 2 2 13 11 4374 5257 5832 +7123 2 2 13 11 4375 5833 5258 +7124 2 2 13 11 5929 4472 3862 +7125 2 2 13 11 3875 5062 4457 +7126 2 2 13 11 4065 5092 5433 +7127 2 2 13 11 4094 4490 5571 +7128 2 2 13 11 4183 5237 5181 +7129 2 2 13 11 4244 5281 4640 +7130 2 2 13 11 3851 4496 5309 +7131 2 2 13 11 4958 6837 6185 +7132 2 2 13 11 3777 5034 4968 +7133 2 2 13 11 4130 4870 6744 +7134 2 2 13 11 4151 5261 5084 +7135 2 2 13 11 3822 5249 5248 +7136 2 2 13 11 3986 5060 4549 +7137 2 2 13 11 4004 6293 4617 +7138 2 2 13 11 4028 5049 4479 +7139 2 2 13 11 3926 6610 5228 +7140 2 2 13 11 3651 4576 5899 +7141 2 2 13 11 3815 4550 5147 +7142 2 2 13 11 292 4793 6245 +7143 2 2 13 11 4083 4865 5064 +7144 2 2 13 11 3976 5020 5580 +7145 2 2 13 11 3977 5581 5021 +7146 2 2 13 11 3848 4498 5519 +7147 2 2 13 11 3803 5655 6002 +7148 2 2 13 11 4280 6156 4965 +7149 2 2 13 11 4281 4966 6157 +7150 2 2 13 11 3823 5107 4551 +7151 2 2 13 11 278 4797 6269 +7152 2 2 13 11 3789 4813 4827 +7153 2 2 13 11 3790 4828 4814 +7154 2 2 13 11 5010 5719 6386 +7155 2 2 13 11 4410 5517 6123 +7156 2 2 13 11 5720 5011 6387 +7157 2 2 13 11 4130 4562 6189 +7158 2 2 13 11 3860 5071 5751 +7159 2 2 13 11 4813 5712 6914 +7160 2 2 13 11 4814 6915 5713 +7161 2 2 13 11 4191 5642 5289 +7162 2 2 13 11 3941 5366 4974 +7163 2 2 13 11 3942 4975 5367 +7164 2 2 13 11 4014 5795 4992 +7165 2 2 13 11 3849 4464 5599 +7166 2 2 13 11 4701 6887 5702 +7167 2 2 13 11 3674 4636 5895 +7168 2 2 13 11 3811 4941 5402 +7169 2 2 13 11 117 5926 4541 +7170 2 2 13 11 4140 6817 4746 +7171 2 2 13 11 4099 6880 4486 +7172 2 2 13 11 3676 5050 5172 +7173 2 2 13 11 3906 5381 4803 +7174 2 2 13 11 4163 4525 5774 +7175 2 2 13 11 3733 4745 4774 +7176 2 2 13 11 3710 6509 5164 +7177 2 2 13 11 4677 6758 5128 +7178 2 2 13 11 4044 5205 4860 +7179 2 2 13 11 4045 4861 5206 +7180 2 2 13 11 3767 4557 6607 +7181 2 2 13 11 3916 4550 4882 +7182 2 2 13 11 3848 6276 4678 +7183 2 2 13 11 4719 5889 5666 +7184 2 2 13 11 3869 4514 5134 +7185 2 2 13 11 6758 3755 5128 +7186 2 2 13 11 3874 4538 4969 +7187 2 2 13 11 3876 4970 4539 +7188 2 2 13 11 6890 4706 6302 +7189 2 2 13 11 3665 4958 6185 +7190 2 2 13 11 6265 4159 4955 +7191 2 2 13 11 4472 5775 3862 +7192 2 2 13 11 4032 5447 4929 +7193 2 2 13 11 3753 5593 4977 +7194 2 2 13 11 6837 4514 6185 +7195 2 2 13 11 4151 4587 5427 +7196 2 2 13 11 3733 4800 4839 +7197 2 2 13 11 4105 6624 4641 +7198 2 2 13 11 3708 4513 5399 +7199 2 2 13 11 4102 4591 5516 +7200 2 2 13 11 4727 6385 5232 +7201 2 2 13 11 4175 5303 4681 +7202 2 2 13 11 4060 4526 5245 +7203 2 2 13 11 4169 5514 4602 +7204 2 2 13 11 4005 4904 4691 +7205 2 2 13 11 4170 4603 5515 +7206 2 2 13 11 4031 4839 4800 +7207 2 2 13 11 4525 4641 6624 +7208 2 2 13 11 4691 4904 6883 +7209 2 2 13 11 3915 5743 4697 +7210 2 2 13 11 3746 4510 6591 +7211 2 2 13 11 3747 6592 4511 +7212 2 2 13 11 4385 5532 5212 +7213 2 2 13 11 4386 5213 5533 +7214 2 2 13 11 3702 5660 4681 +7215 2 2 13 11 4006 4774 4745 +7216 2 2 13 11 3723 6175 5702 +7217 2 2 13 11 3849 6698 4464 +7218 2 2 13 11 5352 5815 6648 +7219 2 2 13 11 5353 6649 5816 +7220 2 2 13 11 3656 5637 5840 +7221 2 2 13 11 4708 5774 5656 +7222 2 2 13 11 3987 4621 5065 +7223 2 2 13 11 4480 5751 5071 +7224 2 2 13 11 4746 6817 4877 +7225 2 2 13 11 4206 4873 4659 +7226 2 2 13 11 4163 4708 6139 +7227 2 2 13 11 3694 4891 4682 +7228 2 2 13 11 156 5486 5441 +7229 2 2 13 11 65 5442 5487 +7230 2 2 13 11 3882 6736 4823 +7231 2 2 13 11 5278 4864 6513 +7232 2 2 13 11 4383 5433 5092 +7233 2 2 13 11 4005 4564 6378 +7234 2 2 13 11 6923 3873 5887 +7235 2 2 13 11 3991 6529 4653 +7236 2 2 13 11 4028 4479 5560 +7237 2 2 13 11 3979 5796 4669 +7238 2 2 13 11 6934 5149 3908 +7239 2 2 13 11 4515 6528 5604 +7240 2 2 13 11 3848 5351 4498 +7241 2 2 13 11 4094 5202 4490 +7242 2 2 13 11 4060 6266 4526 +7243 2 2 13 11 4002 5034 5985 +7244 2 2 13 11 3857 5939 4465 +7245 2 2 13 11 3858 4466 5940 +7246 2 2 13 11 3945 4568 6013 +7247 2 2 13 11 4340 5313 6288 +7248 2 2 13 11 4341 6289 5316 +7249 2 2 13 11 4176 4925 5041 +7250 2 2 13 11 4054 4509 4996 +7251 2 2 13 11 4224 4563 6032 +7252 2 2 13 11 4050 4827 4813 +7253 2 2 13 11 4051 4814 4828 +7254 2 2 13 11 4091 5391 4999 +7255 2 2 13 11 3737 4771 5612 +7256 2 2 13 11 3738 5613 4772 +7257 2 2 13 11 4201 4803 5381 +7258 2 2 13 11 3988 6441 4613 +7259 2 2 13 11 3991 4636 6529 +7260 2 2 13 11 3901 4762 5902 +7261 2 2 13 11 3708 5504 4513 +7262 2 2 13 11 3874 5238 4538 +7263 2 2 13 11 3876 4539 5239 +7264 2 2 13 11 3749 4803 4801 +7265 2 2 13 11 3867 5728 5917 +7266 2 2 13 11 3757 4662 4890 +7267 2 2 13 11 3714 4592 5341 +7268 2 2 13 11 3715 5342 4593 +7269 2 2 13 11 3917 6233 4733 +7270 2 2 13 11 3851 5946 5115 +7271 2 2 13 11 4325 4883 5513 +7272 2 2 13 11 3955 5565 6000 +7273 2 2 13 11 4976 5176 6208 +7274 2 2 13 11 3719 5212 5532 +7275 2 2 13 11 3720 5533 5213 +7276 2 2 13 11 3857 4465 5566 +7277 2 2 13 11 3858 5567 4466 +7278 2 2 13 11 4012 5033 5002 +7279 2 2 13 11 4602 5514 6391 +7280 2 2 13 11 4603 6392 5515 +7281 2 2 13 11 3823 4551 5358 +7282 2 2 13 11 3983 4886 4677 +7283 2 2 13 11 4615 6265 4955 +7284 2 2 13 11 3668 4549 5060 +7285 2 2 13 11 3706 5057 4524 +7286 2 2 13 11 4032 5792 6330 +7287 2 2 13 11 4530 5985 5034 +7288 2 2 13 11 3673 5571 5560 +7289 2 2 13 11 3853 4470 5379 +7290 2 2 13 11 6341 5012 3744 +7291 2 2 13 11 6343 3745 5013 +7292 2 2 13 11 3668 6229 4495 +7293 2 2 13 11 4359 5340 5419 +7294 2 2 13 11 3688 5831 6366 +7295 2 2 13 11 3945 6778 4568 +7296 2 2 13 11 4033 5719 5010 +7297 2 2 13 11 4034 5011 5720 +7298 2 2 13 11 4236 4937 5961 +7299 2 2 13 11 4404 5843 6545 +7300 2 2 13 11 3768 5774 4525 +7301 2 2 13 11 4196 5838 5395 +7302 2 2 13 11 4314 4974 5366 +7303 2 2 13 11 4315 5367 4975 +7304 2 2 13 11 4311 5520 5671 +7305 2 2 13 11 4183 5181 4676 +7306 2 2 13 11 4413 6280 5280 +7307 2 2 13 11 3709 4529 5061 +7308 2 2 13 11 4168 4584 5477 +7309 2 2 13 11 4102 4760 5196 +7310 2 2 13 11 3943 5038 4561 +7311 2 2 13 11 4090 5362 4600 +7312 2 2 13 11 4864 4309 6513 +7313 2 2 13 11 4236 4995 4716 +7314 2 2 13 11 4075 4988 4718 +7315 2 2 13 11 4678 6158 5014 +7316 2 2 13 11 3930 4516 5150 +7317 2 2 13 11 4070 4884 4938 +7318 2 2 13 11 4071 4939 4885 +7319 2 2 13 11 3717 6201 4646 +7320 2 2 13 11 3746 4938 4884 +7321 2 2 13 11 4372 4733 6355 +7322 2 2 13 11 3747 4885 4939 +7323 2 2 13 11 3750 4964 4824 +7324 2 2 13 11 3739 4995 4886 +7325 2 2 13 11 3875 4457 5638 +7326 2 2 13 11 4003 4706 6890 +7327 2 2 13 11 6914 5712 3964 +7328 2 2 13 11 6915 3965 5713 +7329 2 2 13 11 4073 4824 4964 +7330 2 2 13 11 3975 4599 6120 +7331 2 2 13 11 6883 4904 3958 +7332 2 2 13 11 4623 5580 6631 +7333 2 2 13 11 4624 6632 5581 +7334 2 2 13 11 4307 5580 5020 +7335 2 2 13 11 4308 5021 5581 +7336 2 2 13 11 6778 5368 4568 +7337 2 2 13 11 4278 4631 6093 +7338 2 2 13 11 4244 5678 5281 +7339 2 2 13 11 4610 6408 5395 +7340 2 2 13 11 303 5378 6220 +7341 2 2 13 11 3884 5970 4547 +7342 2 2 13 11 3885 4548 5971 +7343 2 2 13 11 3788 5064 4865 +7344 2 2 13 11 3676 5172 4686 +7345 2 2 13 11 3815 6040 4550 +7346 2 2 13 11 4451 4733 6233 +7347 2 2 13 11 4032 6330 4944 +7348 2 2 13 11 114 5394 4616 +7349 2 2 13 11 3951 5037 5569 +7350 2 2 13 11 4027 4519 5066 +7351 2 2 13 11 3746 6030 4510 +7352 2 2 13 11 3747 4511 6031 +7353 2 2 13 11 4610 5337 6355 +7354 2 2 13 11 3698 5335 5067 +7355 2 2 13 11 6435 4815 4006 +7356 2 2 13 11 4149 5002 5033 +7357 2 2 13 11 3999 4475 5675 +7358 2 2 13 11 4000 5676 4476 +7359 2 2 13 11 3735 4931 6314 +7360 2 2 13 11 3917 6473 4596 +7361 2 2 13 11 5337 4372 6355 +7362 2 2 13 11 4771 6070 5612 +7363 2 2 13 11 4772 5613 6071 +7364 2 2 13 11 4214 5605 4534 +7365 2 2 13 11 4525 6681 4641 +7366 2 2 13 11 4410 6555 5517 +7367 2 2 13 11 4023 6043 5905 +7368 2 2 13 11 4438 5697 5317 +7369 2 2 13 11 4439 5318 5698 +7370 2 2 13 11 3669 4561 5936 +7371 2 2 13 11 4023 5905 4936 +7372 2 2 13 11 3993 5074 5843 +7373 2 2 13 11 5914 5293 3682 +7374 2 2 13 11 117 4541 5287 +7375 2 2 13 11 5916 3683 5294 +7376 2 2 13 11 5115 5946 6684 +7377 2 2 13 11 3897 4522 5072 +7378 2 2 13 11 3898 5073 4523 +7379 2 2 13 11 309 5231 5700 +7380 2 2 13 11 4149 4980 5345 +7381 2 2 13 11 3975 4635 5127 +7382 2 2 13 11 4151 6309 4587 +7383 2 2 13 11 3675 4713 5222 +7384 2 2 13 11 3959 4710 5383 +7385 2 2 13 11 4207 5224 5015 +7386 2 2 13 11 4208 5016 5226 +7387 2 2 13 11 4126 5080 5162 +7388 2 2 13 11 4311 4999 5391 +7389 2 2 13 11 3757 5311 5024 +7390 2 2 13 11 3904 5578 4711 +7391 2 2 13 11 3816 4623 6631 +7392 2 2 13 11 3817 6632 4624 +7393 2 2 13 11 4100 5451 4463 +7394 2 2 13 11 4252 4841 6279 +7395 2 2 13 11 4490 5560 5571 +7396 2 2 13 11 4313 6254 4638 +7397 2 2 13 11 4046 5096 6811 +7398 2 2 13 11 3672 6446 5392 +7399 2 2 13 11 3821 5419 5340 +7400 2 2 13 11 3744 5012 4577 +7401 2 2 13 11 3745 4578 5013 +7402 2 2 13 11 3735 6314 5820 +7403 2 2 13 11 4007 4557 5880 +7404 2 2 13 11 3786 5177 6290 +7405 2 2 13 11 3787 6291 5178 +7406 2 2 13 11 4163 6235 4525 +7407 2 2 13 11 4636 5233 5895 +7408 2 2 13 11 3853 5303 4470 +7409 2 2 13 11 4027 4840 6536 +7410 2 2 13 11 3755 4715 5128 +7411 2 2 13 11 4047 6812 5099 +7412 2 2 13 11 3664 5448 5297 +7413 2 2 13 11 4001 5014 6158 +7414 2 2 13 11 3934 4978 5615 +7415 2 2 13 11 3935 5616 4979 +7416 2 2 13 11 3930 5164 4516 +7417 2 2 13 11 6385 4319 5232 +7418 2 2 13 11 3989 4585 5494 +7419 2 2 13 11 4762 6947 5902 +7420 2 2 13 11 3927 4714 6932 +7421 2 2 13 11 4566 5293 5914 +7422 2 2 13 11 4567 5916 5294 +7423 2 2 13 11 3756 4509 5253 +7424 2 2 13 11 3987 5004 4621 +7425 2 2 13 11 4180 4708 5656 +7426 2 2 13 11 4089 5399 4513 +7427 2 2 13 11 4382 4688 5194 +7428 2 2 13 11 3992 5047 6870 +7429 2 2 13 11 4318 4632 6117 +7430 2 2 13 11 4590 5403 6146 +7431 2 2 13 11 4733 6516 6355 +7432 2 2 13 11 3868 4883 5606 +7433 2 2 13 11 4663 5012 6341 +7434 2 2 13 11 4664 6343 5013 +7435 2 2 13 11 3959 5383 6138 +7436 2 2 13 11 3944 6072 6727 +7437 2 2 13 11 3888 4986 5481 +7438 2 2 13 11 4435 6067 4848 +7439 2 2 13 11 3865 4574 5884 +7440 2 2 13 11 4537 5702 6175 +7441 2 2 13 11 5016 6397 6151 +7442 2 2 13 11 4379 4776 5887 +7443 2 2 13 11 4032 4944 5447 +7444 2 2 13 11 4516 5164 6509 +7445 2 2 13 11 4187 4590 5873 +7446 2 2 13 11 3998 4657 5749 +7447 2 2 13 11 4526 131 5596 +7448 2 2 13 11 6887 3723 5702 +7449 2 2 13 11 4005 6378 4654 +7450 2 2 13 11 3802 5498 4963 +7451 2 2 13 11 4084 5015 5224 +7452 2 2 13 11 4085 5226 5016 +7453 2 2 13 11 3736 5627 4655 +7454 2 2 13 11 4728 6870 5047 +7455 2 2 13 11 289 5362 4712 +7456 2 2 13 11 3671 5422 6190 +7457 2 2 13 11 3708 5399 5117 +7458 2 2 13 11 3891 5674 4671 +7459 2 2 13 11 4406 5439 5324 +7460 2 2 13 11 3960 4592 5035 +7461 2 2 13 11 3961 5036 4593 +7462 2 2 13 11 3848 4678 5014 +7463 2 2 13 11 5397 6806 4008 +7464 2 2 13 11 4125 4518 5310 +7465 2 2 13 11 4048 4741 4827 +7466 2 2 13 11 4049 4828 4742 +7467 2 2 13 11 3678 4924 5273 +7468 2 2 13 11 3760 4503 6432 +7469 2 2 13 11 273 6147 5156 +7470 2 2 13 11 4144 4532 5215 +7471 2 2 13 11 4145 5216 4533 +7472 2 2 13 11 4065 5433 4531 +7473 2 2 13 11 4110 4902 5096 +7474 2 2 13 11 3863 5682 5173 +7475 2 2 13 11 3864 5174 5683 +7476 2 2 13 11 107 108 4702 +7477 2 2 13 11 3775 4667 5132 +7478 2 2 13 11 3776 5133 4668 +7479 2 2 13 11 4053 4852 4790 +7480 2 2 13 11 3706 4524 5598 +7481 2 2 13 11 3878 4485 5763 +7482 2 2 13 11 3749 5501 4611 +7483 2 2 13 11 4224 5724 4563 +7484 2 2 13 11 4457 5297 5448 +7485 2 2 13 11 4052 5623 4500 +7486 2 2 13 11 3870 6093 4631 +7487 2 2 13 11 4212 5845 5661 +7488 2 2 13 11 4401 5569 5037 +7489 2 2 13 11 4127 4646 4915 +7490 2 2 13 11 3834 5324 5439 +7491 2 2 13 11 3984 6067 5765 +7492 2 2 13 11 4552 6168 5398 +7493 2 2 13 11 4611 5501 5681 +7494 2 2 13 11 4278 5523 4631 +7495 2 2 13 11 3976 4747 5020 +7496 2 2 13 11 3977 5021 4748 +7497 2 2 13 11 3988 6888 6441 +7498 2 2 13 11 83 5667 5094 +7499 2 2 13 11 3911 4805 5527 +7500 2 2 13 11 3912 5528 4806 +7501 2 2 13 11 3830 5317 5697 +7502 2 2 13 11 3831 5698 5318 +7503 2 2 13 11 4092 5358 4551 +7504 2 2 13 11 4024 4899 4737 +7505 2 2 13 11 4144 6766 4532 +7506 2 2 13 11 4145 4533 6767 +7507 2 2 13 11 4212 5661 5041 +7508 2 2 13 11 3860 5751 4940 +7509 2 2 13 11 4112 5099 4905 +7510 2 2 13 11 6408 4426 5395 +7511 2 2 13 11 4149 5345 5733 +7512 2 2 13 11 3869 5134 4558 +7513 2 2 13 11 4832 5149 6934 +7514 2 2 13 11 3744 4577 6062 +7515 2 2 13 11 3745 6064 4578 +7516 2 2 13 11 4515 5604 6581 +7517 2 2 13 11 4118 4616 5394 +7518 2 2 13 11 4041 4990 6459 +7519 2 2 13 11 4042 6460 4991 +7520 2 2 13 11 154 155 4695 +7521 2 2 13 11 66 67 4696 +7522 2 2 13 11 4998 5834 6247 +7523 2 2 13 11 4679 6575 5929 +7524 2 2 13 11 4081 5132 4527 +7525 2 2 13 11 5131 6435 4006 +7526 2 2 13 11 3784 4604 5875 +7527 2 2 13 11 4082 4528 5133 +7528 2 2 13 11 3767 6607 4852 +7529 2 2 13 11 3856 6640 5245 +7530 2 2 13 11 3670 5592 4761 +7531 2 2 13 11 3688 6366 5236 +7532 2 2 13 11 3944 6814 6072 +7533 2 2 13 11 4382 6395 4688 +7534 2 2 13 11 4826 6201 6228 +7535 2 2 13 11 3979 6765 5796 +7536 2 2 13 11 3975 6120 4764 +7537 2 2 13 11 4353 5615 4978 +7538 2 2 13 11 4354 4979 5616 +7539 2 2 13 11 302 5378 303 +7540 2 2 13 11 3756 4795 6419 +7541 2 2 13 11 3709 5892 4529 +7542 2 2 13 11 3852 5762 4935 +7543 2 2 13 11 4962 6310 5986 +7544 2 2 13 11 3668 5990 4549 +7545 2 2 13 11 4776 6923 5887 +7546 2 2 13 11 4488 5585 6386 +7547 2 2 13 11 4489 6387 5586 +7548 2 2 13 11 4147 5302 4626 +7549 2 2 13 11 4756 6811 5096 +7550 2 2 13 11 3995 5301 4947 +7551 2 2 13 11 3757 4890 5311 +7552 2 2 13 11 315 5157 316 +7553 2 2 13 11 260 5158 261 +7554 2 2 13 11 4065 4531 5991 +7555 2 2 13 11 3824 5785 6384 +7556 2 2 13 11 4175 4681 5660 +7557 2 2 13 11 3962 5108 4753 +7558 2 2 13 11 3907 4680 5575 +7559 2 2 13 11 4757 5099 6812 +7560 2 2 13 11 3666 5207 4572 +7561 2 2 13 11 4095 5431 5327 +7562 2 2 13 11 3667 4573 5208 +7563 2 2 13 11 4096 5328 5432 +7564 2 2 13 11 4099 4486 5508 +7565 2 2 13 11 3927 6932 4783 +7566 2 2 13 11 3880 4544 5494 +7567 2 2 13 11 4618 4855 6614 +7568 2 2 13 11 4619 6615 4856 +7569 2 2 13 11 4190 5666 5889 +7570 2 2 13 11 4568 5382 6013 +7571 2 2 13 11 4052 4500 5254 +7572 2 2 13 11 3799 5707 4622 +7573 2 2 13 11 3915 4697 4984 +7574 2 2 13 11 4521 5245 6640 +7575 2 2 13 11 3760 5065 4621 +7576 2 2 13 11 3750 4521 6443 +7577 2 2 13 11 4066 6583 4507 +7578 2 2 13 11 4067 4508 6584 +7579 2 2 13 11 4196 5125 5838 +7580 2 2 13 11 3698 4816 5335 +7581 2 2 13 11 3671 6843 5422 +7582 2 2 13 11 4069 4554 5385 +7583 2 2 13 11 3661 4584 6719 +7584 2 2 13 11 4246 5936 4561 +7585 2 2 13 11 3775 5132 5105 +7586 2 2 13 11 3776 5106 5133 +7587 2 2 13 11 3736 4655 4987 +7588 2 2 13 11 3734 5305 4900 +7589 2 2 13 11 3668 4495 5541 +7590 2 2 13 11 3841 4708 5546 +7591 2 2 13 11 4841 5026 6279 +7592 2 2 13 11 4208 6397 5016 +7593 2 2 13 11 4332 5481 4986 +7594 2 2 13 11 4629 5203 6634 +7595 2 2 13 11 4630 6635 5204 +7596 2 2 13 11 4941 5710 6270 +7597 2 2 13 11 3947 4862 5195 +7598 2 2 13 11 3964 5343 6914 +7599 2 2 13 11 3965 6915 5344 +7600 2 2 13 11 3948 4877 6659 +7601 2 2 13 11 4510 5173 5682 +7602 2 2 13 11 4511 5683 5174 +7603 2 2 13 11 3947 4651 5058 +7604 2 2 13 11 4132 5284 4957 +7605 2 2 13 11 5849 4041 6459 +7606 2 2 13 11 5850 6460 4042 +7607 2 2 13 11 4172 4711 5578 +7608 2 2 13 11 3897 5417 4522 +7609 2 2 13 11 3898 4523 5418 +7610 2 2 13 11 4312 4963 5498 +7611 2 2 13 11 4880 6629 6688 +7612 2 2 13 11 3746 4926 4874 +7613 2 2 13 11 3747 4875 4927 +7614 2 2 13 11 4112 4834 5775 +7615 2 2 13 11 4465 5157 6049 +7616 2 2 13 11 4466 6050 5158 +7617 2 2 13 11 3778 5614 4666 +7618 2 2 13 11 3928 6216 4613 +7619 2 2 13 11 4335 5117 5399 +7620 2 2 13 11 4213 5274 5064 +7621 2 2 13 11 4883 5957 5606 +7622 2 2 13 11 3674 6894 4636 +7623 2 2 13 11 4313 4638 6574 +7624 2 2 13 11 4311 4690 5520 +7625 2 2 13 11 3939 6112 5307 +7626 2 2 13 11 3963 4520 5732 +7627 2 2 13 11 6439 3757 5024 +7628 2 2 13 11 3675 4609 6471 +7629 2 2 13 11 3711 5938 5179 +7630 2 2 13 11 3649 4725 6633 +7631 2 2 13 11 4093 5181 5237 +7632 2 2 13 11 5185 6360 5924 +7633 2 2 13 11 4222 4604 5067 +7634 2 2 13 11 3984 4848 6067 +7635 2 2 13 11 3985 4880 4928 +7636 2 2 13 11 3816 6353 4623 +7637 2 2 13 11 3817 4624 6354 +7638 2 2 13 11 4455 4744 6501 +7639 2 2 13 11 3760 6428 4503 +7640 2 2 13 11 4054 5253 4509 +7641 2 2 13 11 4351 5257 5424 +7642 2 2 13 11 3672 5392 6279 +7643 2 2 13 11 4352 5425 5258 +7644 2 2 13 11 3928 6761 4764 +7645 2 2 13 11 4180 5546 4708 +7646 2 2 13 11 3742 4496 5549 +7647 2 2 13 11 4218 5527 4805 +7648 2 2 13 11 4219 4806 5528 +7649 2 2 13 11 3690 4876 4844 +7650 2 2 13 11 3712 5623 4540 +7651 2 2 13 11 3943 4561 5354 +7652 2 2 13 11 267 5701 5314 +7653 2 2 13 11 4026 5185 5924 +7654 2 2 13 11 4441 4784 6303 +7655 2 2 13 11 3702 4719 5666 +7656 2 2 13 11 4442 6304 4785 +7657 2 2 13 11 4222 5875 4604 +7658 2 2 13 11 4888 5867 6829 +7659 2 2 13 11 3824 6384 4821 +7660 2 2 13 11 3792 5113 4920 +7661 2 2 13 11 3793 4921 5114 +7662 2 2 13 11 3815 5867 4888 +7663 2 2 13 11 3651 5882 4576 +7664 2 2 13 11 3751 5427 4587 +7665 2 2 13 11 3666 4572 5557 +7666 2 2 13 11 3667 5558 4573 +7667 2 2 13 11 4140 4746 5470 +7668 2 2 13 11 4019 6033 4737 +7669 2 2 13 11 4487 6515 4913 +7670 2 2 13 11 139 140 5030 +7671 2 2 13 11 4672 5645 6503 +7672 2 2 13 11 6604 3884 4547 +7673 2 2 13 11 4673 6504 5646 +7674 2 2 13 11 6606 4548 3885 +7675 2 2 13 11 4066 4507 5557 +7676 2 2 13 11 4067 5558 4508 +7677 2 2 13 11 4040 4570 5491 +7678 2 2 13 11 4066 6634 5203 +7679 2 2 13 11 4067 5204 6635 +7680 2 2 13 11 3692 5873 4590 +7681 2 2 13 11 3764 4558 5941 +7682 2 2 13 11 3655 5096 4902 +7683 2 2 13 11 3970 5851 5104 +7684 2 2 13 11 4636 6894 5044 +7685 2 2 13 11 4418 4940 5751 +7686 2 2 13 11 4083 5064 5274 +7687 2 2 13 11 3650 6200 6322 +7688 2 2 13 11 4543 6073 5002 +7689 2 2 13 11 110 111 4993 +7690 2 2 13 11 4605 6345 5295 +7691 2 2 13 11 4606 5296 6346 +7692 2 2 13 11 3761 4531 5433 +7693 2 2 13 11 6266 131 4526 +7694 2 2 13 11 3865 6051 4574 +7695 2 2 13 11 4048 4827 4950 +7696 2 2 13 11 4049 4951 4828 +7697 2 2 13 11 142 143 4738 +7698 2 2 13 11 5440 5725 3687 +7699 2 2 13 11 3737 4868 4771 +7700 2 2 13 11 3738 4772 4869 +7701 2 2 13 11 4638 6254 6563 +7702 2 2 13 11 4065 4853 5092 +7703 2 2 13 11 3966 4808 4831 +7704 2 2 13 11 4214 4534 6153 +7705 2 2 13 11 4099 5349 6880 +7706 2 2 13 11 3767 5880 4557 +7707 2 2 13 11 3810 6033 5280 +7708 2 2 13 11 3693 5473 4944 +7709 2 2 13 11 6263 5236 5007 +7710 2 2 13 11 4077 5398 6168 +7711 2 2 13 11 3678 5273 4916 +7712 2 2 13 11 4013 5798 4693 +7713 2 2 13 11 3767 6692 6246 +7714 2 2 13 11 3734 4674 5881 +7715 2 2 13 11 4239 5793 4722 +7716 2 2 13 11 4240 4723 5794 +7717 2 2 13 11 4081 4527 6194 +7718 2 2 13 11 4082 6195 4528 +7719 2 2 13 11 4093 5237 4739 +7720 2 2 13 11 4189 4622 5707 +7721 2 2 13 11 4015 6133 5199 +7722 2 2 13 11 3936 4676 5491 +7723 2 2 13 11 4016 5200 6134 +7724 2 2 13 11 3760 4621 5138 +7725 2 2 13 11 4414 4935 5762 +7726 2 2 13 11 3908 4688 6395 +7727 2 2 13 11 4469 5244 5795 +7728 2 2 13 11 6575 4472 5929 +7729 2 2 13 11 3711 5250 5938 +7730 2 2 13 11 3669 6774 4561 +7731 2 2 13 11 3656 4905 5099 +7732 2 2 13 11 3750 5380 4521 +7733 2 2 13 11 3751 4587 6562 +7734 2 2 13 11 4591 6139 5516 +7735 2 2 13 11 3655 4756 5096 +7736 2 2 13 11 4081 4649 5105 +7737 2 2 13 11 4082 5106 4650 +7738 2 2 13 11 4595 6135 5303 +7739 2 2 13 11 3717 4646 5459 +7740 2 2 13 11 6325 5212 4256 +7741 2 2 13 11 6326 4257 5213 +7742 2 2 13 11 3964 5712 5992 +7743 2 2 13 11 3965 5993 5713 +7744 2 2 13 11 4100 6797 5350 +7745 2 2 13 11 3718 5315 6313 +7746 2 2 13 11 3844 4945 6022 +7747 2 2 13 11 4004 6142 4571 +7748 2 2 13 11 3656 5099 4757 +7749 2 2 13 11 3698 5912 4816 +7750 2 2 13 11 5926 119 5166 +7751 2 2 13 11 3754 4880 6688 +7752 2 2 13 11 3654 5322 4649 +7753 2 2 13 11 3653 4650 5323 +7754 2 2 13 11 4618 6614 6811 +7755 2 2 13 11 4619 6812 6615 +7756 2 2 13 11 5710 3909 6270 +7757 2 2 13 11 3716 6355 6516 +7758 2 2 13 11 3761 5641 4930 +7759 2 2 13 11 4491 6747 4845 +7760 2 2 13 11 5225 6171 6024 +7761 2 2 13 11 4484 6000 5565 +7762 2 2 13 11 3928 4764 6921 +7763 2 2 13 11 3975 6845 4599 +7764 2 2 13 11 3926 4739 5237 +7765 2 2 13 11 3665 5722 5721 +7766 2 2 13 11 82 83 5094 +7767 2 2 13 11 325 5168 5588 +7768 2 2 13 11 251 5589 5169 +7769 2 2 13 11 4500 5104 5851 +7770 2 2 13 11 5605 6718 4534 +7771 2 2 13 11 4015 5045 6133 +7772 2 2 13 11 4016 6134 5046 +7773 2 2 13 11 3749 4611 5507 +7774 2 2 13 11 4026 4562 5526 +7775 2 2 13 11 75 76 4744 +7776 2 2 13 11 5673 4273 6417 +7777 2 2 13 11 4711 6718 5605 +7778 2 2 13 11 4331 6201 4826 +7779 2 2 13 11 3774 4825 5911 +7780 2 2 13 11 3822 5248 4596 +7781 2 2 13 11 4125 5396 4518 +7782 2 2 13 11 4059 4798 5549 +7783 2 2 13 11 4015 5136 4672 +7784 2 2 13 11 4016 4673 5137 +7785 2 2 13 11 6405 4326 5128 +7786 2 2 13 11 4039 5892 4729 +7787 2 2 13 11 4479 5915 6286 +7788 2 2 13 11 3869 5770 4514 +7789 2 2 13 11 3662 6303 4784 +7790 2 2 13 11 3663 4785 6304 +7791 2 2 13 11 4142 5498 4675 +7792 2 2 13 11 3995 5620 4712 +7793 2 2 13 11 3938 6501 4744 +7794 2 2 13 11 6345 4020 5295 +7795 2 2 13 11 6346 5296 4021 +7796 2 2 13 11 3768 4525 6624 +7797 2 2 13 11 108 5604 4702 +7798 2 2 13 11 3915 6254 4582 +7799 2 2 13 11 3759 5632 4670 +7800 2 2 13 11 4293 6110 4863 +7801 2 2 13 11 4300 5441 5486 +7802 2 2 13 11 4301 5487 5442 +7803 2 2 13 11 3916 5197 4550 +7804 2 2 13 11 4690 6439 5024 +7805 2 2 13 11 4230 6263 5007 +7806 2 2 13 11 4015 4672 5045 +7807 2 2 13 11 4016 5046 4673 +7808 2 2 13 11 4138 5437 4703 +7809 2 2 13 11 4139 4704 5438 +7810 2 2 13 11 3902 5102 6255 +7811 2 2 13 11 3880 5679 4544 +7812 2 2 13 11 3903 6256 5103 +7813 2 2 13 11 3894 4616 5577 +7814 2 2 13 11 4057 4565 6267 +7815 2 2 13 11 4287 4835 5503 +7816 2 2 13 11 4189 5779 4622 +7817 2 2 13 11 3692 4590 5801 +7818 2 2 13 11 3794 5692 6231 +7819 2 2 13 11 4255 4944 5473 +7820 2 2 13 11 3960 5341 4592 +7821 2 2 13 11 3961 4593 5342 +7822 2 2 13 11 3998 5626 4721 +7823 2 2 13 11 4635 4764 6761 +7824 2 2 13 11 4210 5159 5081 +7825 2 2 13 11 4845 6747 6223 +7826 2 2 13 11 4040 5745 4570 +7827 2 2 13 11 3702 4681 5797 +7828 2 2 13 11 301 5525 302 +7829 2 2 13 11 3979 4669 6548 +7830 2 2 13 11 325 5588 326 +7831 2 2 13 11 250 5589 251 +7832 2 2 13 11 3962 4971 4765 +7833 2 2 13 11 4026 5573 4562 +7834 2 2 13 11 3684 5424 5257 +7835 2 2 13 11 3685 5258 5425 +7836 2 2 13 11 3847 4994 4773 +7837 2 2 13 11 3761 5839 5246 +7838 2 2 13 11 4863 6110 6377 +7839 2 2 13 11 4052 5254 4658 +7840 2 2 13 11 4113 5681 5501 +7841 2 2 13 11 3983 4677 5128 +7842 2 2 13 11 4543 6285 6073 +7843 2 2 13 11 275 5559 4721 +7844 2 2 13 11 3714 5862 4592 +7845 2 2 13 11 3715 4593 5863 +7846 2 2 13 11 4239 4722 5772 +7847 2 2 13 11 4240 5773 4723 +7848 2 2 13 11 4059 6374 4656 +7849 2 2 13 11 3785 5348 5041 +7850 2 2 13 11 3889 6391 5514 +7851 2 2 13 11 4114 4611 5152 +7852 2 2 13 11 3890 5515 6392 +7853 2 2 13 11 6158 5308 4235 +7854 2 2 13 11 3769 5675 4791 +7855 2 2 13 11 3770 4792 5676 +7856 2 2 13 11 3857 5566 4577 +7857 2 2 13 11 3858 4578 5567 +7858 2 2 13 11 4741 5212 6325 +7859 2 2 13 11 3724 6480 4683 +7860 2 2 13 11 4742 6326 5213 +7861 2 2 13 11 4186 4775 5260 +7862 2 2 13 11 3958 5306 4683 +7863 2 2 13 11 4052 4540 5623 +7864 2 2 13 11 3783 4651 6181 +7865 2 2 13 11 4488 6678 5585 +7866 2 2 13 11 4489 5586 6679 +7867 2 2 13 11 4035 4596 5248 +7868 2 2 13 11 6560 5066 3774 +7869 2 2 13 11 4689 6047 5331 +7870 2 2 13 11 4089 4513 5519 +7871 2 2 13 11 4576 6553 5899 +7872 2 2 13 11 4076 4981 4658 +7873 2 2 13 11 3953 4913 6515 +7874 2 2 13 11 4641 5725 5440 +7875 2 2 13 11 3906 6593 4666 +7876 2 2 13 11 4241 5027 5298 +7877 2 2 13 11 4242 5299 5028 +7878 2 2 13 11 3767 5049 6692 +7879 2 2 13 11 3752 5795 5244 +7880 2 2 13 11 3706 5059 5057 +7881 2 2 13 11 3730 5184 4665 +7882 2 2 13 11 3714 5772 4722 +7883 2 2 13 11 3715 4723 5773 +7884 2 2 13 11 3783 5703 4651 +7885 2 2 13 11 3822 4596 5406 +7886 2 2 13 11 3934 4703 5437 +7887 2 2 13 11 4005 5736 4564 +7888 2 2 13 11 3935 5438 4704 +7889 2 2 13 11 3891 5218 4644 +7890 2 2 13 11 3988 4613 6216 +7891 2 2 13 11 3915 6563 6254 +7892 2 2 13 11 308 5622 5231 +7893 2 2 13 11 3769 4817 5675 +7894 2 2 13 11 3770 5676 4818 +7895 2 2 13 11 4420 5721 5722 +7896 2 2 13 11 3836 5651 5102 +7897 2 2 13 11 3837 5103 5652 +7898 2 2 13 11 4131 5347 4767 +7899 2 2 13 11 5191 6039 6116 +7900 2 2 13 11 3665 5127 4635 +7901 2 2 13 11 4217 5389 5024 +7902 2 2 13 11 4001 5003 5014 +7903 2 2 13 11 3670 5095 5592 +7904 2 2 13 11 4156 5415 4751 +7905 2 2 13 11 4157 4752 5416 +7906 2 2 13 11 3933 6206 4646 +7907 2 2 13 11 3799 4622 5292 +7908 2 2 13 11 302 5525 5378 +7909 2 2 13 11 4632 6590 6117 +7910 2 2 13 11 4118 5577 4616 +7911 2 2 13 11 4144 4920 5113 +7912 2 2 13 11 4145 5114 4921 +7913 2 2 13 11 4288 5867 5147 +7914 2 2 13 11 3719 4751 5415 +7915 2 2 13 11 3720 5416 4752 +7916 2 2 13 11 4360 5022 5735 +7917 2 2 13 11 3697 5470 4746 +7918 2 2 13 11 4518 6161 5372 +7919 2 2 13 11 4077 5247 5398 +7920 2 2 13 11 4198 5695 4730 +7921 2 2 13 11 5275 6451 6197 +7922 2 2 13 11 3744 6062 6424 +7923 2 2 13 11 3745 6425 6064 +7924 2 2 13 11 3710 5164 5764 +7925 2 2 13 11 4013 4689 6510 +7926 2 2 13 11 4058 4876 5083 +7927 2 2 13 11 4715 6405 5128 +7928 2 2 13 11 4409 5986 6310 +7929 2 2 13 11 118 119 5926 +7930 2 2 13 11 3994 4725 5001 +7931 2 2 13 11 4749 6914 5343 +7932 2 2 13 11 4114 5507 4611 +7933 2 2 13 11 4750 5344 6915 +7934 2 2 13 11 4286 5076 5820 +7935 2 2 13 11 4050 6914 4749 +7936 2 2 13 11 4050 4950 4827 +7937 2 2 13 11 3734 5330 4594 +7938 2 2 13 11 4206 4659 5806 +7939 2 2 13 11 4051 4750 6915 +7940 2 2 13 11 4051 4828 4951 +7941 2 2 13 11 6693 5272 5093 +7942 2 2 13 11 4074 4928 4880 +7943 2 2 13 11 4058 4844 4876 +7944 2 2 13 11 4187 5403 4590 +7945 2 2 13 11 4407 5102 5651 +7946 2 2 13 11 4283 5327 5431 +7947 2 2 13 11 4408 5652 5103 +7948 2 2 13 11 4284 5432 5328 +7949 2 2 13 11 4147 4626 5699 +7950 2 2 13 11 4187 5873 4651 +7951 2 2 13 11 4134 6762 4565 +7952 2 2 13 11 3709 5061 5070 +7953 2 2 13 11 3846 5337 4610 +7954 2 2 13 11 4229 5006 5235 +7955 2 2 13 11 3902 4722 5793 +7956 2 2 13 11 3903 5794 4723 +7957 2 2 13 11 4069 5932 4554 +7958 2 2 13 11 4481 6261 4962 +7959 2 2 13 11 4232 5263 5210 +7960 2 2 13 11 3872 5868 4826 +7961 2 2 13 11 4233 5211 5264 +7962 2 2 13 11 3846 5260 5828 +7963 2 2 13 11 3686 5092 4853 +7964 2 2 13 11 3853 5345 4681 +7965 2 2 13 11 4153 5423 4765 +7966 2 2 13 11 4477 6022 4945 +7967 2 2 13 11 4043 6758 4677 +7968 2 2 13 11 3675 6471 4713 +7969 2 2 13 11 3994 5175 4945 +7970 2 2 13 11 3862 6162 5929 +7971 2 2 13 11 4036 4690 5024 +7972 2 2 13 11 124 125 4777 +7973 2 2 13 11 4492 6141 6364 +7974 2 2 13 11 273 5156 274 +7975 2 2 13 11 4104 5426 6123 +7976 2 2 13 11 3901 6938 4762 +7977 2 2 13 11 5095 6715 6213 +7978 2 2 13 11 4191 5153 5642 +7979 2 2 13 11 4081 5199 4649 +7980 2 2 13 11 4473 6659 4877 +7981 2 2 13 11 4032 4929 4964 +7982 2 2 13 11 4082 4650 5200 +7983 2 2 13 11 4112 5775 5357 +7984 2 2 13 11 4269 5116 5371 +7985 2 2 13 11 3838 5815 5352 +7986 2 2 13 11 3839 5353 5816 +7987 2 2 13 11 4127 4652 6348 +7988 2 2 13 11 3981 4767 5017 +7989 2 2 13 11 3765 4672 5136 +7990 2 2 13 11 3766 5137 4673 +7991 2 2 13 11 3818 5153 5118 +7992 2 2 13 11 3760 5138 4676 +7993 2 2 13 11 3794 6231 5224 +7994 2 2 13 11 4291 6247 5834 +7995 2 2 13 11 4154 5172 5050 +7996 2 2 13 11 115 116 4811 +7997 2 2 13 11 3958 4683 5082 +7998 2 2 13 11 5645 4037 6503 +7999 2 2 13 11 6504 4038 5646 +8000 2 2 13 11 3986 4549 6937 +8001 2 2 13 11 4002 4922 5540 +8002 2 2 13 11 4009 5095 6213 +8003 2 2 13 11 4582 5246 5839 +8004 2 2 13 11 4161 5173 4874 +8005 2 2 13 11 4162 4875 5174 +8006 2 2 13 11 4774 5025 5714 +8007 2 2 13 11 3746 6591 4938 +8008 2 2 13 11 3747 4939 6592 +8009 2 2 13 11 4747 6871 5909 +8010 2 2 13 11 4748 5910 6872 +8011 2 2 13 11 4123 4702 5604 +8012 2 2 13 11 4879 6724 6640 +8013 2 2 13 11 4149 5033 4980 +8014 2 2 13 11 4050 4813 6914 +8015 2 2 13 11 4051 6915 4814 +8016 2 2 13 11 4126 5162 4925 +8017 2 2 13 11 4006 4745 5022 +8018 2 2 13 11 3709 5070 6400 +8019 2 2 13 11 3786 6426 5177 +8020 2 2 13 11 3787 5178 6427 +8021 2 2 13 11 4010 5488 4900 +8022 2 2 13 11 6579 5270 4087 +8023 2 2 13 11 4002 5540 4989 +8024 2 2 13 11 80 81 4889 +8025 2 2 13 11 4270 6043 4590 +8026 2 2 13 11 318 5182 4627 +8027 2 2 13 11 258 4628 5183 +8028 2 2 13 11 4678 5308 6158 +8029 2 2 13 11 4187 4651 5703 +8030 2 2 13 11 3742 4798 6536 +8031 2 2 13 11 3845 4763 4997 +8032 2 2 13 11 4231 6084 4780 +8033 2 2 13 11 4058 5162 5080 +8034 2 2 13 11 4366 4797 5107 +8035 2 2 13 11 3995 4793 5620 +8036 2 2 13 11 4215 5188 4849 +8037 2 2 13 11 4216 4850 5189 +8038 2 2 13 11 3962 4765 5423 +8039 2 2 13 11 4107 5371 5116 +8040 2 2 13 11 4336 5828 5260 +8041 2 2 13 11 4055 4874 4926 +8042 2 2 13 11 4056 4927 4875 +8043 2 2 13 11 4057 5122 5911 +8044 2 2 13 11 4052 5324 4540 +8045 2 2 13 11 4707 6593 6824 +8046 2 2 13 11 4680 6713 5575 +8047 2 2 13 11 4258 5997 4738 +8048 2 2 13 11 4134 4565 6953 +8049 2 2 13 11 4040 5138 4621 +8050 2 2 13 11 3932 4789 5680 +8051 2 2 13 11 3998 4797 5626 +8052 2 2 13 11 4059 4656 6165 +8053 2 2 13 11 5122 6560 3774 +8054 2 2 13 11 4084 5180 4807 +8055 2 2 13 11 3661 5699 4626 +8056 2 2 13 11 3792 5639 5942 +8057 2 2 13 11 3793 5943 5640 +8058 2 2 13 11 3861 6497 4833 +8059 2 2 13 11 4004 5273 5075 +8060 2 2 13 11 161 162 4778 +8061 2 2 13 11 59 60 4779 +8062 2 2 13 11 3869 4558 6339 +8063 2 2 13 11 4105 5440 6053 +8064 2 2 13 11 3958 6809 5306 +8065 2 2 13 11 3784 6163 4604 +8066 2 2 13 11 4110 6152 4833 +8067 2 2 13 11 3846 4610 5395 +8068 2 2 13 11 4493 6313 5315 +8069 2 2 13 11 3697 4957 5284 +8070 2 2 13 11 4348 5398 5247 +8071 2 2 13 11 4013 6431 4689 +8072 2 2 13 11 4237 5909 6871 +8073 2 2 13 11 4238 6872 5910 +8074 2 2 13 11 3796 5081 5159 +8075 2 2 13 11 4359 6245 4793 +8076 2 2 13 11 3718 5960 5315 +8077 2 2 13 11 4163 4591 5764 +8078 2 2 13 11 4646 6201 4915 +8079 2 2 13 11 4725 5267 6633 +8080 2 2 13 11 4378 6669 4661 +8081 2 2 13 11 4366 6269 4797 +8082 2 2 13 11 3690 4844 5744 +8083 2 2 13 11 3688 5139 5831 +8084 2 2 13 11 4113 5335 4816 +8085 2 2 13 11 3761 5246 5641 +8086 2 2 13 11 120 5047 6140 +8087 2 2 13 11 4008 5166 5705 +8088 2 2 13 11 4079 5862 4722 +8089 2 2 13 11 4080 4723 5863 +8090 2 2 13 11 3906 6824 6593 +8091 2 2 13 11 142 4738 5146 +8092 2 2 13 11 4367 4761 5539 +8093 2 2 13 11 3822 5406 6176 +8094 2 2 13 11 4031 4800 6548 +8095 2 2 13 11 4235 5075 5273 +8096 2 2 13 11 139 5030 6011 +8097 2 2 13 11 4177 5730 4794 +8098 2 2 13 11 4088 5262 6557 +8099 2 2 13 11 3999 4817 6614 +8100 2 2 13 11 4000 6615 4818 +8101 2 2 13 11 4176 5390 4925 +8102 2 2 13 11 3854 5018 5746 +8103 2 2 13 11 3750 6554 5380 +8104 2 2 13 11 3855 5747 5019 +8105 2 2 13 11 3881 5152 4611 +8106 2 2 13 11 3807 5750 5069 +8107 2 2 13 11 3654 5210 5263 +8108 2 2 13 11 3717 4871 5680 +8109 2 2 13 11 3653 5264 5211 +8110 2 2 13 11 4047 5099 5042 +8111 2 2 13 11 3909 5101 6270 +8112 2 2 13 11 3807 5913 5750 +8113 2 2 13 11 6417 4273 4887 +8114 2 2 13 11 4158 5057 5059 +8115 2 2 13 11 4176 5473 5390 +8116 2 2 13 11 4675 5498 6800 +8117 2 2 13 11 4268 5819 4822 +8118 2 2 13 11 3692 5801 4692 +8119 2 2 13 11 4022 4959 5386 +8120 2 2 13 11 4155 5729 5783 +8121 2 2 13 11 3857 4577 5529 +8122 2 2 13 11 3858 5530 4578 +8123 2 2 13 11 3710 4807 5180 +8124 2 2 13 11 3968 5376 5008 +8125 2 2 13 11 3969 5009 5377 +8126 2 2 13 11 4166 4734 5594 +8127 2 2 13 11 4167 5595 4735 +8128 2 2 13 11 4012 6308 5033 +8129 2 2 13 11 4268 4822 5572 +8130 2 2 13 11 4046 5029 5096 +8131 2 2 13 11 4377 4906 5927 +8132 2 2 13 11 4993 6935 6493 +8133 2 2 13 11 3973 4962 6261 +8134 2 2 13 11 5008 5376 6109 +8135 2 2 13 11 3901 4754 5223 +8136 2 2 13 11 5009 6111 5377 +8137 2 2 13 11 3700 5927 4906 +8138 2 2 13 11 5070 5994 6400 +8139 2 2 13 11 117 118 5926 +8140 2 2 13 11 4357 6650 4759 +8141 2 2 13 11 4109 5014 5003 +8142 2 2 13 11 4589 6322 6200 +8143 2 2 13 11 3891 6087 6184 +8144 2 2 13 11 309 5700 310 +8145 2 2 13 11 266 5701 267 +8146 2 2 13 11 4322 6073 6285 +8147 2 2 13 11 4671 5674 6893 +8148 2 2 13 11 4044 4860 5489 +8149 2 2 13 11 164 165 4909 +8150 2 2 13 11 56 57 4910 +8151 2 2 13 11 4045 5490 4861 +8152 2 2 13 11 3760 4676 5181 +8153 2 2 13 11 3999 6614 4855 +8154 2 2 13 11 3810 5290 4737 +8155 2 2 13 11 4000 4856 6615 +8156 2 2 13 11 4148 6693 5093 +8157 2 2 13 11 4526 6106 5245 +8158 2 2 13 11 306 4830 307 +8159 2 2 13 11 4191 5118 5153 +8160 2 2 13 11 159 4842 5111 +8161 2 2 13 11 62 5112 4843 +8162 2 2 13 11 4119 5205 4933 +8163 2 2 13 11 4120 4934 5206 +8164 2 2 13 11 4046 4817 5029 +8165 2 2 13 11 4092 4551 5436 +8166 2 2 13 11 4825 6580 5911 +8167 2 2 13 11 4483 5831 5139 +8168 2 2 13 11 4287 5503 5825 +8169 2 2 13 11 3792 5942 5113 +8170 2 2 13 11 3793 5114 5943 +8171 2 2 13 11 4047 5042 4818 +8172 2 2 13 11 4039 4729 6465 +8173 2 2 13 11 4036 5024 5389 +8174 2 2 13 11 5292 6297 4285 +8175 2 2 13 11 3679 5737 4707 +8176 2 2 13 11 4298 5077 5400 +8177 2 2 13 11 3959 6789 4710 +8178 2 2 13 11 4299 5401 5078 +8179 2 2 13 11 3762 4618 5740 +8180 2 2 13 11 4043 4677 6572 +8181 2 2 13 11 3763 5741 4619 +8182 2 2 13 11 3894 6167 4616 +8183 2 2 13 11 3882 5522 4581 +8184 2 2 13 11 4019 6691 6033 +8185 2 2 13 11 4229 5235 5725 +8186 2 2 13 11 4012 5002 6073 +8187 2 2 13 11 4531 4930 6654 +8188 2 2 13 11 4515 4993 6493 +8189 2 2 13 11 159 160 4842 +8190 2 2 13 11 61 62 4843 +8191 2 2 13 11 3764 5517 4558 +8192 2 2 13 11 4479 5049 5915 +8193 2 2 13 11 3757 5391 4662 +8194 2 2 13 11 3910 5201 4755 +8195 2 2 13 11 6866 5538 4317 +8196 2 2 13 11 3703 5141 4734 +8197 2 2 13 11 3704 4735 5142 +8198 2 2 13 11 4320 4763 6224 +8199 2 2 13 11 4008 5000 5397 +8200 2 2 13 11 4639 6441 6888 +8201 2 2 13 11 3967 4822 5819 +8202 2 2 13 11 4159 5070 5061 +8203 2 2 13 11 4110 5812 6152 +8204 2 2 13 11 4159 5155 5070 +8205 2 2 13 11 4318 6198 4632 +8206 2 2 13 11 4720 5380 6554 +8207 2 2 13 11 4061 5534 5141 +8208 2 2 13 11 4062 5142 5535 +8209 2 2 13 11 4553 6184 6087 +8210 2 2 13 11 4078 5123 5276 +8211 2 2 13 11 3820 5735 5022 +8212 2 2 13 11 3833 5842 5661 +8213 2 2 13 11 4031 6548 6418 +8214 2 2 13 11 4057 5911 5974 +8215 2 2 13 11 4319 5191 6116 +8216 2 2 13 11 4209 4665 5768 +8217 2 2 13 11 4079 4722 5684 +8218 2 2 13 11 4080 5685 4723 +8219 2 2 13 11 4331 4826 5868 +8220 2 2 13 11 3806 4841 5689 +8221 2 2 13 11 3908 5149 4688 +8222 2 2 13 11 4108 4681 5345 +8223 2 2 13 11 3991 5233 4636 +8224 2 2 13 11 3769 5029 4817 +8225 2 2 13 11 3952 4686 5172 +8226 2 2 13 11 4546 6213 5570 +8227 2 2 13 11 4495 6229 4952 +8228 2 2 13 11 3932 5680 4871 +8229 2 2 13 11 3758 5075 5308 +8230 2 2 13 11 3741 5053 4936 +8231 2 2 13 11 3759 4870 5632 +8232 2 2 13 11 3877 6364 6141 +8233 2 2 13 11 4025 5176 4768 +8234 2 2 13 11 3713 5834 4998 +8235 2 2 13 11 4057 5413 4565 +8236 2 2 13 11 3851 5240 5946 +8237 2 2 13 11 4235 5308 5075 +8238 2 2 13 11 4013 6510 4829 +8239 2 2 13 11 4172 5209 4633 +8240 2 2 13 11 5026 6274 6048 +8241 2 2 13 11 3780 4980 5033 +8242 2 2 13 11 3770 4818 5042 +8243 2 2 13 11 4039 4881 6292 +8244 2 2 13 11 4246 4561 5771 +8245 2 2 13 11 3989 5494 4923 +8246 2 2 13 11 5076 6675 5820 +8247 2 2 13 11 4094 5462 5202 +8248 2 2 13 11 4091 4662 5391 +8249 2 2 13 11 4812 5306 6809 +8250 2 2 13 11 4886 4995 6572 +8251 2 2 13 11 4007 5592 4557 +8252 2 2 13 11 4519 6536 4798 +8253 2 2 13 11 4004 4617 6511 +8254 2 2 13 11 4599 6845 5653 +8255 2 2 13 11 3921 4738 5997 +8256 2 2 13 11 3736 6773 6065 +8257 2 2 13 11 3660 5321 4687 +8258 2 2 13 11 4760 6363 5196 +8259 2 2 13 11 3919 4791 6566 +8260 2 2 13 11 3920 6567 4792 +8261 2 2 13 11 94 5383 4710 +8262 2 2 13 11 4364 4734 5141 +8263 2 2 13 11 4524 4833 6497 +8264 2 2 13 11 4365 5142 4735 +8265 2 2 13 11 3955 6669 5565 +8266 2 2 13 11 4802 5538 6866 +8267 2 2 13 11 3844 5671 5520 +8268 2 2 13 11 4035 5070 5155 +8269 2 2 13 11 4202 4743 5505 +8270 2 2 13 11 4060 5225 6266 +8271 2 2 13 11 4153 5372 6161 +8272 2 2 13 11 3724 4683 6337 +8273 2 2 13 11 3650 6322 4899 +8274 2 2 13 11 4023 5659 4692 +8275 2 2 13 11 4421 6053 5440 +8276 2 2 13 11 4173 5686 4731 +8277 2 2 13 11 4174 4732 5687 +8278 2 2 13 11 3891 4671 6087 +8279 2 2 13 11 4043 4799 6758 +8280 2 2 13 11 4073 4964 4929 +8281 2 2 13 11 4396 5746 5018 +8282 2 2 13 11 4483 5728 6577 +8283 2 2 13 11 4397 5019 5747 +8284 2 2 13 11 4319 5556 5232 +8285 2 2 13 11 4218 5219 5203 +8286 2 2 13 11 4219 5204 5220 +8287 2 2 13 11 3833 5145 5842 +8288 2 2 13 11 4584 5824 5407 +8289 2 2 13 11 4079 4592 5862 +8290 2 2 13 11 4080 5863 4593 +8291 2 2 13 11 4563 6774 6032 +8292 2 2 13 11 3995 6107 4634 +8293 2 2 13 11 4081 5105 5132 +8294 2 2 13 11 4494 5000 6275 +8295 2 2 13 11 4082 5133 5106 +8296 2 2 13 11 4022 5386 6278 +8297 2 2 13 11 3686 4853 5209 +8298 2 2 13 11 4039 5023 5892 +8299 2 2 13 11 3970 4780 5040 +8300 2 2 13 11 3955 4598 5499 +8301 2 2 13 11 4243 6118 5165 +8302 2 2 13 11 3751 6562 4847 +8303 2 2 13 11 3923 6609 4796 +8304 2 2 13 11 4040 4621 5854 +8305 2 2 13 11 5428 6579 4087 +8306 2 2 13 11 4066 5203 5219 +8307 2 2 13 11 3736 6088 5627 +8308 2 2 13 11 4067 5220 5204 +8309 2 2 13 11 96 97 4956 +8310 2 2 13 11 6573 3986 5311 +8311 2 2 13 11 4317 5502 5578 +8312 2 2 13 11 4076 4658 6841 +8313 2 2 13 11 4422 6219 6282 +8314 2 2 13 11 4090 4712 5362 +8315 2 2 13 11 4060 6171 5225 +8316 2 2 13 11 80 4889 6605 +8317 2 2 13 11 3982 4582 6740 +8318 2 2 13 11 4182 5062 5227 +8319 2 2 13 11 4378 4661 6337 +8320 2 2 13 11 4005 4691 5736 +8321 2 2 13 11 4396 6243 5409 +8322 2 2 13 11 4397 5410 6244 +8323 2 2 13 11 4104 6123 5278 +8324 2 2 13 11 4497 4796 6609 +8325 2 2 13 11 4676 5138 5491 +8326 2 2 13 11 3909 5710 5100 +8327 2 2 13 11 5259 6639 4073 +8328 2 2 13 11 4173 4731 5615 +8329 2 2 13 11 4174 5616 4732 +8330 2 2 13 11 4102 6136 4591 +8331 2 2 13 11 3964 6627 5343 +8332 2 2 13 11 3965 5344 6628 +8333 2 2 13 11 4474 6138 5383 +8334 2 2 13 11 3856 4879 6640 +8335 2 2 13 11 4555 6424 6062 +8336 2 2 13 11 4556 6064 6425 +8337 2 2 13 11 319 4627 5554 +8338 2 2 13 11 257 5555 4628 +8339 2 2 13 11 3736 4987 6773 +8340 2 2 13 11 4070 5452 4884 +8341 2 2 13 11 4071 4885 5453 +8342 2 2 13 11 5120 5729 6416 +8343 2 2 13 11 4422 6282 5456 +8344 2 2 13 11 6860 3842 5771 +8345 2 2 13 11 3762 5313 6037 +8346 2 2 13 11 3763 6038 5316 +8347 2 2 13 11 4166 5639 4647 +8348 2 2 13 11 4167 4648 5640 +8349 2 2 13 11 4320 5450 4763 +8350 2 2 13 11 4318 4961 6846 +8351 2 2 13 11 4475 6566 4791 +8352 2 2 13 11 4476 4792 6567 +8353 2 2 13 11 3748 6275 5000 +8354 2 2 13 11 3654 4649 6133 +8355 2 2 13 11 3653 6134 4650 +8356 2 2 13 11 3911 4607 5461 +8357 2 2 13 11 3862 5023 6162 +8358 2 2 13 11 3912 5463 4608 +8359 2 2 13 11 3795 6287 5694 +8360 2 2 13 11 3955 5422 4598 +8361 2 2 13 11 3655 6118 4756 +8362 2 2 13 11 72 73 4959 +8363 2 2 13 11 5998 5389 4217 +8364 2 2 13 11 5429 4088 6557 +8365 2 2 13 11 4396 5885 6243 +8366 2 2 13 11 4397 6244 5886 +8367 2 2 13 11 4169 4602 5700 +8368 2 2 13 11 3891 4644 5674 +8369 2 2 13 11 3677 5241 4758 +8370 2 2 13 11 4170 5701 4603 +8371 2 2 13 11 4013 6600 5798 +8372 2 2 13 11 4796 6297 5292 +8373 2 2 13 11 3934 5615 4731 +8374 2 2 13 11 3935 4732 5616 +8375 2 2 13 11 4497 6609 5632 +8376 2 2 13 11 4504 5392 6446 +8377 2 2 13 11 4244 4640 5840 +8378 2 2 13 11 4252 5689 4841 +8379 2 2 13 11 3947 5195 4651 +8380 2 2 13 11 3692 4692 5654 +8381 2 2 13 11 5033 6308 5480 +8382 2 2 13 11 4246 6654 4930 +8383 2 2 13 11 4175 6805 4595 +8384 2 2 13 11 4638 5389 5998 +8385 2 2 13 11 4059 5549 5115 +8386 2 2 13 11 267 5314 268 +8387 2 2 13 11 4221 5193 5737 +8388 2 2 13 11 3762 5027 4855 +8389 2 2 13 11 4214 4867 5605 +8390 2 2 13 11 4424 5308 4678 +8391 2 2 13 11 4107 5043 5419 +8392 2 2 13 11 3763 4856 5028 +8393 2 2 13 11 6213 6514 5570 +8394 2 2 13 11 3963 6129 5312 +8395 2 2 13 11 3995 5340 4793 +8396 2 2 13 11 4358 5705 5166 +8397 2 2 13 11 4363 5202 5462 +8398 2 2 13 11 3775 5534 4667 +8399 2 2 13 11 3751 5706 5427 +8400 2 2 13 11 4862 5814 5195 +8401 2 2 13 11 3776 4668 5535 +8402 2 2 13 11 4404 5256 5699 +8403 2 2 13 11 5343 3786 6290 +8404 2 2 13 11 5344 6291 3787 +8405 2 2 13 11 4462 5156 6147 +8406 2 2 13 11 4142 4675 5300 +8407 2 2 13 11 4171 5054 5414 +8408 2 2 13 11 4749 5343 6290 +8409 2 2 13 11 4750 6291 5344 +8410 2 2 13 11 3661 4626 5477 +8411 2 2 13 11 3946 4743 6411 +8412 2 2 13 11 3982 5743 4582 +8413 2 2 13 11 3734 5881 6690 +8414 2 2 13 11 6200 4149 4589 +8415 2 2 13 11 4121 5400 5077 +8416 2 2 13 11 4122 5078 5401 +8417 2 2 13 11 3804 4933 5205 +8418 2 2 13 11 3991 4870 5233 +8419 2 2 13 11 3805 5206 4934 +8420 2 2 13 11 4707 5737 6593 +8421 2 2 13 11 4467 6290 5177 +8422 2 2 13 11 4468 5178 6291 +8423 2 2 13 11 116 5287 4811 +8424 2 2 13 11 3959 4825 6789 +8425 2 2 13 11 4464 4889 5599 +8426 2 2 13 11 4405 5338 4901 +8427 2 2 13 11 4039 6292 6162 +8428 2 2 13 11 3978 5026 4841 +8429 2 2 13 11 4005 4654 5230 +8430 2 2 13 11 90 4656 6374 +8431 2 2 13 11 3781 5696 4857 +8432 2 2 13 11 3778 5192 5614 +8433 2 2 13 11 4550 6429 5147 +8434 2 2 13 11 3743 4680 5436 +8435 2 2 13 11 3845 6224 4763 +8436 2 2 13 11 4335 5399 5356 +8437 2 2 13 11 4900 5488 6356 +8438 2 2 13 11 3886 5086 6187 +8439 2 2 13 11 3887 6188 5087 +8440 2 2 13 11 4387 5100 5710 +8441 2 2 13 11 4253 4857 5696 +8442 2 2 13 11 3661 6719 4996 +8443 2 2 13 11 4072 5223 6882 +8444 2 2 13 11 4572 5417 6642 +8445 2 2 13 11 4573 6643 5418 +8446 2 2 13 11 4364 5141 5534 +8447 2 2 13 11 4365 5535 5142 +8448 2 2 13 11 3949 6529 5044 +8449 2 2 13 11 4728 5047 6608 +8450 2 2 13 11 3691 5542 4637 +8451 2 2 13 11 4890 6573 5311 +8452 2 2 13 11 3875 5227 5062 +8453 2 2 13 11 3854 4892 5018 +8454 2 2 13 11 3855 5019 4893 +8455 2 2 13 11 3662 5719 4809 +8456 2 2 13 11 3663 4810 5720 +8457 2 2 13 11 4555 6625 4990 +8458 2 2 13 11 4556 4991 6626 +8459 2 2 13 11 5038 6860 5771 +8460 2 2 13 11 120 121 5047 +8461 2 2 13 11 3998 6209 4657 +8462 2 2 13 11 4013 4693 6672 +8463 2 2 13 11 3866 5407 5824 +8464 2 2 13 11 4112 5042 5099 +8465 2 2 13 11 3775 5601 5534 +8466 2 2 13 11 3776 5535 5602 +8467 2 2 13 11 5319 6910 4124 +8468 2 2 13 11 3904 5605 4867 +8469 2 2 13 11 4152 4662 6137 +8470 2 2 13 11 4181 6593 5737 +8471 2 2 13 11 5375 6248 6561 +8472 2 2 13 11 4405 5614 5192 +8473 2 2 13 11 4110 5096 5029 +8474 2 2 13 11 4052 4658 5935 +8475 2 2 13 11 4024 5229 4899 +8476 2 2 13 11 308 5231 309 +8477 2 2 13 11 3675 5222 5649 +8478 2 2 13 11 3730 4665 5450 +8479 2 2 13 11 4527 6187 5086 +8480 2 2 13 11 4528 5087 6188 +8481 2 2 13 11 3889 4990 6625 +8482 2 2 13 11 3890 6626 4991 +8483 2 2 13 11 3904 4711 5605 +8484 2 2 13 11 3723 4787 5274 +8485 2 2 13 11 3773 4835 5119 +8486 2 2 13 11 4133 4901 5338 +8487 2 2 13 11 268 5314 6090 +8488 2 2 13 11 4414 5053 5934 +8489 2 2 13 11 4754 6882 5223 +8490 2 2 13 11 3973 6310 4962 +8491 2 2 13 11 322 4897 323 +8492 2 2 13 11 253 4898 254 +8493 2 2 13 11 4058 5083 5162 +8494 2 2 13 11 4598 5422 6843 +8495 2 2 13 11 3815 4888 6040 +8496 2 2 13 11 3741 5934 5053 +8497 2 2 13 11 133 134 4962 +8498 2 2 13 11 4358 6140 5047 +8499 2 2 13 11 6591 3996 5509 +8500 2 2 13 11 6592 5510 3997 +8501 2 2 13 11 3665 4635 5722 +8502 2 2 13 11 165 6079 4909 +8503 2 2 13 11 56 4910 6080 +8504 2 2 13 11 4318 6846 6198 +8505 2 2 13 11 4079 6114 4592 +8506 2 2 13 11 4080 4593 6115 +8507 2 2 13 11 4116 6087 5711 +8508 2 2 13 11 3928 4613 5977 +8509 2 2 13 11 4747 5909 6916 +8510 2 2 13 11 4748 6917 5910 +8511 2 2 13 11 3937 4698 6465 +8512 2 2 13 11 113 4616 5336 +8513 2 2 13 11 96 4956 6621 +8514 2 2 13 11 4057 4758 5122 +8515 2 2 13 11 3778 4666 5866 +8516 2 2 13 11 4195 4997 5569 +8517 2 2 13 11 4069 6340 6620 +8518 2 2 13 11 4092 5436 4680 +8519 2 2 13 11 3675 5449 4609 +8520 2 2 13 11 3967 4768 5176 +8521 2 2 13 11 3946 4604 5505 +8522 2 2 13 11 3756 5253 5462 +8523 2 2 13 11 4127 5800 4652 +8524 2 2 13 11 4683 6480 5082 +8525 2 2 13 11 4378 6337 4683 +8526 2 2 13 11 4414 6226 5053 +8527 2 2 13 11 3911 5852 4607 +8528 2 2 13 11 4003 5184 4706 +8529 2 2 13 11 3912 4608 5853 +8530 2 2 13 11 3998 5107 4797 +8531 2 2 13 11 3795 5226 6287 +8532 2 2 13 11 4325 6224 5548 +8533 2 2 13 11 3815 5147 5867 +8534 2 2 13 11 4061 5018 4892 +8535 2 2 13 11 4075 4936 5053 +8536 2 2 13 11 4062 4893 5019 +8537 2 2 13 11 3660 4687 6127 +8538 2 2 13 11 3989 6433 4585 +8539 2 2 13 11 3674 5798 4988 +8540 2 2 13 11 5354 6721 5877 +8541 2 2 13 11 3705 6003 5037 +8542 2 2 13 11 4026 4775 5573 +8543 2 2 13 11 4168 5824 4584 +8544 2 2 13 11 3917 4733 6473 +8545 2 2 13 11 4780 6084 5040 +8546 2 2 13 11 3928 6921 6216 +8547 2 2 13 11 4846 6130 6947 +8548 2 2 13 11 4286 5670 5076 +8549 2 2 13 11 4220 4755 5201 +8550 2 2 13 11 4938 6591 5509 +8551 2 2 13 11 4939 5510 6592 +8552 2 2 13 11 3946 5505 4743 +8553 2 2 13 11 4171 5727 4705 +8554 2 2 13 11 4090 4600 5633 +8555 2 2 13 11 4044 5489 5109 +8556 2 2 13 11 4045 5110 5490 +8557 2 2 13 11 4854 6639 5259 +8558 2 2 13 11 3870 4631 6234 +8559 2 2 13 11 4078 5088 5085 +8560 2 2 13 11 3741 5301 4634 +8561 2 2 13 11 3937 6465 4729 +8562 2 2 13 11 4140 4724 5277 +8563 2 2 13 11 3938 5836 5305 +8564 2 2 13 11 4264 4816 5912 +8565 2 2 13 11 4552 5398 6489 +8566 2 2 13 11 4089 5356 5399 +8567 2 2 13 11 4061 5754 4667 +8568 2 2 13 11 4062 4668 5755 +8569 2 2 13 11 4030 6539 5090 +8570 2 2 13 11 3725 6280 5716 +8571 2 2 13 11 3768 5656 5774 +8572 2 2 13 11 3782 5003 5791 +8573 2 2 13 11 3782 5791 4976 +8574 2 2 13 11 3690 5123 4876 +8575 2 2 13 11 4101 5094 5325 +8576 2 2 13 11 4359 5419 5043 +8577 2 2 13 11 4220 5950 4755 +8578 2 2 13 11 3881 4816 5835 +8579 2 2 13 11 4149 5733 4589 +8580 2 2 13 11 4182 4839 5062 +8581 2 2 13 11 4027 4758 5241 +8582 2 2 13 11 4583 5427 5706 +8583 2 2 13 11 3821 5403 4919 +8584 2 2 13 11 3819 4691 5662 +8585 2 2 13 11 3899 5355 4643 +8586 2 2 13 11 4600 5362 6564 +8587 2 2 13 11 4123 5604 6528 +8588 2 2 13 11 3717 5680 6228 +8589 2 2 13 11 4404 5699 6703 +8590 2 2 13 11 3802 6800 5498 +8591 2 2 13 11 4740 6052 6704 +8592 2 2 13 11 3800 5531 5214 +8593 2 2 13 11 4199 5710 4941 +8594 2 2 13 11 75 4744 6380 +8595 2 2 13 11 4362 6040 4888 +8596 2 2 13 11 4730 5695 6931 +8597 2 2 13 11 4695 5930 5668 +8598 2 2 13 11 4696 5669 5931 +8599 2 2 13 11 4236 4716 6041 +8600 2 2 13 11 4661 6669 5499 +8601 2 2 13 11 4645 6129 6854 +8602 2 2 13 11 4078 5083 4876 +8603 2 2 13 11 4024 4983 5229 +8604 2 2 13 11 4844 6499 5744 +8605 2 2 13 11 4183 4676 5582 +8606 2 2 13 11 3784 4783 5611 +8607 2 2 13 11 4072 5076 6108 +8608 2 2 13 11 3718 5232 5556 +8609 2 2 13 11 3772 4705 5727 +8610 2 2 13 11 4077 5280 6280 +8611 2 2 13 11 4087 6603 4609 +8612 2 2 13 11 4414 6559 6226 +8613 2 2 13 11 4105 4641 5440 +8614 2 2 13 11 4455 6380 4744 +8615 2 2 13 11 4057 6267 4758 +8616 2 2 13 11 3808 5281 5678 +8617 2 2 13 11 4029 5147 6429 +8618 2 2 13 11 3886 6855 5086 +8619 2 2 13 11 3887 5087 6856 +8620 2 2 13 11 3886 6148 6855 +8621 2 2 13 11 3887 6856 6150 +8622 2 2 13 11 4574 6612 5884 +8623 2 2 13 11 3946 5799 4604 +8624 2 2 13 11 4366 5483 5048 +8625 2 2 13 11 4087 4609 5449 +8626 2 2 13 11 4320 5603 5450 +8627 2 2 13 11 4177 5562 5730 +8628 2 2 13 11 4221 5737 6069 +8629 2 2 13 11 4475 4791 5675 +8630 2 2 13 11 4476 5676 4792 +8631 2 2 13 11 4450 5326 5653 +8632 2 2 13 11 4636 5044 6529 +8633 2 2 13 11 4182 5802 4745 +8634 2 2 13 11 3879 5653 5326 +8635 2 2 13 11 4473 5228 6610 +8636 2 2 13 11 4202 5094 5667 +8637 2 2 13 11 4125 5048 5483 +8638 2 2 13 11 4464 6605 4889 +8639 2 2 13 11 4954 6933 5361 +8640 2 2 13 11 3950 6165 4656 +8641 2 2 13 11 4117 5085 5088 +8642 2 2 13 11 3943 5354 5877 +8643 2 2 13 11 4372 5337 6176 +8644 2 2 13 11 4024 4737 5290 +8645 2 2 13 11 4340 5651 5298 +8646 2 2 13 11 77 5143 5883 +8647 2 2 13 11 4341 5299 5652 +8648 2 2 13 11 72 4959 6375 +8649 2 2 13 11 4185 5654 4692 +8650 2 2 13 11 3819 5736 4691 +8651 2 2 13 11 4349 4988 5798 +8652 2 2 13 11 4347 6366 5831 +8653 2 2 13 11 4671 5711 6087 +8654 2 2 13 11 3743 6713 4680 +8655 2 2 13 11 3918 6406 4908 +8656 2 2 13 11 4550 6040 4882 +8657 2 2 13 11 70 71 4946 +8658 2 2 13 11 3717 5459 4871 +8659 2 2 13 11 4453 6151 6397 +8660 2 2 13 11 4372 5406 4733 +8661 2 2 13 11 6910 5126 4124 +8662 2 2 13 11 4109 5276 5123 +8663 2 2 13 11 4055 5111 4842 +8664 2 2 13 11 4056 4843 5112 +8665 2 2 13 11 6052 3809 6704 +8666 2 2 13 11 3691 4637 5734 +8667 2 2 13 11 90 5617 4656 +8668 2 2 13 11 3666 4911 5207 +8669 2 2 13 11 3667 5208 4912 +8670 2 2 13 11 4086 6284 4725 +8671 2 2 13 11 4367 5539 6191 +8672 2 2 13 11 6933 3877 5361 +8673 2 2 13 11 4201 5903 4801 +8674 2 2 13 11 4322 4821 5500 +8675 2 2 13 11 4347 5831 5135 +8676 2 2 13 11 4027 5745 4840 +8677 2 2 13 11 4041 5293 6251 +8678 2 2 13 11 4042 6252 5294 +8679 2 2 13 11 3995 4947 5340 +8680 2 2 13 11 3881 4611 5681 +8681 2 2 13 11 3785 4925 5162 +8682 2 2 13 11 4363 5462 5253 +8683 2 2 13 11 5090 6539 5538 +8684 2 2 13 11 4622 5779 4878 +8685 2 2 13 11 3706 6320 5059 +8686 2 2 13 11 150 151 4982 +8687 2 2 13 11 4130 5233 4870 +8688 2 2 13 11 3921 5997 4632 +8689 2 2 13 11 4642 6072 6814 +8690 2 2 13 11 3984 5319 4848 +8691 2 2 13 11 5027 6037 5298 +8692 2 2 13 11 5028 5299 6038 +8693 2 2 13 11 4163 5774 4708 +8694 2 2 13 11 297 4949 298 +8695 2 2 13 11 3686 5803 5092 +8696 2 2 13 11 155 5441 4695 +8697 2 2 13 11 66 4696 5442 +8698 2 2 13 11 4480 6012 5170 +8699 2 2 13 11 4661 4882 5876 +8700 2 2 13 11 4153 4765 6673 +8701 2 2 13 11 3830 6386 5585 +8702 2 2 13 11 3831 5586 6387 +8703 2 2 13 11 3705 6197 6451 +8704 2 2 13 11 3670 4761 6333 +8705 2 2 13 11 4078 4876 5123 +8706 2 2 13 11 4108 5355 4719 +8707 2 2 13 11 4388 6742 5079 +8708 2 2 13 11 4482 6190 5422 +8709 2 2 13 11 4566 6251 5293 +8710 2 2 13 11 3727 4642 5460 +8711 2 2 13 11 4567 5294 6252 +8712 2 2 13 11 4485 5495 6436 +8713 2 2 13 11 3765 5645 4672 +8714 2 2 13 11 3766 4673 5646 +8715 2 2 13 11 3809 5076 5670 +8716 2 2 13 11 4699 6752 6453 +8717 2 2 13 11 4700 6454 6753 +8718 2 2 13 11 107 4702 6542 +8719 2 2 13 11 4265 5445 5168 +8720 2 2 13 11 4266 5169 5446 +8721 2 2 13 11 4007 5880 6777 +8722 2 2 13 11 3994 5267 4725 +8723 2 2 13 11 3952 5937 4686 +8724 2 2 13 11 4462 5948 5466 +8725 2 2 13 11 4023 6616 5659 +8726 2 2 13 11 3939 4620 5730 +8727 2 2 13 11 4100 4717 5451 +8728 2 2 13 11 4353 5415 5475 +8729 2 2 13 11 4354 5476 5416 +8730 2 2 13 11 4822 6376 5572 +8731 2 2 13 11 5654 5361 6733 +8732 2 2 13 11 4172 4633 5752 +8733 2 2 13 11 4400 5005 5185 +8734 2 2 13 11 3860 5466 5948 +8735 2 2 13 11 4387 4844 5855 +8736 2 2 13 11 3764 6123 5517 +8737 2 2 13 11 154 4695 5668 +8738 2 2 13 11 67 5669 4696 +8739 2 2 13 11 4059 5167 6374 +8740 2 2 13 11 143 5907 4738 +8741 2 2 13 11 4091 5420 4662 +8742 2 2 13 11 3785 5085 5348 +8743 2 2 13 11 3962 5423 5108 +8744 2 2 13 11 4997 6596 5569 +8745 2 2 13 11 4605 5411 6345 +8746 2 2 13 11 4606 6346 5412 +8747 2 2 13 11 4002 5985 4922 +8748 2 2 13 11 4138 5168 5445 +8749 2 2 13 11 4139 5446 5169 +8750 2 2 13 11 3728 5170 6012 +8751 2 2 13 11 3680 5333 4837 +8752 2 2 13 11 3681 4838 5334 +8753 2 2 13 11 4759 6650 5309 +8754 2 2 13 11 4327 6947 6130 +8755 2 2 13 11 4270 4947 5301 +8756 2 2 13 11 3956 4956 6430 +8757 2 2 13 11 4646 6206 5459 +8758 2 2 13 11 4258 4738 5907 +8759 2 2 13 11 134 6660 4962 +8760 2 2 13 11 3875 5148 4961 +8761 2 2 13 11 4092 5921 4682 +8762 2 2 13 11 4505 6430 4956 +8763 2 2 13 11 3781 4698 5696 +8764 2 2 13 11 4124 4848 5319 +8765 2 2 13 11 4089 6613 6900 +8766 2 2 13 11 3820 6117 6590 +8767 2 2 13 11 4264 5835 4816 +8768 2 2 13 11 3804 5536 4933 +8769 2 2 13 11 4775 5924 5260 +8770 2 2 13 11 3660 4755 5950 +8771 2 2 13 11 4438 5317 6035 +8772 2 2 13 11 3805 4934 5537 +8773 2 2 13 11 4209 6034 4665 +8774 2 2 13 11 4439 6036 5318 +8775 2 2 13 11 5361 4416 6733 +8776 2 2 13 11 99 6166 6268 +8777 2 2 13 11 4190 4705 5619 +8778 2 2 13 11 3929 5780 4736 +8779 2 2 13 11 4311 5671 4999 +8780 2 2 13 11 4198 4736 5271 +8781 2 2 13 11 4187 4919 5403 +8782 2 2 13 11 4254 5899 6553 +8783 2 2 13 11 3933 4646 5944 +8784 2 2 13 11 3902 5793 4663 +8785 2 2 13 11 3903 4664 5794 +8786 2 2 13 11 4392 6345 5411 +8787 2 2 13 11 4393 5412 6346 +8788 2 2 13 11 4069 5385 6340 +8789 2 2 13 11 4247 4716 6241 +8790 2 2 13 11 4134 4865 5255 +8791 2 2 13 11 4451 6516 4733 +8792 2 2 13 11 3859 4903 6027 +8793 2 2 13 11 3678 6882 4754 +8794 2 2 13 11 4335 5217 6485 +8795 2 2 13 11 4633 5619 5752 +8796 2 2 13 11 3758 4894 5075 +8797 2 2 13 11 4083 5274 4787 +8798 2 2 13 11 4053 4790 5813 +8799 2 2 13 11 4182 5227 5802 +8800 2 2 13 11 3916 4661 6826 +8801 2 2 13 11 3882 4766 5522 +8802 2 2 13 11 3971 6130 4846 +8803 2 2 13 11 3779 5553 5821 +8804 2 2 13 11 4023 4692 5801 +8805 2 2 13 11 3700 6311 5261 +8806 2 2 13 11 3899 4705 5889 +8807 2 2 13 11 3962 4753 6264 +8808 2 2 13 11 3772 5752 5619 +8809 2 2 13 11 4078 5085 5083 +8810 2 2 13 11 3779 5711 4671 +8811 2 2 13 11 4544 4923 5494 +8812 2 2 13 11 3673 5961 5571 +8813 2 2 13 11 4666 5614 6490 +8814 2 2 13 11 4058 5855 4844 +8815 2 2 13 11 5217 5766 6485 +8816 2 2 13 11 4645 5553 6129 +8817 2 2 13 11 3975 5127 5479 +8818 2 2 13 11 4623 6353 5359 +8819 2 2 13 11 4624 5360 6354 +8820 2 2 13 11 4329 5783 5729 +8821 2 2 13 11 290 4712 5620 +8822 2 2 13 11 3699 5289 5642 +8823 2 2 13 11 4207 5015 6922 +8824 2 2 13 11 3803 5285 4942 +8825 2 2 13 11 4195 5541 4997 +8826 2 2 13 11 4117 5688 5564 +8827 2 2 13 11 4357 4759 6455 +8828 2 2 13 11 3753 5778 4768 +8829 2 2 13 11 4207 6922 6396 +8830 2 2 13 11 3729 4688 5813 +8831 2 2 13 11 4220 5201 5731 +8832 2 2 13 11 4072 6108 5223 +8833 2 2 13 11 4043 5928 5739 +8834 2 2 13 11 3662 4784 6786 +8835 2 2 13 11 3663 6787 4785 +8836 2 2 13 11 4127 5944 4646 +8837 2 2 13 11 3672 5026 6048 +8838 2 2 13 11 77 78 5143 +8839 2 2 13 11 4260 6052 4740 +8840 2 2 13 11 4202 5325 5094 +8841 2 2 13 11 4247 6282 4716 +8842 2 2 13 11 4123 5922 4702 +8843 2 2 13 11 116 117 5287 +8844 2 2 13 11 4449 4905 6449 +8845 2 2 13 11 4075 4718 6616 +8846 2 2 13 11 4177 4794 5430 +8847 2 2 13 11 3804 5205 5006 +8848 2 2 13 11 3805 5007 5206 +8849 2 2 13 11 4165 4637 5949 +8850 2 2 13 11 4419 6451 5275 +8851 2 2 13 11 3742 4840 5854 +8852 2 2 13 11 4659 6906 5806 +8853 2 2 13 11 4649 5322 6944 +8854 2 2 13 11 4650 6945 5323 +8855 2 2 13 11 4166 4647 5630 +8856 2 2 13 11 4167 5631 4648 +8857 2 2 13 11 4670 5632 6609 +8858 2 2 13 11 4401 5037 6003 +8859 2 2 13 11 3812 6156 5295 +8860 2 2 13 11 3813 5296 6157 +8861 2 2 13 11 4130 5444 4693 +8862 2 2 13 11 276 4721 5626 +8863 2 2 13 11 4061 4667 5534 +8864 2 2 13 11 4062 5535 4668 +8865 2 2 13 11 3919 6579 4791 +8866 2 2 13 11 4095 5322 5265 +8867 2 2 13 11 4096 5266 5323 +8868 2 2 13 11 4312 5644 4963 +8869 2 2 13 11 4783 6932 5611 +8870 2 2 13 11 4165 5734 4637 +8871 2 2 13 11 3847 4773 5397 +8872 2 2 13 11 4311 6439 4690 +8873 2 2 13 11 3713 6416 5729 +8874 2 2 13 11 4996 5843 6703 +8875 2 2 13 11 4867 6676 6016 +8876 2 2 13 11 3734 6356 4674 +8877 2 2 13 11 106 4726 5543 +8878 2 2 13 11 4337 5946 5240 +8879 2 2 13 11 3936 5582 4676 +8880 2 2 13 11 3703 4734 5630 +8881 2 2 13 11 3704 5631 4735 +8882 2 2 13 11 3780 5995 5658 +8883 2 2 13 11 3741 4634 5934 +8884 2 2 13 11 5054 6093 5414 +8885 2 2 13 11 4572 5207 5417 +8886 2 2 13 11 4573 5418 5208 +8887 2 2 13 11 4543 5518 6285 +8888 2 2 13 11 4474 6621 4956 +8889 2 2 13 11 3927 4801 5903 +8890 2 2 13 11 3836 5298 5651 +8891 2 2 13 11 3837 5652 5299 +8892 2 2 13 11 4999 5671 6448 +8893 2 2 13 11 4292 5214 5531 +8894 2 2 13 11 3998 4721 6209 +8895 2 2 13 11 3995 4712 6107 +8896 2 2 13 11 3899 5742 4705 +8897 2 2 13 11 4734 6948 5594 +8898 2 2 13 11 4036 5389 4984 +8899 2 2 13 11 4735 5595 6949 +8900 2 2 13 11 125 5695 4777 +8901 2 2 13 11 3680 4837 6009 +8902 2 2 13 11 3681 6010 4838 +8903 2 2 13 11 3920 4792 6557 +8904 2 2 13 11 4425 6248 5375 +8905 2 2 13 11 3841 6139 4708 +8906 2 2 13 11 3750 4824 6554 +8907 2 2 13 11 4392 6453 6752 +8908 2 2 13 11 4393 6753 6454 +8909 2 2 13 11 4298 4909 6079 +8910 2 2 13 11 4299 6080 4910 +8911 2 2 13 11 4146 4674 5488 +8912 2 2 13 11 4509 5843 4996 +8913 2 2 13 11 4431 4778 6327 +8914 2 2 13 11 4432 6328 4779 +8915 2 2 13 11 3727 5788 4642 +8916 2 2 13 11 6060 3924 4695 +8917 2 2 13 11 6061 4696 3925 +8918 2 2 13 11 158 159 5111 +8919 2 2 13 11 62 63 5112 +8920 2 2 13 11 4102 5516 4760 +8921 2 2 13 11 3729 6582 4688 +8922 2 2 13 11 4190 5889 4705 +8923 2 2 13 11 147 6381 4815 +8924 2 2 13 11 4398 5359 6353 +8925 2 2 13 11 4399 6354 5360 +8926 2 2 13 11 4146 6319 4674 +8927 2 2 13 11 4119 4860 5205 +8928 2 2 13 11 4212 5041 5348 +8929 2 2 13 11 3914 6489 5398 +8930 2 2 13 11 4120 5206 4861 +8931 2 2 13 11 4285 5108 5423 +8932 2 2 13 11 3753 6094 5778 +8933 2 2 13 11 4156 5475 5415 +8934 2 2 13 11 4157 5416 5476 +8935 2 2 13 11 3719 5532 4751 +8936 2 2 13 11 3720 4752 5533 +8937 2 2 13 11 3699 6378 6810 +8938 2 2 13 11 4130 4693 5895 +8939 2 2 13 11 4235 5273 4924 +8940 2 2 13 11 4382 5194 6587 +8941 2 2 13 11 3856 5245 6106 +8942 2 2 13 11 3649 5618 4725 +8943 2 2 13 11 3842 5524 4770 +8944 2 2 13 11 4535 6246 6692 +8945 2 2 13 11 3849 5426 6698 +8946 2 2 13 11 3772 5619 4705 +8947 2 2 13 11 3899 4719 5355 +8948 2 2 13 11 4092 4680 5921 +8949 2 2 13 11 6016 6676 3658 +8950 2 2 13 11 4151 5717 5261 +8951 2 2 13 11 3972 4836 6776 +8952 2 2 13 11 4367 6333 4761 +8953 2 2 13 11 5135 5831 6577 +8954 2 2 13 11 4124 5126 5148 +8955 2 2 13 11 3991 4653 6951 +8956 2 2 13 11 4086 4725 5618 +8957 2 2 13 11 4642 6816 6072 +8958 2 2 13 11 4426 6409 5395 +8959 2 2 13 11 5079 6742 5983 +8960 2 2 13 11 4269 5371 5163 +8961 2 2 13 11 5057 6738 6836 +8962 2 2 13 11 4078 5276 5088 +8963 2 2 13 11 3967 6842 4822 +8964 2 2 13 11 4651 5873 5058 +8965 2 2 13 11 3714 5341 6518 +8966 2 2 13 11 3715 6519 5342 +8967 2 2 13 11 4467 6827 5333 +8968 2 2 13 11 4468 5334 6828 +8969 2 2 13 11 4148 5597 4831 +8970 2 2 13 11 4020 6722 4909 +8971 2 2 13 11 4021 4910 6723 +8972 2 2 13 11 3976 6871 4747 +8973 2 2 13 11 3977 4748 6872 +8974 2 2 13 11 3750 6443 4964 +8975 2 2 13 11 3976 6074 4965 +8976 2 2 13 11 3977 4966 6075 +8977 2 2 13 11 4109 5003 5276 +8978 2 2 13 11 4172 5578 5502 +8979 2 2 13 11 4192 6063 5050 +8980 2 2 13 11 4249 6164 4709 +8981 2 2 13 11 4076 6841 4963 +8982 2 2 13 11 4097 4849 5188 +8983 2 2 13 11 4098 5189 4850 +8984 2 2 13 11 4138 4703 5588 +8985 2 2 13 11 4139 5589 4704 +8986 2 2 13 11 4384 6375 4959 +8987 2 2 13 11 3918 4908 6401 +8988 2 2 13 11 4767 5347 6873 +8989 2 2 13 11 4361 4922 5985 +8990 2 2 13 11 3792 4920 5188 +8991 2 2 13 11 3793 5189 4921 +8992 2 2 13 11 4065 4770 6696 +8993 2 2 13 11 3879 6377 6110 +8994 2 2 13 11 5039 6199 6262 +8995 2 2 13 11 4647 5639 4895 +8996 2 2 13 11 4648 4896 5640 +8997 2 2 13 11 3680 6035 4950 +8998 2 2 13 11 3681 4951 6036 +8999 2 2 13 11 4547 5150 6604 +9000 2 2 13 11 4372 6176 5406 +9001 2 2 13 11 4548 6606 5151 +9002 2 2 13 11 4065 5991 4770 +9003 2 2 13 11 4158 5059 5285 +9004 2 2 13 11 4645 5821 5553 +9005 2 2 13 11 162 6327 4778 +9006 2 2 13 11 59 4779 6328 +9007 2 2 13 11 4250 5265 5322 +9008 2 2 13 11 4108 4719 5797 +9009 2 2 13 11 4251 5323 5266 +9010 2 2 13 11 5061 6850 6763 +9011 2 2 13 11 3923 4878 5920 +9012 2 2 13 11 4127 4726 5944 +9013 2 2 13 11 4643 5658 5995 +9014 2 2 13 11 3654 5263 5322 +9015 2 2 13 11 3653 5323 5264 +9016 2 2 13 11 5059 6320 5837 +9017 2 2 13 11 4687 4888 6829 +9018 2 2 13 11 4146 5488 4958 +9019 2 2 13 11 4143 4961 5148 +9020 2 2 13 11 3743 4657 5999 +9021 2 2 13 11 3735 5765 5718 +9022 2 2 13 11 4084 4807 5610 +9023 2 2 13 11 4427 6220 5378 +9024 2 2 13 11 5092 5803 6379 +9025 2 2 13 11 4292 5231 5622 +9026 2 2 13 11 4317 5063 5502 +9027 2 2 13 11 3773 5503 4835 +9028 2 2 13 11 3794 5628 6393 +9029 2 2 13 11 3795 6394 5629 +9030 2 2 13 11 4093 4739 5901 +9031 2 2 13 11 3656 6449 4905 +9032 2 2 13 11 4215 5668 5930 +9033 2 2 13 11 4216 5931 5669 +9034 2 2 13 11 3733 6215 4745 +9035 2 2 13 11 4481 4962 6660 +9036 2 2 13 11 4232 6370 5263 +9037 2 2 13 11 4233 5264 6371 +9038 2 2 13 11 4605 5295 6156 +9039 2 2 13 11 4606 6157 5296 +9040 2 2 13 11 4454 6554 4824 +9041 2 2 13 11 4165 5611 6932 +9042 2 2 13 11 4945 5175 6042 +9043 2 2 13 11 4276 4805 5461 +9044 2 2 13 11 4277 5463 4806 +9045 2 2 13 11 4743 5288 6411 +9046 2 2 13 11 3812 5295 5400 +9047 2 2 13 11 3813 5401 5296 +9048 2 2 13 11 3987 4759 6782 +9049 2 2 13 11 5201 6558 5731 +9050 2 2 13 11 4127 5543 4726 +9051 2 2 13 11 4297 5920 4878 +9052 2 2 13 11 3907 4682 5921 +9053 2 2 13 11 3788 4865 5421 +9054 2 2 13 11 3676 4686 5521 +9055 2 2 13 11 4406 5324 5935 +9056 2 2 13 11 4491 4845 6890 +9057 2 2 13 11 104 4652 5980 +9058 2 2 13 11 3782 5276 5003 +9059 2 2 13 11 4388 5079 5393 +9060 2 2 13 11 4029 5285 5059 +9061 2 2 13 11 6348 4652 104 +9062 2 2 13 11 3929 4736 5891 +9063 2 2 13 11 4391 5765 6067 +9064 2 2 13 11 3759 4670 6412 +9065 2 2 13 11 3785 5162 5083 +9066 2 2 13 11 94 4710 6853 +9067 2 2 13 11 3791 5187 5052 +9068 2 2 13 11 4298 5400 5295 +9069 2 2 13 11 4299 5296 5401 +9070 2 2 13 11 4348 5247 5704 +9071 2 2 13 11 4407 6255 5102 +9072 2 2 13 11 4408 5103 6256 +9073 2 2 13 11 3756 4851 5482 +9074 2 2 13 11 4057 5974 5413 +9075 2 2 13 11 4364 5534 5601 +9076 2 2 13 11 4365 5602 5535 +9077 2 2 13 11 4348 5704 5576 +9078 2 2 13 11 3670 4854 5259 +9079 2 2 13 11 4217 5024 5311 +9080 2 2 13 11 4132 5052 5284 +9081 2 2 13 11 4398 5756 5359 +9082 2 2 13 11 4399 5360 5757 +9083 2 2 13 11 4431 6924 4778 +9084 2 2 13 11 4432 4779 6925 +9085 2 2 13 11 4189 4891 5779 +9086 2 2 13 11 4140 5470 4724 +9087 2 2 13 11 3743 5749 4657 +9088 2 2 13 11 4276 6009 4837 +9089 2 2 13 11 4277 4838 6010 +9090 2 2 13 11 4492 4907 6141 +9091 2 2 13 11 3937 6296 4698 +9092 2 2 13 11 3785 5083 5085 +9093 2 2 13 11 4695 3924 5930 +9094 2 2 13 11 4696 5931 3925 +9095 2 2 13 11 4530 5034 6558 +9096 2 2 13 11 3913 4716 6282 +9097 2 2 13 11 3806 6756 4841 +9098 2 2 13 11 3651 4831 5597 +9099 2 2 13 11 3812 4965 6156 +9100 2 2 13 11 3813 6157 4966 +9101 2 2 13 11 4196 5748 6362 +9102 2 2 13 11 3679 4707 6196 +9103 2 2 13 11 4329 5729 5120 +9104 2 2 13 11 4332 5790 6451 +9105 2 2 13 11 3832 4929 5447 +9106 2 2 13 11 4133 5542 4901 +9107 2 2 13 11 4718 5659 6616 +9108 2 2 13 11 4721 5559 6209 +9109 2 2 13 11 4449 6717 4905 +9110 2 2 13 11 4127 6348 5543 +9111 2 2 13 11 4499 5315 5960 +9112 2 2 13 11 4415 5332 5728 +9113 2 2 13 11 4036 6066 4690 +9114 2 2 13 11 4022 6278 5330 +9115 2 2 13 11 3678 4916 6882 +9116 2 2 13 11 3985 5089 6629 +9117 2 2 13 11 5050 6063 5575 +9118 2 2 13 11 3777 6558 5034 +9119 2 2 13 11 4756 6118 5636 +9120 2 2 13 11 3702 5797 4719 +9121 2 2 13 11 4353 4978 5415 +9122 2 2 13 11 4354 5416 4979 +9123 2 2 13 11 3882 5709 4766 +9124 2 2 13 11 4191 4689 6431 +9125 2 2 13 11 3694 4682 5904 +9126 2 2 13 11 4073 4929 5496 +9127 2 2 13 11 4359 4793 5340 +9128 2 2 13 11 4171 4705 5742 +9129 2 2 13 11 4086 5154 5187 +9130 2 2 13 11 4150 6788 4724 +9131 2 2 13 11 4106 5331 6047 +9132 2 2 13 11 4379 6065 4776 +9133 2 2 13 11 4514 6837 5134 +9134 2 2 13 11 4330 5314 5544 +9135 2 2 13 11 4134 5421 4865 +9136 2 2 13 11 4193 5146 6344 +9137 2 2 13 11 4048 6035 5317 +9138 2 2 13 11 4049 5318 6036 +9139 2 2 13 11 4189 6128 4891 +9140 2 2 13 11 3922 4687 6801 +9141 2 2 13 11 3992 5271 4872 +9142 2 2 13 11 161 4778 5583 +9143 2 2 13 11 60 5584 4779 +9144 2 2 13 11 3848 5014 5351 +9145 2 2 13 11 4744 5883 6177 +9146 2 2 13 11 88 89 5167 +9147 2 2 13 11 4249 4709 5785 +9148 2 2 13 11 4202 5667 4743 +9149 2 2 13 11 76 5883 4744 +9150 2 2 13 11 3911 5461 4805 +9151 2 2 13 11 4612 5984 6015 +9152 2 2 13 11 3912 4806 5463 +9153 2 2 13 11 3906 4666 6490 +9154 2 2 13 11 3678 4822 6746 +9155 2 2 13 11 4166 5630 4734 +9156 2 2 13 11 4167 4735 5631 +9157 2 2 13 11 330 5686 4972 +9158 2 2 13 11 246 4973 5687 +9159 2 2 13 11 3773 5855 5080 +9160 2 2 13 11 4524 5057 6836 +9161 2 2 13 11 3796 5454 5081 +9162 2 2 13 11 4731 5686 6481 +9163 2 2 13 11 4732 6482 5687 +9164 2 2 13 11 3897 6642 5417 +9165 2 2 13 11 4227 5346 4906 +9166 2 2 13 11 3898 5418 6643 +9167 2 2 13 11 4837 5333 6827 +9168 2 2 13 11 4838 6828 5334 +9169 2 2 13 11 128 6024 5468 +9170 2 2 13 11 3707 5945 5312 +9171 2 2 13 11 3886 6187 5754 +9172 2 2 13 11 3887 5755 6188 +9173 2 2 13 11 4170 5544 5314 +9174 2 2 13 11 3836 5102 6478 +9175 2 2 13 11 3837 6479 5103 +9176 2 2 13 11 5102 6878 6478 +9177 2 2 13 11 4111 4815 6381 +9178 2 2 13 11 5103 6479 6879 +9179 2 2 13 11 4164 5732 4968 +9180 2 2 13 11 4118 5394 4811 +9181 2 2 13 11 5227 6117 5802 +9182 2 2 13 11 4989 5540 6813 +9183 2 2 13 11 3821 5340 4947 +9184 2 2 13 11 3907 5921 4680 +9185 2 2 13 11 4089 6900 5356 +9186 2 2 13 11 4100 5890 4717 +9187 2 2 13 11 4529 6850 5061 +9188 2 2 13 11 141 142 5146 +9189 2 2 13 11 293 5043 294 +9190 2 2 13 11 4097 5188 4920 +9191 2 2 13 11 4098 4921 5189 +9192 2 2 13 11 4436 6684 5946 +9193 2 2 13 11 3680 4950 5333 +9194 2 2 13 11 3825 6502 5196 +9195 2 2 13 11 3681 5334 4951 +9196 2 2 13 11 4140 5277 5090 +9197 2 2 13 11 4395 6024 6171 +9198 2 2 13 11 4580 6745 5255 +9199 2 2 13 11 4309 5883 5143 +9200 2 2 13 11 3779 4671 6893 +9201 2 2 13 11 3686 5209 5502 +9202 2 2 13 11 4065 6696 4853 +9203 2 2 13 11 4161 4842 5583 +9204 2 2 13 11 4162 5584 4843 +9205 2 2 13 11 3760 6432 5065 +9206 2 2 13 11 3818 5118 5444 +9207 2 2 13 11 4364 6948 4734 +9208 2 2 13 11 4365 4735 6949 +9209 2 2 13 11 4161 5583 4778 +9210 2 2 13 11 4162 4779 5584 +9211 2 2 13 11 4745 5802 5022 +9212 2 2 13 11 4135 4751 5532 +9213 2 2 13 11 4201 5234 6680 +9214 2 2 13 11 4136 5533 4752 +9215 2 2 13 11 4232 5970 6370 +9216 2 2 13 11 6813 5540 4446 +9217 2 2 13 11 4233 6371 5971 +9218 2 2 13 11 4651 5195 6181 +9219 2 2 13 11 291 5620 4793 +9220 2 2 13 11 3764 4864 5278 +9221 2 2 13 11 4142 6190 5606 +9222 2 2 13 11 279 5048 280 +9223 2 2 13 11 4370 5307 6112 +9224 2 2 13 11 4273 6051 5221 +9225 2 2 13 11 3783 5163 5371 +9226 2 2 13 11 4654 6362 5748 +9227 2 2 13 11 4143 5148 5126 +9228 2 2 13 11 335 5055 336 +9229 2 2 13 11 240 5056 241 +9230 2 2 13 11 3810 4737 6033 +9231 2 2 13 11 4103 6209 5559 +9232 2 2 13 11 3783 5371 6881 +9233 2 2 13 11 4307 4972 5457 +9234 2 2 13 11 4308 5458 4973 +9235 2 2 13 11 3825 5610 6502 +9236 2 2 13 11 4201 6680 5903 +9237 2 2 13 11 3680 6298 6035 +9238 2 2 13 11 3681 6036 6299 +9239 2 2 13 11 4015 5199 4917 +9240 2 2 13 11 4043 5739 4799 +9241 2 2 13 11 4304 6048 6274 +9242 2 2 13 11 4016 4918 5200 +9243 2 2 13 11 4338 5467 5180 +9244 2 2 13 11 4014 6739 5287 +9245 2 2 13 11 277 5626 4797 +9246 2 2 13 11 4107 6794 5043 +9247 2 2 13 11 4250 5758 5692 +9248 2 2 13 11 4522 5417 6100 +9249 2 2 13 11 3753 4768 6851 +9250 2 2 13 11 4251 5694 5759 +9251 2 2 13 11 4523 6102 5418 +9252 2 2 13 11 4454 4824 6776 +9253 2 2 13 11 3803 6169 4780 +9254 2 2 13 11 4280 5359 5411 +9255 2 2 13 11 4281 5412 5360 +9256 2 2 13 11 144 145 5455 +9257 2 2 13 11 3730 5450 5603 +9258 2 2 13 11 4193 6344 5766 +9259 2 2 13 11 4575 5715 6571 +9260 2 2 13 11 3941 5647 5366 +9261 2 2 13 11 3942 5367 5648 +9262 2 2 13 11 4004 4916 5273 +9263 2 2 13 11 4027 6560 4758 +9264 2 2 13 11 148 149 5268 +9265 2 2 13 11 4198 6641 5695 +9266 2 2 13 11 3986 6573 5060 +9267 2 2 13 11 3723 5871 4787 +9268 2 2 13 11 4292 5531 5231 +9269 2 2 13 11 3842 4770 5991 +9270 2 2 13 11 4280 5411 6156 +9271 2 2 13 11 4281 6157 5412 +9272 2 2 13 11 4030 5090 5277 +9273 2 2 13 11 3892 5832 6534 +9274 2 2 13 11 3893 6535 5833 +9275 2 2 13 11 4111 4774 6222 +9276 2 2 13 11 4703 4731 6091 +9277 2 2 13 11 4704 6092 4732 +9278 2 2 13 11 4090 6107 4712 +9279 2 2 13 11 4063 6100 5417 +9280 2 2 13 11 4064 5418 6102 +9281 2 2 13 11 4250 5322 5263 +9282 2 2 13 11 4251 5264 5323 +9283 2 2 13 11 4185 4692 5963 +9284 2 2 13 11 4137 5393 5079 +9285 2 2 13 11 4579 5139 6728 +9286 2 2 13 11 4667 5754 6187 +9287 2 2 13 11 4668 6188 5755 +9288 2 2 13 11 307 4830 5622 +9289 2 2 13 11 4169 5231 5531 +9290 2 2 13 11 3650 4899 5229 +9291 2 2 13 11 4637 6555 6323 +9292 2 2 13 11 4458 6640 6724 +9293 2 2 13 11 4378 4683 5972 +9294 2 2 13 11 3770 5042 5357 +9295 2 2 13 11 160 5583 4842 +9296 2 2 13 11 61 4843 5584 +9297 2 2 13 11 164 4909 5369 +9298 2 2 13 11 57 5370 4910 +9299 2 2 13 11 3907 5908 4682 +9300 2 2 13 11 4374 5628 5634 +9301 2 2 13 11 4375 5635 5629 +9302 2 2 13 11 4010 4958 5488 +9303 2 2 13 11 4108 5797 4681 +9304 2 2 13 11 5611 6735 3784 +9305 2 2 13 11 3699 6810 5289 +9306 2 2 13 11 4623 5359 6074 +9307 2 2 13 11 4624 6075 5360 +9308 2 2 13 11 4029 4942 5285 +9309 2 2 13 11 4661 5876 6337 +9310 2 2 13 11 3967 5819 4768 +9311 2 2 13 11 6178 6792 3703 +9312 2 2 13 11 3780 5480 4863 +9313 2 2 13 11 6179 3704 6793 +9314 2 2 13 11 4212 6349 5845 +9315 2 2 13 11 3755 5817 4715 +9316 2 2 13 11 4172 5752 4711 +9317 2 2 13 11 4621 5004 5854 +9318 2 2 13 11 4385 5317 5585 +9319 2 2 13 11 4386 5586 5318 +9320 2 2 13 11 106 6542 4726 +9321 2 2 13 11 4086 5454 5154 +9322 2 2 13 11 4529 5892 5023 +9323 2 2 13 11 4485 5644 5552 +9324 2 2 13 11 4004 6511 4916 +9325 2 2 13 11 4777 5695 6641 +9326 2 2 13 11 4081 4917 5199 +9327 2 2 13 11 4082 5200 4918 +9328 2 2 13 11 3936 4787 5582 +9329 2 2 13 11 3714 4722 5862 +9330 2 2 13 11 3715 5863 4723 +9331 2 2 13 11 4008 5926 5166 +9332 2 2 13 11 3665 5721 4958 +9333 2 2 13 11 3701 4762 5563 +9334 2 2 13 11 3906 4803 5523 +9335 2 2 13 11 3937 4729 6145 +9336 2 2 13 11 3722 5552 5644 +9337 2 2 13 11 4428 6213 6715 +9338 2 2 13 11 4960 6682 6727 +9339 2 2 13 11 4083 4787 6021 +9340 2 2 13 11 4625 5413 5974 +9341 2 2 13 11 3974 6072 6816 +9342 2 2 13 11 4832 6286 5149 +9343 2 2 13 11 3984 4894 5319 +9344 2 2 13 11 4098 4946 5279 +9345 2 2 13 11 4150 4724 6711 +9346 2 2 13 11 4725 6284 5001 +9347 2 2 13 11 3874 6272 5238 +9348 2 2 13 11 3876 5239 6273 +9349 2 2 13 11 3742 5549 4798 +9350 2 2 13 11 5221 6051 6232 +9351 2 2 13 11 4191 6047 4689 +9352 2 2 13 11 4496 5004 6782 +9353 2 2 13 11 4407 4911 6520 +9354 2 2 13 11 4408 6521 4912 +9355 2 2 13 11 4006 6222 4774 +9356 2 2 13 11 4231 4942 5197 +9357 2 2 13 11 4658 5254 6841 +9358 2 2 13 11 4441 6272 4784 +9359 2 2 13 11 4442 4785 6273 +9360 2 2 13 11 4094 6941 4851 +9361 2 2 13 11 69 5708 4850 +9362 2 2 13 11 4404 6703 5843 +9363 2 2 13 11 4199 5858 4694 +9364 2 2 13 11 4427 6682 4960 +9365 2 2 13 11 3921 6344 4738 +9366 2 2 13 11 3742 5854 5004 +9367 2 2 13 11 4909 6722 5369 +9368 2 2 13 11 4910 5370 6723 +9369 2 2 13 11 4605 6156 5411 +9370 2 2 13 11 4606 5412 6157 +9371 2 2 13 11 3677 4758 6267 +9372 2 2 13 11 4025 4768 5778 +9373 2 2 13 11 4615 5988 5978 +9374 2 2 13 11 4415 5728 6464 +9375 2 2 13 11 3865 4952 6232 +9376 2 2 13 11 4280 6074 5359 +9377 2 2 13 11 4720 6171 5380 +9378 2 2 13 11 4281 5360 6075 +9379 2 2 13 11 5261 5717 6361 +9380 2 2 13 11 4400 4908 6406 +9381 2 2 13 11 4470 5303 6135 +9382 2 2 13 11 4198 5891 4736 +9383 2 2 13 11 4536 5739 5928 +9384 2 2 13 11 3664 6597 4848 +9385 2 2 13 11 3719 5415 4978 +9386 2 2 13 11 3720 4979 5416 +9387 2 2 13 11 4035 6700 4858 +9388 2 2 13 11 4435 4848 6597 +9389 2 2 13 11 3733 4774 5714 +9390 2 2 13 11 3694 5779 4891 +9391 2 2 13 11 4103 5466 4940 +9392 2 2 13 11 313 5097 314 +9393 2 2 13 11 262 5098 263 +9394 2 2 13 11 166 167 5077 +9395 2 2 13 11 54 55 5078 +9396 2 2 13 11 3970 5655 4780 +9397 2 2 13 11 4128 5852 4771 +9398 2 2 13 11 4129 4772 5853 +9399 2 2 13 11 4344 5958 5084 +9400 2 2 13 11 3783 6881 5703 +9401 2 2 13 11 306 6014 4830 +9402 2 2 13 11 4487 4913 6777 +9403 2 2 13 11 3881 6461 5152 +9404 2 2 13 11 4520 5312 5945 +9405 2 2 13 11 321 5363 6056 +9406 2 2 13 11 255 6057 5364 +9407 2 2 13 11 3911 4771 5852 +9408 2 2 13 11 3912 5853 4772 +9409 2 2 13 11 3727 4804 5508 +9410 2 2 13 11 4044 5235 5006 +9411 2 2 13 11 4199 4694 5744 +9412 2 2 13 11 4045 5007 5236 +9413 2 2 13 11 4718 4988 5786 +9414 2 2 13 11 3926 6126 4739 +9415 2 2 13 11 3840 5659 4718 +9416 2 2 13 11 4209 4903 5275 +9417 2 2 13 11 3676 5485 5050 +9418 2 2 13 11 4099 5508 4804 +9419 2 2 13 11 3816 5475 6353 +9420 2 2 13 11 3817 6354 5476 +9421 2 2 13 11 3920 4717 5890 +9422 2 2 13 11 3866 5084 5958 +9423 2 2 13 11 4007 4761 5592 +9424 2 2 13 11 3954 6836 6738 +9425 2 2 13 11 5121 6143 6308 +9426 2 2 13 11 4321 5564 5688 +9427 2 2 13 11 3695 5359 5756 +9428 2 2 13 11 3900 6015 5984 +9429 2 2 13 11 3696 5757 5360 +9430 2 2 13 11 4150 5187 5154 +9431 2 2 13 11 3948 6484 4746 +9432 2 2 13 11 4478 6746 4822 +9433 2 2 13 11 3932 6466 4789 +9434 2 2 13 11 3901 5572 4754 +9435 2 2 13 11 3659 5185 5005 +9436 2 2 13 11 4161 4778 5897 +9437 2 2 13 11 4162 5898 4779 +9438 2 2 13 11 4097 5304 4982 +9439 2 2 13 11 4074 4880 5469 +9440 2 2 13 11 4433 5366 5647 +9441 2 2 13 11 4384 5279 4946 +9442 2 2 13 11 4434 5648 5367 +9443 2 2 13 11 4150 5052 5187 +9444 2 2 13 11 4027 5241 5745 +9445 2 2 13 11 4276 6358 4805 +9446 2 2 13 11 4627 5975 5554 +9447 2 2 13 11 4053 6286 5915 +9448 2 2 13 11 4628 5555 5976 +9449 2 2 13 11 4277 4806 6359 +9450 2 2 13 11 4237 5864 5055 +9451 2 2 13 11 4238 5056 5865 +9452 2 2 13 11 4156 4751 5955 +9453 2 2 13 11 4157 5956 4752 +9454 2 2 13 11 4569 6052 5563 +9455 2 2 13 11 3691 4901 5542 +9456 2 2 13 11 4213 6332 6175 +9457 2 2 13 11 4260 5563 6052 +9458 2 2 13 11 6833 4125 5483 +9459 2 2 13 11 4811 5287 6739 +9460 2 2 13 11 4594 5330 6278 +9461 2 2 13 11 4184 4766 5709 +9462 2 2 13 11 4073 6639 4824 +9463 2 2 13 11 150 4982 6350 +9464 2 2 13 11 4141 6185 5770 +9465 2 2 13 11 3927 5903 4714 +9466 2 2 13 11 4586 5152 6461 +9467 2 2 13 11 3784 6735 5325 +9468 2 2 13 11 4260 4740 6082 +9469 2 2 13 11 323 4897 5404 +9470 2 2 13 11 253 5405 4898 +9471 2 2 13 11 3662 6786 5719 +9472 2 2 13 11 3663 5720 6787 +9473 2 2 13 11 4460 5218 6184 +9474 2 2 13 11 3664 4848 5448 +9475 2 2 13 11 4054 5407 6242 +9476 2 2 13 11 6670 6260 3947 +9477 2 2 13 11 4184 5973 4766 +9478 2 2 13 11 3972 6776 4824 +9479 2 2 13 11 3797 5035 6114 +9480 2 2 13 11 3798 6115 5036 +9481 2 2 13 11 4627 6096 5975 +9482 2 2 13 11 4628 5976 6097 +9483 2 2 13 11 274 5156 5559 +9484 2 2 13 11 3771 5538 4802 +9485 2 2 13 11 4497 6779 4796 +9486 2 2 13 11 4113 4816 5681 +9487 2 2 13 11 4169 5700 5231 +9488 2 2 13 11 4125 5310 5048 +9489 2 2 13 11 3987 5065 6259 +9490 2 2 13 11 3735 5718 4931 +9491 2 2 13 11 4293 4863 5480 +9492 2 2 13 11 4200 6122 5091 +9493 2 2 13 11 4781 5922 5706 +9494 2 2 13 11 4192 5050 5485 +9495 2 2 13 11 4222 5335 5190 +9496 2 2 13 11 5109 5964 6734 +9497 2 2 13 11 3752 5244 4913 +9498 2 2 13 11 4015 4917 6372 +9499 2 2 13 11 4092 4891 5358 +9500 2 2 13 11 3754 5469 4880 +9501 2 2 13 11 4016 6373 4918 +9502 2 2 13 11 3700 4906 5346 +9503 2 2 13 11 4519 4798 6783 +9504 2 2 13 11 3728 5451 6450 +9505 2 2 13 11 4228 5229 4983 +9506 2 2 13 11 3677 5255 6745 +9507 2 2 13 11 4574 6683 5665 +9508 2 2 13 11 4903 6790 6027 +9509 2 2 13 11 4729 5892 3709 +9510 2 2 13 11 4152 5512 5726 +9511 2 2 13 11 85 6538 5288 +9512 2 2 13 11 4227 4906 5987 +9513 2 2 13 11 4107 5419 6881 +9514 2 2 13 11 3948 5702 5579 +9515 2 2 13 11 3695 5411 5359 +9516 2 2 13 11 4123 5706 5922 +9517 2 2 13 11 3696 5360 5412 +9518 2 2 13 11 3717 6228 6201 +9519 2 2 13 11 3957 6763 6850 +9520 2 2 13 11 4357 6455 5067 +9521 2 2 13 11 3697 4746 6901 +9522 2 2 13 11 297 5286 4949 +9523 2 2 13 11 4095 5265 5431 +9524 2 2 13 11 4096 5432 5266 +9525 2 2 13 11 103 5980 6340 +9526 2 2 13 11 4198 4730 5891 +9527 2 2 13 11 4631 5523 6336 +9528 2 2 13 11 4403 4985 6690 +9529 2 2 13 11 73 5386 4959 +9530 2 2 13 11 4316 6008 5568 +9531 2 2 13 11 4097 5777 4849 +9532 2 2 13 11 3769 4791 5428 +9533 2 2 13 11 3770 5429 4792 +9534 2 2 13 11 3882 4823 6405 +9535 2 2 13 11 4907 6260 6670 +9536 2 2 13 11 4600 5568 6008 +9537 2 2 13 11 4101 5599 4889 +9538 2 2 13 11 4558 6946 5941 +9539 2 2 13 11 4070 6303 5129 +9540 2 2 13 11 4118 4811 6739 +9541 2 2 13 11 4071 5130 6304 +9542 2 2 13 11 3651 4981 5882 +9543 2 2 13 11 3678 6376 4822 +9544 2 2 13 11 4022 5330 4985 +9545 2 2 13 11 3756 5482 4795 +9546 2 2 13 11 78 5373 5143 +9547 2 2 13 11 4102 4807 6136 +9548 2 2 13 11 3911 6070 4771 +9549 2 2 13 11 156 157 5486 +9550 2 2 13 11 64 65 5487 +9551 2 2 13 11 3912 4772 6071 +9552 2 2 13 11 4232 5210 5536 +9553 2 2 13 11 4233 5537 5211 +9554 2 2 13 11 4234 4781 6089 +9555 2 2 13 11 4083 6483 4865 +9556 2 2 13 11 4380 6232 4952 +9557 2 2 13 11 3724 6337 5876 +9558 2 2 13 11 4182 4745 6215 +9559 2 2 13 11 4330 5544 5124 +9560 2 2 13 11 4179 6420 4782 +9561 2 2 13 11 3902 5684 4722 +9562 2 2 13 11 3903 4723 5685 +9563 2 2 13 11 3677 6745 5241 +9564 2 2 13 11 4568 5845 6349 +9565 2 2 13 11 4081 6194 4917 +9566 2 2 13 11 4082 4918 6195 +9567 2 2 13 11 6792 5141 3703 +9568 2 2 13 11 6793 3704 5142 +9569 2 2 13 11 4231 4780 6169 +9570 2 2 13 11 4236 5928 4995 +9571 2 2 13 11 3666 6520 4911 +9572 2 2 13 11 3667 4912 6521 +9573 2 2 13 11 4026 5924 4775 +9574 2 2 13 11 3731 5489 4860 +9575 2 2 13 11 115 4811 5394 +9576 2 2 13 11 3891 6184 5218 +9577 2 2 13 11 4197 4900 5305 +9578 2 2 13 11 3732 4861 5490 +9579 2 2 13 11 4911 6288 5207 +9580 2 2 13 11 4912 5208 6289 +9581 2 2 13 11 3985 6629 4880 +9582 2 2 13 11 4581 5778 6094 +9583 2 2 13 11 152 4849 5777 +9584 2 2 13 11 6688 4501 5587 +9585 2 2 13 11 4050 5333 4950 +9586 2 2 13 11 4051 4951 5334 +9587 2 2 13 11 4895 6210 5930 +9588 2 2 13 11 4896 5931 6211 +9589 2 2 13 11 4302 6109 5376 +9590 2 2 13 11 4326 6405 4823 +9591 2 2 13 11 4303 5377 6111 +9592 2 2 13 11 3840 4718 5786 +9593 2 2 13 11 4234 6206 4781 +9594 2 2 13 11 3860 4940 5466 +9595 2 2 13 11 4085 5016 5374 +9596 2 2 13 11 4445 5196 6363 +9597 2 2 13 11 320 5363 321 +9598 2 2 13 11 255 5364 256 +9599 2 2 13 11 4141 5770 5192 +9600 2 2 13 11 4357 5067 5799 +9601 2 2 13 11 4095 6944 5322 +9602 2 2 13 11 4096 5323 6945 +9603 2 2 13 11 6842 4478 4822 +9604 2 2 13 11 4874 5173 6030 +9605 2 2 13 11 4875 6031 5174 +9606 2 2 13 11 4500 5851 5254 +9607 2 2 13 11 3830 5585 5317 +9608 2 2 13 11 3768 6693 4808 +9609 2 2 13 11 3831 5318 5586 +9610 2 2 13 11 3920 6456 4717 +9611 2 2 13 11 4282 6576 4826 +9612 2 2 13 11 4107 5116 6794 +9613 2 2 13 11 3833 5368 5808 +9614 2 2 13 11 3999 5675 4817 +9615 2 2 13 11 4829 6688 5587 +9616 2 2 13 11 4505 6268 6166 +9617 2 2 13 11 4000 4818 5676 +9618 2 2 13 11 3938 4744 6177 +9619 2 2 13 11 3907 4859 5908 +9620 2 2 13 11 3674 5895 5798 +9621 2 2 13 11 4204 5554 5975 +9622 2 2 13 11 4205 5976 5555 +9623 2 2 13 11 3751 6089 4781 +9624 2 2 13 11 3899 5889 4719 +9625 2 2 13 11 4588 6242 5407 +9626 2 2 13 11 3851 6650 5240 +9627 2 2 13 11 3981 6571 5715 +9628 2 2 13 11 4561 5038 5771 +9629 2 2 13 11 3846 5395 5838 +9630 2 2 13 11 85 86 6538 +9631 2 2 13 11 4153 6673 5372 +9632 2 2 13 11 3769 5812 5029 +9633 2 2 13 11 4046 6811 6614 +9634 2 2 13 11 4047 6615 6812 +9635 2 2 13 11 4346 5069 5242 +9636 2 2 13 11 3853 5379 5733 +9637 2 2 13 11 3746 6300 4926 +9638 2 2 13 11 3747 4927 6301 +9639 2 2 13 11 4717 6450 5451 +9640 2 2 13 11 3749 4801 5501 +9641 2 2 13 11 3768 4808 5656 +9642 2 2 13 11 4098 4850 5708 +9643 2 2 13 11 3905 5844 5120 +9644 2 2 13 11 3872 4826 5600 +9645 2 2 13 11 94 95 5383 +9646 2 2 13 11 3905 5978 5988 +9647 2 2 13 11 4351 5424 5113 +9648 2 2 13 11 4052 5935 5324 +9649 2 2 13 11 4352 5114 5425 +9650 2 2 13 11 3888 6116 6039 +9651 2 2 13 11 3966 5925 4808 +9652 2 2 13 11 5475 6476 6353 +9653 2 2 13 11 5476 6354 6477 +9654 2 2 13 11 4111 6222 4815 +9655 2 2 13 11 4346 5109 6734 +9656 2 2 13 11 3799 5292 5493 +9657 2 2 13 11 4099 4819 5869 +9658 2 2 13 11 4177 5365 6295 +9659 2 2 13 11 4100 5870 4820 +9660 2 2 13 11 4872 5705 6472 +9661 2 2 13 11 4194 5805 5937 +9662 2 2 13 11 4570 5241 6745 +9663 2 2 13 11 4532 6765 5859 +9664 2 2 13 11 3976 4965 6871 +9665 2 2 13 11 3977 6872 4966 +9666 2 2 13 11 3971 5393 4977 +9667 2 2 13 11 3802 6841 5254 +9668 2 2 13 11 4063 6288 5313 +9669 2 2 13 11 4064 5316 6289 +9670 2 2 13 11 4773 4994 6543 +9671 2 2 13 11 4055 4926 5352 +9672 2 2 13 11 4056 5353 4927 +9673 2 2 13 11 4997 5541 6936 +9674 2 2 13 11 4967 6833 5483 +9675 2 2 13 11 4131 4767 5715 +9676 2 2 13 11 4020 6770 5295 +9677 2 2 13 11 4021 5296 6771 +9678 2 2 13 11 4070 4938 5509 +9679 2 2 13 11 4071 5510 4939 +9680 2 2 13 11 4061 4892 5754 +9681 2 2 13 11 4062 5755 4893 +9682 2 2 13 11 3662 4809 6368 +9683 2 2 13 11 3663 6369 4810 +9684 2 2 13 11 4293 6308 6143 +9685 2 2 13 11 3771 4802 6952 +9686 2 2 13 11 3910 5506 5243 +9687 2 2 13 11 4589 5733 5379 +9688 2 2 13 11 6400 4729 3709 +9689 2 2 13 11 4185 4954 5361 +9690 2 2 13 11 4285 5493 5292 +9691 2 2 13 11 3794 6393 5431 +9692 2 2 13 11 3795 5432 6394 +9693 2 2 13 11 3981 5715 4767 +9694 2 2 13 11 3751 4781 5706 +9695 2 2 13 11 4253 6296 5140 +9696 2 2 13 11 3983 6561 6248 +9697 2 2 13 11 4008 6806 5926 +9698 2 2 13 11 99 100 6166 +9699 2 2 13 11 4214 6676 4867 +9700 2 2 13 11 4186 6896 4775 +9701 2 2 13 11 4380 5726 5512 +9702 2 2 13 11 4501 6629 5089 +9703 2 2 13 11 3767 4852 5915 +9704 2 2 13 11 4037 5645 6617 +9705 2 2 13 11 4038 6618 5646 +9706 2 2 13 11 4150 5284 5052 +9707 2 2 13 11 3678 4754 6376 +9708 2 2 13 11 4215 4849 6664 +9709 2 2 13 11 4216 6665 4850 +9710 2 2 13 11 4009 6607 5095 +9711 2 2 13 11 4094 4937 6941 +9712 2 2 13 11 3881 5681 4816 +9713 2 2 13 11 3913 6041 4716 +9714 2 2 13 11 4282 4789 6768 +9715 2 2 13 11 3742 6536 4840 +9716 2 2 13 11 4302 5109 5489 +9717 2 2 13 11 4303 5490 5110 +9718 2 2 13 11 4249 6728 5139 +9719 2 2 13 11 4665 5184 5768 +9720 2 2 13 11 274 5559 275 +9721 2 2 13 11 4340 4911 5651 +9722 2 2 13 11 4447 5808 5368 +9723 2 2 13 11 3727 6262 4804 +9724 2 2 13 11 4341 5652 4912 +9725 2 2 13 11 4686 5937 5805 +9726 2 2 13 11 3799 5396 6833 +9727 2 2 13 11 4329 5120 5844 +9728 2 2 13 11 4919 6881 5419 +9729 2 2 13 11 4332 6451 5481 +9730 2 2 13 11 3899 4769 5742 +9731 2 2 13 11 3947 6260 4862 +9732 2 2 13 11 3953 5987 4906 +9733 2 2 13 11 3725 5247 6280 +9734 2 2 13 11 5249 6844 6145 +9735 2 2 13 11 4074 5321 4928 +9736 2 2 13 11 4297 6401 4908 +9737 2 2 13 11 3938 6177 4864 +9738 2 2 13 11 4455 6278 5386 +9739 2 2 13 11 4099 5857 4819 +9740 2 2 13 11 147 148 6381 +9741 2 2 13 11 4524 6836 4833 +9742 2 2 13 11 4193 5217 5402 +9743 2 2 13 11 4059 6165 4798 +9744 2 2 13 11 4518 5372 6537 +9745 2 2 13 11 4612 6015 4943 +9746 2 2 13 11 4473 4877 6764 +9747 2 2 13 11 4100 4820 5890 +9748 2 2 13 11 3789 5712 4813 +9749 2 2 13 11 3790 4814 5713 +9750 2 2 13 11 3821 4919 5419 +9751 2 2 13 11 4963 5644 6436 +9752 2 2 13 11 4501 6688 6629 +9753 2 2 13 11 4497 5632 6951 +9754 2 2 13 11 3654 5045 5210 +9755 2 2 13 11 3679 4769 6069 +9756 2 2 13 11 145 6324 5455 +9757 2 2 13 11 3653 5211 5046 +9758 2 2 13 11 3936 6021 4787 +9759 2 2 13 11 4215 6210 5188 +9760 2 2 13 11 4216 5189 6211 +9761 2 2 13 11 4126 4925 5390 +9762 2 2 13 11 4105 5093 5272 +9763 2 2 13 11 322 6056 4897 +9764 2 2 13 11 254 4898 6057 +9765 2 2 13 11 4041 5251 4990 +9766 2 2 13 11 4042 4991 5252 +9767 2 2 13 11 3782 5088 5276 +9768 2 2 13 11 3756 5462 4851 +9769 2 2 13 11 4884 5452 6236 +9770 2 2 13 11 4885 6237 5453 +9771 2 2 13 11 3806 5689 5155 +9772 2 2 13 11 4391 5718 5765 +9773 2 2 13 11 3824 4821 6285 +9774 2 2 13 11 4075 6894 4988 +9775 2 2 13 11 3983 6710 4886 +9776 2 2 13 11 4179 4782 6705 +9777 2 2 13 11 4203 5908 4859 +9778 2 2 13 11 3962 6264 4971 +9779 2 2 13 11 4309 6177 5883 +9780 2 2 13 11 3841 5516 6139 +9781 2 2 13 11 4259 5030 5402 +9782 2 2 13 11 4101 4948 5599 +9783 2 2 13 11 4632 6198 5117 +9784 2 2 13 11 4282 5680 4789 +9785 2 2 13 11 4644 6820 6221 +9786 2 2 13 11 4784 5690 6678 +9787 2 2 13 11 4785 6679 5691 +9788 2 2 13 11 4215 5930 6210 +9789 2 2 13 11 4216 6211 5931 +9790 2 2 13 11 4413 5716 6280 +9791 2 2 13 11 71 6375 4946 +9792 2 2 13 11 4423 4982 5304 +9793 2 2 13 11 4385 5212 6028 +9794 2 2 13 11 4386 6029 5213 +9795 2 2 13 11 4532 5859 5215 +9796 2 2 13 11 4533 5216 5860 +9797 2 2 13 11 4135 5690 4751 +9798 2 2 13 11 4136 4752 5691 +9799 2 2 13 11 3660 6127 4755 +9800 2 2 13 11 4537 5579 5702 +9801 2 2 13 11 3826 4953 5497 +9802 2 2 13 11 4320 5513 5952 +9803 2 2 13 11 3773 6585 5855 +9804 2 2 13 11 4298 6079 5077 +9805 2 2 13 11 4299 5078 6080 +9806 2 2 13 11 4587 6309 5824 +9807 2 2 13 11 4119 6182 4860 +9808 2 2 13 11 4120 4861 6183 +9809 2 2 13 11 3923 4796 6342 +9810 2 2 13 11 4094 4851 5462 +9811 2 2 13 11 4225 4884 6236 +9812 2 2 13 11 4226 6237 4885 +9813 2 2 13 11 3679 6059 4769 +9814 2 2 13 11 3943 5384 5038 +9815 2 2 13 11 3972 4824 6639 +9816 2 2 13 11 4294 6262 6199 +9817 2 2 13 11 4470 5716 6691 +9818 2 2 13 11 4013 4829 6600 +9819 2 2 13 11 4234 4871 5459 +9820 2 2 13 11 4084 5610 5015 +9821 2 2 13 11 4115 5945 4862 +9822 2 2 13 11 4098 5708 4946 +9823 2 2 13 11 3933 5922 4781 +9824 2 2 13 11 4053 5813 5149 +9825 2 2 13 11 3941 5975 6096 +9826 2 2 13 11 3942 6097 5976 +9827 2 2 13 11 4259 6011 5030 +9828 2 2 13 11 3774 6160 4825 +9829 2 2 13 11 4345 5249 6145 +9830 2 2 13 11 4031 6205 4839 +9831 2 2 13 11 5215 5859 6457 +9832 2 2 13 11 5216 6458 5860 +9833 2 2 13 11 3987 6259 4759 +9834 2 2 13 11 4458 6330 5792 +9835 2 2 13 11 4124 5448 4848 +9836 2 2 13 11 4037 5536 5210 +9837 2 2 13 11 4038 5211 5537 +9838 2 2 13 11 4134 6953 5600 +9839 2 2 13 11 3788 6768 5302 +9840 2 2 13 11 4014 6543 4994 +9841 2 2 13 11 4645 6858 6699 +9842 2 2 13 11 3783 6181 5163 +9843 2 2 13 11 3991 5632 4870 +9844 2 2 13 11 4007 6351 4761 +9845 2 2 13 11 3932 4871 5888 +9846 2 2 13 11 4270 5301 5905 +9847 2 2 13 11 4542 6340 5980 +9848 2 2 13 11 4211 6893 5674 +9849 2 2 13 11 4693 5798 5895 +9850 2 2 13 11 3960 5177 5341 +9851 2 2 13 11 4050 4749 6839 +9852 2 2 13 11 3961 5342 5178 +9853 2 2 13 11 4051 6840 4750 +9854 2 2 13 11 4075 6616 4936 +9855 2 2 13 11 3701 5673 4846 +9856 2 2 13 11 3987 6782 5004 +9857 2 2 13 11 4104 5143 5373 +9858 2 2 13 11 3910 4755 6741 +9859 2 2 13 11 3826 6151 4953 +9860 2 2 13 11 329 5686 330 +9861 2 2 13 11 246 5687 247 +9862 2 2 13 11 4426 5430 6687 +9863 2 2 13 11 4111 6001 5025 +9864 2 2 13 11 3687 5725 5235 +9865 2 2 13 11 3824 6214 6728 +9866 2 2 13 11 3755 4866 5817 +9867 2 2 13 11 3801 5124 5544 +9868 2 2 13 11 3972 6639 4854 +9869 2 2 13 11 4250 5692 5265 +9870 2 2 13 11 4251 5266 5694 +9871 2 2 13 11 4207 5634 5628 +9872 2 2 13 11 4208 5629 5635 +9873 2 2 13 11 4192 6292 4881 +9874 2 2 13 11 3693 5390 5473 +9875 2 2 13 11 3963 5222 6854 +9876 2 2 13 11 4582 6254 5246 +9877 2 2 13 11 3779 4786 5711 +9878 2 2 13 11 4395 5468 6024 +9879 2 2 13 11 3758 5308 5818 +9880 2 2 13 11 4101 4889 5761 +9881 2 2 13 11 124 4777 6407 +9882 2 2 13 11 3671 5300 5040 +9883 2 2 13 11 3799 6833 5707 +9884 2 2 13 11 3804 5981 5536 +9885 2 2 13 11 4465 5939 5157 +9886 2 2 13 11 4466 5158 5940 +9887 2 2 13 11 3805 5537 5982 +9888 2 2 13 11 3861 4833 6152 +9889 2 2 13 11 4423 6350 4982 +9890 2 2 13 11 4006 4815 6222 +9891 2 2 13 11 4615 4955 5988 +9892 2 2 13 11 78 79 5373 +9893 2 2 13 11 4048 6028 4741 +9894 2 2 13 11 4049 4742 6029 +9895 2 2 13 11 6874 6506 4323 +9896 2 2 13 11 6875 4324 6507 +9897 2 2 13 11 4135 6678 5690 +9898 2 2 13 11 4136 5691 6679 +9899 2 2 13 11 4040 5854 4840 +9900 2 2 13 11 4974 6426 6019 +9901 2 2 13 11 4975 6020 6427 +9902 2 2 13 11 6472 5705 4358 +9903 2 2 13 11 4143 6846 4961 +9904 2 2 13 11 4908 6868 6412 +9905 2 2 13 11 3963 6854 6129 +9906 2 2 13 11 4634 4935 5934 +9907 2 2 13 11 4461 5232 6313 +9908 2 2 13 11 4134 5255 6762 +9909 2 2 13 11 4759 5309 6782 +9910 2 2 13 11 4048 4950 6035 +9911 2 2 13 11 4049 6036 4951 +9912 2 2 13 11 4144 5113 5424 +9913 2 2 13 11 4145 5425 5114 +9914 2 2 13 11 4537 6175 6332 +9915 2 2 13 11 4753 5108 5969 +9916 2 2 13 11 3829 5591 5279 +9917 2 2 13 11 3733 6939 4800 +9918 2 2 13 11 3990 6199 5039 +9919 2 2 13 11 3953 5464 4913 +9920 2 2 13 11 4730 6212 5891 +9921 2 2 13 11 4121 5055 5864 +9922 2 2 13 11 4122 5865 5056 +9923 2 2 13 11 4282 4826 6228 +9924 2 2 13 11 3946 5240 5799 +9925 2 2 13 11 3707 5814 4862 +9926 2 2 13 11 3933 4781 6206 +9927 2 2 13 11 4385 5585 5532 +9928 2 2 13 11 4386 5533 5586 +9929 2 2 13 11 3832 5496 4929 +9930 2 2 13 11 4097 4982 5777 +9931 2 2 13 11 3811 5402 5217 +9932 2 2 13 11 3710 6136 4807 +9933 2 2 13 11 4248 5179 5374 +9934 2 2 13 11 3929 5891 6212 +9935 2 2 13 11 4046 6614 4817 +9936 2 2 13 11 4968 5732 6751 +9937 2 2 13 11 5091 6122 5884 +9938 2 2 13 11 4144 5424 6766 +9939 2 2 13 11 4145 6767 5425 +9940 2 2 13 11 4047 4818 6615 +9941 2 2 13 11 152 6664 4849 +9942 2 2 13 11 69 4850 6665 +9943 2 2 13 11 86 87 5607 +9944 2 2 13 11 4068 6611 5069 +9945 2 2 13 11 4328 6116 5841 +9946 2 2 13 11 3927 4783 5968 +9947 2 2 13 11 4073 5496 5259 +9948 2 2 13 11 4114 5152 5979 +9949 2 2 13 11 3950 4873 5829 +9950 2 2 13 11 4248 5804 5339 +9951 2 2 13 11 4255 5447 4944 +9952 2 2 13 11 4699 5682 6752 +9953 2 2 13 11 4657 4940 5999 +9954 2 2 13 11 4700 6753 5683 +9955 2 2 13 11 3799 5493 6161 +9956 2 2 13 11 4040 4840 5745 +9957 2 2 13 11 3828 5304 5590 +9958 2 2 13 11 4262 5527 5471 +9959 2 2 13 11 4263 5472 5528 +9960 2 2 13 11 3978 4841 5723 +9961 2 2 13 11 4521 5380 5245 +9962 2 2 13 11 4033 6903 4868 +9963 2 2 13 11 4034 4869 6904 +9964 2 2 13 11 3938 4864 5836 +9965 2 2 13 11 4177 6295 5787 +9966 2 2 13 11 4713 6854 5222 +9967 2 2 13 11 4366 5107 6784 +9968 2 2 13 11 4108 5345 4980 +9969 2 2 13 11 4075 5044 6894 +9970 2 2 13 11 4327 6130 5593 +9971 2 2 13 11 4267 6829 5867 +9972 2 2 13 11 6868 3759 6412 +9973 2 2 13 11 280 5048 5310 +9974 2 2 13 11 4262 5471 5136 +9975 2 2 13 11 4263 5137 5472 +9976 2 2 13 11 123 6407 6569 +9977 2 2 13 11 4288 5243 5506 +9978 2 2 13 11 4347 6852 5110 +9979 2 2 13 11 3752 5827 4992 +9980 2 2 13 11 4557 5095 6607 +9981 2 2 13 11 147 4815 6435 +9982 2 2 13 11 4469 6351 5244 +9983 2 2 13 11 4088 5429 6575 +9984 2 2 13 11 6813 3675 5649 +9985 2 2 13 11 4119 5810 5072 +9986 2 2 13 11 4120 5073 5811 +9987 2 2 13 11 3845 5548 6224 +9988 2 2 13 11 4645 6699 5821 +9989 2 2 13 11 4253 6103 4857 +9990 2 2 13 11 3707 6221 6820 +9991 2 2 13 11 4812 5830 6747 +9992 2 2 13 11 4924 6807 6158 +9993 2 2 13 11 5110 6852 5965 +9994 2 2 13 11 6807 4001 6158 +9995 2 2 13 11 4001 5791 5003 +9996 2 2 13 11 3773 5080 5503 +9997 2 2 13 11 4099 4804 5857 +9998 2 2 13 11 4178 5234 5381 +9999 2 2 13 11 4175 5660 5384 +10000 2 2 13 11 4144 5590 4920 +10001 2 2 13 11 3924 4895 5930 +10002 2 2 13 11 4145 4921 5591 +10003 2 2 13 11 3925 5931 4896 +10004 2 2 13 11 4335 5356 5217 +10005 2 2 13 11 4137 4977 5393 +10006 2 2 13 11 4085 5374 5179 +10007 2 2 13 11 4631 6336 5507 +10008 2 2 13 11 3737 5612 4917 +10009 2 2 13 11 3738 4918 5613 +10010 2 2 13 11 3859 6892 4903 +10011 2 2 13 11 4384 4946 6375 +10012 2 2 13 11 4069 4987 5932 +10013 2 2 13 11 4478 6842 4976 +10014 2 2 13 11 4294 4804 6262 +10015 2 2 13 11 3722 5547 5091 +10016 2 2 13 11 4075 6226 5044 +10017 2 2 13 11 4010 5134 6837 +10018 2 2 13 11 4087 5872 5428 +10019 2 2 13 11 317 5182 318 +10020 2 2 13 11 258 5183 259 +10021 2 2 13 11 3878 5763 4932 +10022 2 2 13 11 3784 5875 4783 +10023 2 2 13 11 4309 4864 6177 +10024 2 2 13 11 3895 6493 6935 +10025 2 2 13 11 3907 6063 4859 +10026 2 2 13 11 298 4949 6352 +10027 2 2 13 11 3780 5033 5480 +10028 2 2 13 11 4273 6526 4887 +10029 2 2 13 11 3731 4860 6182 +10030 2 2 13 11 4914 6192 6164 +10031 2 2 13 11 3732 6183 4861 +10032 2 2 13 11 3927 6315 4801 +10033 2 2 13 11 3777 5781 5731 +10034 2 2 13 11 4161 6306 4842 +10035 2 2 13 11 4162 4843 6307 +10036 2 2 13 11 4108 4980 5658 +10037 2 2 13 11 4142 5300 6190 +10038 2 2 13 11 3765 5136 5471 +10039 2 2 13 11 3766 5472 5137 +10040 2 2 13 11 3799 6161 5396 +10041 2 2 13 11 4474 4956 6919 +10042 2 2 13 11 4102 6502 4807 +10043 2 2 13 11 3786 6019 6426 +10044 2 2 13 11 3787 6427 6020 +10045 2 2 13 11 4494 5397 5000 +10046 2 2 13 11 3973 6261 4835 +10047 2 2 13 11 4694 6900 6613 +10048 2 2 13 11 4036 4984 5408 +10049 2 2 13 11 155 156 5441 +10050 2 2 13 11 4789 5302 6768 +10051 2 2 13 11 65 66 5442 +10052 2 2 13 11 3918 4857 6103 +10053 2 2 13 11 4037 4933 5536 +10054 2 2 13 11 4214 5198 5329 +10055 2 2 13 11 4038 5537 4934 +10056 2 2 13 11 4336 5924 6360 +10057 2 2 13 11 4237 5055 5909 +10058 2 2 13 11 4238 5910 5056 +10059 2 2 13 11 3976 5580 6074 +10060 2 2 13 11 3977 6075 5581 +10061 2 2 13 11 4121 5031 6549 +10062 2 2 13 11 4122 6550 5032 +10063 2 2 13 11 5081 5454 6227 +10064 2 2 13 11 3816 5846 5475 +10065 2 2 13 11 3817 5476 5847 +10066 2 2 13 11 5429 6791 6575 +10067 2 2 13 11 4135 5532 5585 +10068 2 2 13 11 4136 5586 5533 +10069 2 2 13 11 4075 5053 6226 +10070 2 2 13 11 4234 4847 5888 +10071 2 2 13 11 4398 6476 4969 +10072 2 2 13 11 4399 4970 6477 +10073 2 2 13 11 4322 6285 4821 +10074 2 2 13 11 4514 5770 6185 +10075 2 2 13 11 4350 5929 6162 +10076 2 2 13 11 4193 5402 5030 +10077 2 2 13 11 4349 6600 5587 +10078 2 2 13 11 89 90 6374 +10079 2 2 13 11 4480 5071 6012 +10080 2 2 13 11 4794 6687 5430 +10081 2 2 13 11 4030 5277 5159 +10082 2 2 13 11 4043 6572 4995 +10083 2 2 13 11 3797 6114 5434 +10084 2 2 13 11 3798 5435 6115 +10085 2 2 13 11 3733 4839 6215 +10086 2 2 13 11 4357 5799 5240 +10087 2 2 13 11 5069 6611 5242 +10088 2 2 13 11 4019 6322 5379 +10089 2 2 13 11 4381 5038 5384 +10090 2 2 13 11 3659 6772 5478 +10091 2 2 13 11 4387 6499 4844 +10092 2 2 13 11 129 130 5225 +10093 2 2 13 11 4601 6240 6083 +10094 2 2 13 11 4117 5348 5085 +10095 2 2 13 11 4146 5497 4953 +10096 2 2 13 11 3916 5511 5197 +10097 2 2 13 11 4177 5787 5562 +10098 2 2 13 11 3755 6517 4866 +10099 2 2 13 11 4184 5817 4866 +10100 2 2 13 11 4199 5744 6499 +10101 2 2 13 11 3734 4900 6356 +10102 2 2 13 11 3779 6726 4786 +10103 2 2 13 11 4177 5430 5365 +10104 2 2 13 11 3939 5315 6112 +10105 2 2 13 11 4418 6023 5291 +10106 2 2 13 11 4147 5256 5609 +10107 2 2 13 11 3749 5507 6336 +10108 2 2 13 11 4110 4833 6495 +10109 2 2 13 11 132 5986 5596 +10110 2 2 13 11 4156 4969 6476 +10111 2 2 13 11 4157 6477 4970 +10112 2 2 13 11 4424 5818 5308 +10113 2 2 13 11 4325 5513 6224 +10114 2 2 13 11 4819 6749 6694 +10115 2 2 13 11 4820 6695 6750 +10116 2 2 13 11 4154 5575 6713 +10117 2 2 13 11 4112 6494 4834 +10118 2 2 13 11 3739 4886 6755 +10119 2 2 13 11 4492 5731 5781 +10120 2 2 13 11 4618 6867 6437 +10121 2 2 13 11 3879 5326 5193 +10122 2 2 13 11 4619 6438 6869 +10123 2 2 13 11 4253 5696 6296 +10124 2 2 13 11 3718 6313 5232 +10125 2 2 13 11 4688 5149 5813 +10126 2 2 13 11 3707 4862 5945 +10127 2 2 13 11 4121 6549 5055 +10128 2 2 13 11 4122 5056 6550 +10129 2 2 13 11 3922 5492 6662 +10130 2 2 13 11 4566 6478 6251 +10131 2 2 13 11 4567 6252 6479 +10132 2 2 13 11 4892 6506 6874 +10133 2 2 13 11 4893 6875 6507 +10134 2 2 13 11 4767 6707 5017 +10135 2 2 13 11 4007 5244 6351 +10136 2 2 13 11 3982 5643 5081 +10137 2 2 13 11 3823 4967 5483 +10138 2 2 13 11 4406 5935 4981 +10139 2 2 13 11 4788 6662 5492 +10140 2 2 13 11 4180 4931 5718 +10141 2 2 13 11 4985 5330 6690 +10142 2 2 13 11 4188 4932 5763 +10143 2 2 13 11 4235 4924 6158 +10144 2 2 13 11 3967 4976 6842 +10145 2 2 13 11 3861 5540 4922 +10146 2 2 13 11 3700 5261 5927 +10147 2 2 13 11 4410 6323 6555 +10148 2 2 13 11 4420 5339 5804 +10149 2 2 13 11 3849 5599 4948 +10150 2 2 13 11 4275 5911 6580 +10151 2 2 13 11 4170 5314 5701 +10152 2 2 13 11 4437 5074 6743 +10153 2 2 13 11 4141 5479 5127 +10154 2 2 13 11 4577 5012 5529 +10155 2 2 13 11 4578 5530 5013 +10156 2 2 13 11 3856 6940 4879 +10157 2 2 13 11 4105 6053 5093 +10158 2 2 13 11 4026 5526 6838 +10159 2 2 13 11 4117 5088 5688 +10160 2 2 13 11 4090 5633 4935 +10161 2 2 13 11 4009 4852 6607 +10162 2 2 13 11 4173 5457 4972 +10163 2 2 13 11 4174 4973 5458 +10164 2 2 13 11 3963 5732 5222 +10165 2 2 13 11 4658 4981 5935 +10166 2 2 13 11 4989 6813 5649 +10167 2 2 13 11 4323 6506 5129 +10168 2 2 13 11 4324 5130 6507 +10169 2 2 13 11 4297 4908 6412 +10170 2 2 13 11 4234 5888 4871 +10171 2 2 13 11 4316 4971 6264 +10172 2 2 13 11 3931 6164 6192 +10173 2 2 13 11 4053 5915 4852 +10174 2 2 13 11 4076 6436 5495 +10175 2 2 13 11 3759 6744 4870 +10176 2 2 13 11 3955 6305 5422 +10177 2 2 13 11 4206 6853 6789 +10178 2 2 13 11 4495 4952 6652 +10179 2 2 13 11 4460 6352 4949 +10180 2 2 13 11 3771 6764 6817 +10181 2 2 13 11 4152 6573 4890 +10182 2 2 13 11 3749 6336 4803 +10183 2 2 13 11 4126 5825 5503 +10184 2 2 13 11 3973 6329 4879 +10185 2 2 13 11 4360 5735 5455 +10186 2 2 13 11 4005 6658 4904 +10187 2 2 13 11 4517 6589 5151 +10188 2 2 13 11 4513 6382 6276 +10189 2 2 13 11 3826 5374 5016 +10190 2 2 13 11 4192 4881 6017 +10191 2 2 13 11 3791 6284 5187 +10192 2 2 13 11 4114 5979 5329 +10193 2 2 13 11 3713 5332 5834 +10194 2 2 13 11 4326 4823 6253 +10195 2 2 13 11 4228 5518 6025 +10196 2 2 13 11 4407 5651 4911 +10197 2 2 13 11 4408 4912 5652 +10198 2 2 13 11 3775 5105 5327 +10199 2 2 13 11 3776 5328 5106 +10200 2 2 13 11 3867 5789 4983 +10201 2 2 13 11 4589 5379 6322 +10202 2 2 13 11 3651 5899 4831 +10203 2 2 13 11 4553 6087 5525 +10204 2 2 13 11 4168 5477 6697 +10205 2 2 13 11 4011 4949 6174 +10206 2 2 13 11 4327 5902 6947 +10207 2 2 13 11 4161 4874 6306 +10208 2 2 13 11 4162 6307 4875 +10209 2 2 13 11 3789 5878 5445 +10210 2 2 13 11 3790 5446 5879 +10211 2 2 13 11 4382 4866 6517 +10212 2 2 13 11 4182 6215 4839 +10213 2 2 13 11 3852 4935 5633 +10214 2 2 13 11 4574 5665 6612 +10215 2 2 13 11 4128 5010 5697 +10216 2 2 13 11 4129 5698 5011 +10217 2 2 13 11 3652 6747 5830 +10218 2 2 13 11 4200 5091 5547 +10219 2 2 13 11 4223 4867 6016 +10220 2 2 13 11 3931 5151 6589 +10221 2 2 13 11 4087 5449 5872 +10222 2 2 13 11 4109 5351 5014 +10223 2 2 13 11 4218 4805 6759 +10224 2 2 13 11 4188 5884 6612 +10225 2 2 13 11 4219 6760 4806 +10226 2 2 13 11 4446 5872 5449 +10227 2 2 13 11 4112 5357 5042 +10228 2 2 13 11 4623 6074 5580 +10229 2 2 13 11 4624 5581 6075 +10230 2 2 13 11 4505 4956 6410 +10231 2 2 13 11 4210 5081 5643 +10232 2 2 13 11 3877 6141 5361 +10233 2 2 13 11 4362 4882 6040 +10234 2 2 13 11 3954 4943 6714 +10235 2 2 13 11 168 5031 6524 +10236 2 2 13 11 53 6525 5032 +10237 2 2 13 11 4462 5466 5156 +10238 2 2 13 11 3769 6655 5812 +10239 2 2 13 11 4074 6801 5321 +10240 2 2 13 11 163 164 5369 +10241 2 2 13 11 57 58 5370 +10242 2 2 13 11 3767 5915 5049 +10243 2 2 13 11 4110 6495 4902 +10244 2 2 13 11 4381 5384 5660 +10245 2 2 13 11 3993 6419 6491 +10246 2 2 13 11 4314 5341 5177 +10247 2 2 13 11 4315 5178 5342 +10248 2 2 13 11 5163 6181 6902 +10249 2 2 13 11 3746 4874 6030 +10250 2 2 13 11 3747 6031 4875 +10251 2 2 13 11 3989 4930 5641 +10252 2 2 13 11 3985 6544 5089 +10253 2 2 13 11 3918 6121 4857 +10254 2 2 13 11 4294 6338 4804 +10255 2 2 13 11 3956 6919 4956 +10256 2 2 13 11 3854 6506 4892 +10257 2 2 13 11 3855 4893 6507 +10258 2 2 13 11 4829 5587 6600 +10259 2 2 13 11 4066 5219 6583 +10260 2 2 13 11 4160 6176 5337 +10261 2 2 13 11 3669 6032 6774 +10262 2 2 13 11 4067 6584 5220 +10263 2 2 13 11 4184 4866 6013 +10264 2 2 13 11 3765 5471 5203 +10265 2 2 13 11 4368 5039 5460 +10266 2 2 13 11 3766 5204 5472 +10267 2 2 13 11 4418 5291 5999 +10268 2 2 13 11 3743 5999 5291 +10269 2 2 13 11 4377 6825 4906 +10270 2 2 13 11 4663 5793 5012 +10271 2 2 13 11 4664 5013 5794 +10272 2 2 13 11 3973 4835 6329 +10273 2 2 13 11 3727 5460 5039 +10274 2 2 13 11 4116 5525 6087 +10275 2 2 13 11 4112 4905 6494 +10276 2 2 13 11 4362 5876 4882 +10277 2 2 13 11 4231 5197 5511 +10278 2 2 13 11 5478 6772 6930 +10279 2 2 13 11 4405 4901 6556 +10280 2 2 13 11 4517 6347 5250 +10281 2 2 13 11 4225 5746 5409 +10282 2 2 13 11 4226 5410 5747 +10283 2 2 13 11 3954 4902 6495 +10284 2 2 13 11 4384 4959 5753 +10285 2 2 13 11 304 6220 4960 +10286 2 2 13 11 4321 6208 5176 +10287 2 2 13 11 4287 6329 4835 +10288 2 2 13 11 4040 5491 5138 +10289 2 2 13 11 4984 5389 6563 +10290 2 2 13 11 4416 5361 6141 +10291 2 2 13 11 4312 5957 4883 +10292 2 2 13 11 4121 6524 5031 +10293 2 2 13 11 4122 5032 6525 +10294 2 2 13 11 4322 5121 6073 +10295 2 2 13 11 4103 5156 5466 +10296 2 2 13 11 4913 5244 6777 +10297 2 2 13 11 3658 5901 6016 +10298 2 2 13 11 4132 5896 5052 +10299 2 2 13 11 4795 6491 6419 +10300 2 2 13 11 4252 4858 5689 +10301 2 2 13 11 3811 5217 5356 +10302 2 2 13 11 4201 5381 5234 +10303 2 2 13 11 4891 6128 5358 +10304 2 2 13 11 4127 4915 5800 +10305 2 2 13 11 4276 4837 6249 +10306 2 2 13 11 4277 6250 4838 +10307 2 2 13 11 3866 5824 6309 +10308 2 2 13 11 3870 6153 5414 +10309 2 2 13 11 3686 5502 5063 +10310 2 2 13 11 3802 4963 6841 +10311 2 2 13 11 4360 6498 5022 +10312 2 2 13 11 3957 6717 4955 +10313 2 2 13 11 4203 4859 6294 +10314 2 2 13 11 4148 5093 5439 +10315 2 2 13 11 4915 6201 4331 +10316 2 2 13 11 3764 5941 4864 +10317 2 2 13 11 4322 5500 6748 +10318 2 2 13 11 3957 6494 4905 +10319 2 2 13 11 5254 5851 6800 +10320 2 2 13 11 3791 5001 6284 +10321 2 2 13 11 4788 6508 6708 +10322 2 2 13 11 4203 6294 6121 +10323 2 2 13 11 4204 4974 6019 +10324 2 2 13 11 4205 6020 4975 +10325 2 2 13 11 4493 5562 5787 +10326 2 2 13 11 3959 6138 5627 +10327 2 2 13 11 4688 6582 5194 +10328 2 2 13 11 4063 5207 6288 +10329 2 2 13 11 4064 6289 5208 +10330 2 2 13 11 4534 5414 6153 +10331 2 2 13 11 299 5550 300 +10332 2 2 13 11 3722 5091 5552 +10333 2 2 13 11 4268 5902 5593 +10334 2 2 13 11 3847 6191 5539 +10335 2 2 13 11 73 74 5386 +10336 2 2 13 11 5400 5864 6864 +10337 2 2 13 11 5401 6865 5865 +10338 2 2 13 11 4499 6112 5315 +10339 2 2 13 11 4429 6056 5363 +10340 2 2 13 11 4430 5364 6057 +10341 2 2 13 11 3781 6017 4881 +10342 2 2 13 11 4286 5820 6314 +10343 2 2 13 11 4246 4930 6159 +10344 2 2 13 11 304 4960 6452 +10345 2 2 13 11 3954 6738 4943 +10346 2 2 13 11 285 4971 6154 +10347 2 2 13 11 3657 5171 5973 +10348 2 2 13 11 3808 5783 5281 +10349 2 2 13 11 4055 4842 6306 +10350 2 2 13 11 4056 6307 4843 +10351 2 2 13 11 4239 5529 5012 +10352 2 2 13 11 4240 5013 5530 +10353 2 2 13 11 4230 6192 4914 +10354 2 2 13 11 4554 6769 5385 +10355 2 2 13 11 3973 4879 6310 +10356 2 2 13 11 4020 4909 6770 +10357 2 2 13 11 4021 6771 4910 +10358 2 2 13 11 3694 4878 5779 +10359 2 2 13 11 4361 5598 4922 +10360 2 2 13 11 4209 5768 4903 +10361 2 2 13 11 70 4946 5708 +10362 2 2 13 11 3904 4867 5947 +10363 2 2 13 11 4165 4948 5611 +10364 2 2 13 11 4429 5343 6627 +10365 2 2 13 11 4430 6628 5344 +10366 2 2 13 11 5484 6708 6677 +10367 2 2 13 11 3780 4863 5995 +10368 2 2 13 11 3657 5564 5171 +10369 2 2 13 11 269 6090 5017 +10370 2 2 13 11 81 5761 4889 +10371 2 2 13 11 3834 5439 5093 +10372 2 2 13 11 4135 5585 6678 +10373 2 2 13 11 4136 6679 5586 +10374 2 2 13 11 3768 6624 5272 +10375 2 2 13 11 4060 5380 6171 +10376 2 2 13 11 4469 5795 4994 +10377 2 2 13 11 4298 6770 4909 +10378 2 2 13 11 4299 4910 6771 +10379 2 2 13 11 3741 4936 5905 +10380 2 2 13 11 4037 6617 4933 +10381 2 2 13 11 4038 4934 6618 +10382 2 2 13 11 4481 6660 5474 +10383 2 2 13 11 3989 6159 4930 +10384 2 2 13 11 4113 5190 5335 +10385 2 2 13 11 4669 6418 6548 +10386 2 2 13 11 4687 6829 6127 +10387 2 2 13 11 4114 5329 5198 +10388 2 2 13 11 3781 4857 6294 +10389 2 2 13 11 3676 5521 6500 +10390 2 2 13 11 335 5909 5055 +10391 2 2 13 11 241 5056 5910 +10392 2 2 13 11 3955 6000 6305 +10393 2 2 13 11 4448 6714 4943 +10394 2 2 13 11 296 5286 297 +10395 2 2 13 11 3670 6333 4854 +10396 2 2 13 11 4017 6062 5566 +10397 2 2 13 11 4018 5567 6064 +10398 2 2 13 11 4181 5193 5326 +10399 2 2 13 11 3730 6470 5184 +10400 2 2 13 11 4587 5824 6562 +10401 2 2 13 11 4121 5077 6524 +10402 2 2 13 11 4122 6525 5078 +10403 2 2 13 11 4218 5471 5527 +10404 2 2 13 11 4219 5528 5472 +10405 2 2 13 11 4295 6002 5655 +10406 2 2 13 11 3822 6176 5545 +10407 2 2 13 11 3829 4985 6458 +10408 2 2 13 11 4029 6429 4942 +10409 2 2 13 11 4626 5302 6466 +10410 2 2 13 11 4543 6025 5518 +10411 2 2 13 11 4917 5612 6372 +10412 2 2 13 11 5118 6672 5444 +10413 2 2 13 11 4918 6373 5613 +10414 2 2 13 11 4579 5917 5139 +10415 2 2 13 11 4373 6656 5561 +10416 2 2 13 11 3950 6783 6165 +10417 2 2 13 11 3992 4872 6472 +10418 2 2 13 11 4234 6089 4847 +10419 2 2 13 11 4415 5834 5332 +10420 2 2 13 11 4865 6483 5255 +10421 2 2 13 11 4398 4969 5756 +10422 2 2 13 11 3966 4831 6462 +10423 2 2 13 11 4399 5757 4970 +10424 2 2 13 11 4146 4958 5721 +10425 2 2 13 11 3947 5058 6670 +10426 2 2 13 11 4168 6697 5782 +10427 2 2 13 11 4382 6587 4866 +10428 2 2 13 11 4101 5761 5094 +10429 2 2 13 11 3792 4895 5639 +10430 2 2 13 11 3793 5640 4896 +10431 2 2 13 11 4172 5502 5209 +10432 2 2 13 11 4117 5320 5348 +10433 2 2 13 11 105 106 5543 +10434 2 2 13 11 3760 5181 6428 +10435 2 2 13 11 4853 6696 6709 +10436 2 2 13 11 3862 6832 5023 +10437 2 2 13 11 4394 5927 5261 +10438 2 2 13 11 3957 4955 6763 +10439 2 2 13 11 4074 5492 6801 +10440 2 2 13 11 4223 6126 5228 +10441 2 2 13 11 3746 4884 6300 +10442 2 2 13 11 3747 6301 4885 +10443 2 2 13 11 4083 6021 6483 +10444 2 2 13 11 4618 6437 5740 +10445 2 2 13 11 3844 5848 4945 +10446 2 2 13 11 4619 5741 6438 +10447 2 2 13 11 4370 6027 6223 +10448 2 2 13 11 4441 5238 6272 +10449 2 2 13 11 4330 6090 5314 +10450 2 2 13 11 4442 6273 5239 +10451 2 2 13 11 4230 4914 6263 +10452 2 2 13 11 4258 5455 5735 +10453 2 2 13 11 4517 6606 6347 +10454 2 2 13 11 4245 5551 5145 +10455 2 2 13 11 4003 6790 5768 +10456 2 2 13 11 3737 4917 6194 +10457 2 2 13 11 3738 6195 4918 +10458 2 2 13 11 4154 5050 5575 +10459 2 2 13 11 3743 5291 6713 +10460 2 2 13 11 3833 5661 5845 +10461 2 2 13 11 3689 5983 4999 +10462 2 2 13 11 3751 4847 6089 +10463 2 2 13 11 3875 4961 6730 +10464 2 2 13 11 4180 5925 4931 +10465 2 2 13 11 3958 4904 6809 +10466 2 2 13 11 4028 5560 6884 +10467 2 2 13 11 4010 4900 5807 +10468 2 2 13 11 3775 5327 5601 +10469 2 2 13 11 3776 5602 5328 +10470 2 2 13 11 3812 5400 6864 +10471 2 2 13 11 3813 6865 5401 +10472 2 2 13 11 4329 5281 5783 +10473 2 2 13 11 6651 4915 4331 +10474 2 2 13 11 3970 5104 5655 +10475 2 2 13 11 337 6549 5031 +10476 2 2 13 11 239 5032 6550 +10477 2 2 13 11 158 5111 6388 +10478 2 2 13 11 63 6389 5112 +10479 2 2 13 11 3682 6694 6749 +10480 2 2 13 11 4055 6306 4874 +10481 2 2 13 11 3683 6750 6695 +10482 2 2 13 11 4056 4875 6307 +10483 2 2 13 11 4070 5129 5452 +10484 2 2 13 11 4071 5453 5130 +10485 2 2 13 11 293 6245 5043 +10486 2 2 13 11 4158 4943 6738 +10487 2 2 13 11 4307 6942 4972 +10488 2 2 13 11 4308 4973 6943 +10489 2 2 13 11 4637 5542 6555 +10490 2 2 13 11 4449 4955 6717 +10491 2 2 13 11 4904 6658 5830 +10492 2 2 13 11 4008 5705 5000 +10493 2 2 13 11 4094 5571 4937 +10494 2 2 13 11 5180 5467 6509 +10495 2 2 13 11 5129 6506 5452 +10496 2 2 13 11 4155 5783 5135 +10497 2 2 13 11 5130 5453 6507 +10498 2 2 13 11 3829 6552 4985 +10499 2 2 13 11 4146 4953 6319 +10500 2 2 13 11 3953 4906 6825 +10501 2 2 13 11 4228 4983 5789 +10502 2 2 13 11 4845 6223 6027 +10503 2 2 13 11 3827 5202 6414 +10504 2 2 13 11 3678 6746 4924 +10505 2 2 13 11 280 5310 281 +10506 2 2 13 11 313 5822 5097 +10507 2 2 13 11 263 5098 5823 +10508 2 2 13 11 4857 6121 6294 +10509 2 2 13 11 279 6269 5048 +10510 2 2 13 11 4025 6712 5176 +10511 2 2 13 11 4666 6593 5866 +10512 2 2 13 11 4165 5949 4948 +10513 2 2 13 11 3800 5214 6880 +10514 2 2 13 11 4118 6739 4992 +10515 2 2 13 11 4297 4878 6335 +10516 2 2 13 11 4283 5601 5327 +10517 2 2 13 11 4264 6259 5065 +10518 2 2 13 11 4312 4883 6068 +10519 2 2 13 11 4284 5328 5602 +10520 2 2 13 11 4153 5493 5423 +10521 2 2 13 11 4109 5123 5767 +10522 2 2 13 11 4221 4863 6377 +10523 2 2 13 11 3781 6294 4859 +10524 2 2 13 11 137 6857 6420 +10525 2 2 13 11 4396 5409 5746 +10526 2 2 13 11 4397 5747 5410 +10527 2 2 13 11 4012 6073 5121 +10528 2 2 13 11 4579 6728 6214 +10529 2 2 13 11 140 5693 5030 +10530 2 2 13 11 3811 5858 4941 +10531 2 2 13 11 4739 6016 5901 +10532 2 2 13 11 4604 5799 5067 +10533 2 2 13 11 4425 6448 5671 +10534 2 2 13 11 4159 6763 4955 +10535 2 2 13 11 4029 5059 5837 +10536 2 2 13 11 4457 6205 5297 +10537 2 2 13 11 4903 5768 6790 +10538 2 2 13 11 4031 5297 6205 +10539 2 2 13 11 3878 4932 6082 +10540 2 2 13 11 3971 4846 6417 +10541 2 2 13 11 3810 6512 5290 +10542 2 2 13 11 3966 4931 5925 +10543 2 2 13 11 5830 6658 4417 +10544 2 2 13 11 332 5966 5020 +10545 2 2 13 11 244 5021 5967 +10546 2 2 13 11 4236 6041 4937 +10547 2 2 13 11 4260 4932 5665 +10548 2 2 13 11 4043 4995 5928 +10549 2 2 13 11 4897 6627 5992 +10550 2 2 13 11 4898 5993 6628 +10551 2 2 13 11 3959 6580 4825 +10552 2 2 13 11 4586 5901 5979 +10553 2 2 13 11 4033 5010 6903 +10554 2 2 13 11 4034 6904 5011 +10555 2 2 13 11 4119 4933 6172 +10556 2 2 13 11 3705 5037 6197 +10557 2 2 13 11 4120 6173 4934 +10558 2 2 13 11 4727 6230 6144 +10559 2 2 13 11 4655 5627 6138 +10560 2 2 13 11 166 5077 6079 +10561 2 2 13 11 55 6080 5078 +10562 2 2 13 11 3796 5154 5454 +10563 2 2 13 11 3657 5382 6349 +10564 2 2 13 11 3979 5859 6765 +10565 2 2 13 11 3999 6217 5160 +10566 2 2 13 11 4000 5161 6218 +10567 2 2 13 11 4368 5460 6331 +10568 2 2 13 11 4115 4862 6260 +10569 2 2 13 11 97 6410 4956 +10570 2 2 13 11 3978 5723 4998 +10571 2 2 13 11 4338 5180 6231 +10572 2 2 13 11 271 5347 272 +10573 2 2 13 11 3849 4948 5949 +10574 2 2 13 11 69 70 5708 +10575 2 2 13 11 4022 5753 4959 +10576 2 2 13 11 4187 5703 4919 +10577 2 2 13 11 5192 5770 6225 +10578 2 2 13 11 4381 6421 5524 +10579 2 2 13 11 4336 5260 5924 +10580 2 2 13 11 138 6011 5101 +10581 2 2 13 11 3842 5991 6654 +10582 2 2 13 11 3830 5697 5010 +10583 2 2 13 11 314 5097 6049 +10584 2 2 13 11 262 6050 5098 +10585 2 2 13 11 3831 5011 5698 +10586 2 2 13 11 146 5131 6324 +10587 2 2 13 11 5579 6332 6891 +10588 2 2 13 11 3870 6234 5198 +10589 2 2 13 11 4494 6191 5397 +10590 2 2 13 11 3701 5665 6683 +10591 2 2 13 11 4206 6160 4873 +10592 2 2 13 11 4403 6458 4985 +10593 2 2 13 11 4137 6094 4977 +10594 2 2 13 11 4221 5995 4863 +10595 2 2 13 11 3996 5238 5509 +10596 2 2 13 11 3752 4992 5795 +10597 2 2 13 11 3997 5510 5239 +10598 2 2 13 11 3818 6189 5573 +10599 2 2 13 11 4480 6619 5751 +10600 2 2 13 11 3966 6314 4931 +10601 2 2 13 11 4512 4928 6588 +10602 2 2 13 11 4641 6681 6078 +10603 2 2 13 11 3684 6396 6006 +10604 2 2 13 11 4206 5806 6853 +10605 2 2 13 11 3685 6007 6397 +10606 2 2 13 11 4373 6480 6656 +10607 2 2 13 11 4188 5552 5091 +10608 2 2 13 11 3819 6708 5484 +10609 2 2 13 11 4111 6381 5268 +10610 2 2 13 11 3781 4859 6017 +10611 2 2 13 11 4577 5566 6062 +10612 2 2 13 11 4578 6064 5567 +10613 2 2 13 11 4679 6500 5521 +10614 2 2 13 11 4142 5606 5957 +10615 2 2 13 11 4583 6493 5717 +10616 2 2 13 11 3774 4873 6160 +10617 2 2 13 11 3777 4968 5781 +10618 2 2 13 11 4186 5125 5642 +10619 2 2 13 11 4115 5781 6751 +10620 2 2 13 11 3669 5936 4923 +10621 2 2 13 11 288 5362 289 +10622 2 2 13 11 3913 6282 6219 +10623 2 2 13 11 295 5116 5989 +10624 2 2 13 11 4197 5807 4900 +10625 2 2 13 11 3691 6689 4901 +10626 2 2 13 11 4561 6774 5354 +10627 2 2 13 11 4418 6619 6023 +10628 2 2 13 11 4478 4976 5791 +10629 2 2 13 11 3892 5594 6948 +10630 2 2 13 11 3893 6949 5595 +10631 2 2 13 11 319 5554 320 +10632 2 2 13 11 256 5555 257 +10633 2 2 13 11 3780 5658 4980 +10634 2 2 13 11 4032 4964 6443 +10635 2 2 13 11 3972 4854 6602 +10636 2 2 13 11 4252 6702 4858 +10637 2 2 13 11 332 5020 6908 +10638 2 2 13 11 244 6909 5021 +10639 2 2 13 11 4141 5192 5760 +10640 2 2 13 11 4677 4886 6572 +10641 2 2 13 11 4349 5786 4988 +10642 2 2 13 11 4334 6026 5336 +10643 2 2 13 11 4155 5332 5729 +10644 2 2 13 11 4362 4888 6802 +10645 2 2 13 11 3651 6831 4981 +10646 2 2 13 11 3803 6155 5285 +10647 2 2 13 11 4571 6142 4894 +10648 2 2 13 11 282 5372 283 +10649 2 2 13 11 4569 5563 6938 +10650 2 2 13 11 3693 5825 5390 +10651 2 2 13 11 4325 6885 4883 +10652 2 2 13 11 4015 6372 5136 +10653 2 2 13 11 4016 5137 6373 +10654 2 2 13 11 3693 4944 6330 +10655 2 2 13 11 3926 5608 6610 +10656 2 2 13 11 5428 5872 6655 +10657 2 2 13 11 3826 5497 5804 +10658 2 2 13 11 3847 5397 6191 +10659 2 2 13 11 5460 6814 6331 +10660 2 2 13 11 4126 5503 5080 +10661 2 2 13 11 4244 5840 5637 +10662 2 2 13 11 3771 6817 5090 +10663 2 2 13 11 4178 6490 5614 +10664 2 2 13 11 3657 5320 5564 +10665 2 2 13 11 295 6794 5116 +10666 2 2 13 11 3828 6001 5304 +10667 2 2 13 11 4728 6569 6407 +10668 2 2 13 11 112 113 5336 +10669 2 2 13 11 4409 5596 5986 +10670 2 2 13 11 4517 5250 6630 +10671 2 2 13 11 4296 4998 5723 +10672 2 2 13 11 4223 5947 4867 +10673 2 2 13 11 3954 6714 4902 +10674 2 2 13 11 3737 5953 4868 +10675 2 2 13 11 3655 4902 6716 +10676 2 2 13 11 3738 4869 5954 +10677 2 2 13 11 4204 5975 4974 +10678 2 2 13 11 4205 4975 5976 +10679 2 2 13 11 269 5017 6707 +10680 2 2 13 11 3827 5672 5186 +10681 2 2 13 11 4529 5023 6832 +10682 2 2 13 11 4151 5084 6309 +10683 2 2 13 11 3867 5917 5789 +10684 2 2 13 11 3689 5079 5983 +10685 2 2 13 11 3914 6144 6230 +10686 2 2 13 11 3985 4954 6544 +10687 2 2 13 11 151 5777 4982 +10688 2 2 13 11 4805 6358 6759 +10689 2 2 13 11 4806 6760 6359 +10690 2 2 13 11 4512 6933 4954 +10691 2 2 13 11 3658 5979 5901 +10692 2 2 13 11 5155 5689 6700 +10693 2 2 13 11 3843 5230 5748 +10694 2 2 13 11 4437 6743 6101 +10695 2 2 13 11 4452 5796 6765 +10696 2 2 13 11 4225 6316 4926 +10697 2 2 13 11 4226 4927 6317 +10698 2 2 13 11 4085 5179 5938 +10699 2 2 13 11 4149 6200 5002 +10700 2 2 13 11 4185 6544 4954 +10701 2 2 13 11 3754 5331 5469 +10702 2 2 13 11 4225 6300 4884 +10703 2 2 13 11 4226 4885 6301 +10704 2 2 13 11 123 124 6407 +10705 2 2 13 11 4270 5905 6043 +10706 2 2 13 11 4460 4949 6895 +10707 2 2 13 11 4173 4972 5686 +10708 2 2 13 11 4174 5687 4973 +10709 2 2 13 11 4706 5184 6470 +10710 2 2 13 11 3771 5090 5538 +10711 2 2 13 11 4133 5517 6555 +10712 2 2 13 11 3957 4905 6717 +10713 2 2 13 11 4060 5245 5380 +10714 2 2 13 11 112 5336 6026 +10715 2 2 13 11 4088 6575 5521 +10716 2 2 13 11 4410 6123 5426 +10717 2 2 13 11 3900 6083 6240 +10718 2 2 13 11 4152 5726 5060 +10719 2 2 13 11 3818 5444 6189 +10720 2 2 13 11 4538 5756 4969 +10721 2 2 13 11 4539 4970 5757 +10722 2 2 13 11 4614 6530 5577 +10723 2 2 13 11 4344 5346 5672 +10724 2 2 13 11 3803 6002 6155 +10725 2 2 13 11 4279 5195 5814 +10726 2 2 13 11 3828 6457 5025 +10727 2 2 13 11 4245 5570 5551 +10728 2 2 13 11 3752 6578 5827 +10729 2 2 13 11 4259 6270 5101 +10730 2 2 13 11 4063 5417 5207 +10731 2 2 13 11 4064 5208 5418 +10732 2 2 13 11 4607 6298 6009 +10733 2 2 13 11 4608 6010 6299 +10734 2 2 13 11 4423 5304 6001 +10735 2 2 13 11 4373 5662 5082 +10736 2 2 13 11 3940 6709 6696 +10737 2 2 13 11 4359 5043 6245 +10738 2 2 13 11 3789 6325 5878 +10739 2 2 13 11 3790 5879 6326 +10740 2 2 13 11 4877 6817 6764 +10741 2 2 13 11 4218 5203 5471 +10742 2 2 13 11 4219 5472 5204 +10743 2 2 13 11 4374 5634 5257 +10744 2 2 13 11 4375 5258 5635 +10745 2 2 13 11 6627 3964 5992 +10746 2 2 13 11 3894 5577 6530 +10747 2 2 13 11 6628 5993 3965 +10748 2 2 13 11 3674 4988 6894 +10749 2 2 13 11 4143 5504 6846 +10750 2 2 13 11 4564 6810 6378 +10751 2 2 13 11 4968 6751 5781 +10752 2 2 13 11 4193 5030 5693 +10753 2 2 13 11 285 6663 4971 +10754 2 2 13 11 3697 6101 4957 +10755 2 2 13 11 4488 6386 5719 +10756 2 2 13 11 4489 5720 6387 +10757 2 2 13 11 3806 6265 6044 +10758 2 2 13 11 4366 5048 6269 +10759 2 2 13 11 3823 6128 4967 +10760 2 2 13 11 3865 6122 4952 +10761 2 2 13 11 3814 5221 5512 +10762 2 2 13 11 3771 6952 5228 +10763 2 2 13 11 320 5554 5363 +10764 2 2 13 11 256 5364 5555 +10765 2 2 13 11 4579 5789 5917 +10766 2 2 13 11 82 5094 5761 +10767 2 2 13 11 4575 5874 6012 +10768 2 2 13 11 4212 5348 5320 +10769 2 2 13 11 4161 5897 5173 +10770 2 2 13 11 4162 5174 5898 +10771 2 2 13 11 3694 6335 4878 +10772 2 2 13 11 4255 5551 5447 +10773 2 2 13 11 4079 5684 6598 +10774 2 2 13 11 4080 6599 5685 +10775 2 2 13 11 3993 6491 4957 +10776 2 2 13 11 3882 6405 5709 +10777 2 2 13 11 4248 5374 5804 +10778 2 2 13 11 3971 4977 6130 +10779 2 2 13 11 4480 6849 6619 +10780 2 2 13 11 4332 4986 5679 +10781 2 2 13 11 4143 5126 5818 +10782 2 2 13 11 4147 5609 5861 +10783 2 2 13 11 3868 5952 5513 +10784 2 2 13 11 4428 5259 5496 +10785 2 2 13 11 3731 5918 5008 +10786 2 2 13 11 3732 5009 5919 +10787 2 2 13 11 3762 5740 5313 +10788 2 2 13 11 3763 5316 5741 +10789 2 2 13 11 4569 6938 5223 +10790 2 2 13 11 4660 5524 6421 +10791 2 2 13 11 4582 5839 6740 +10792 2 2 13 11 4084 6231 5180 +10793 2 2 13 11 4338 5692 5758 +10794 2 2 13 11 4339 5759 5694 +10795 2 2 13 11 3905 5120 5978 +10796 2 2 13 11 3917 5392 6233 +10797 2 2 13 11 4654 5748 5230 +10798 2 2 13 11 4285 5423 5493 +10799 2 2 13 11 3825 5015 5610 +10800 2 2 13 11 3699 5642 5125 +10801 2 2 13 11 4328 5556 6116 +10802 2 2 13 11 4002 4989 6239 +10803 2 2 13 11 4189 5707 4967 +10804 2 2 13 11 4295 5655 5104 +10805 2 2 13 11 323 5404 324 +10806 2 2 13 11 252 5405 253 +10807 2 2 13 11 3930 5150 6078 +10808 2 2 13 11 3941 4974 5975 +10809 2 2 13 11 3942 5976 4975 +10810 2 2 13 11 4492 6568 4907 +10811 2 2 13 11 4199 4941 5858 +10812 2 2 13 11 127 128 5468 +10813 2 2 13 11 4400 6868 4908 +10814 2 2 13 11 4440 6708 6508 +10815 2 2 13 11 4496 5115 5549 +10816 2 2 13 11 4839 6205 5062 +10817 2 2 13 11 167 168 6524 +10818 2 2 13 11 53 54 6525 +10819 2 2 13 11 4575 6012 5071 +10820 2 2 13 11 3880 5494 6357 +10821 2 2 13 11 101 102 5385 +10822 2 2 13 11 3986 5443 5311 +10823 2 2 13 11 330 4972 6942 +10824 2 2 13 11 246 6943 4973 +10825 2 2 13 11 4144 5215 5590 +10826 2 2 13 11 5017 6090 6594 +10827 2 2 13 11 4145 5591 5216 +10828 2 2 13 11 4260 6082 4932 +10829 2 2 13 11 3915 4984 6563 +10830 2 2 13 11 148 5268 6381 +10831 2 2 13 11 316 5157 6004 +10832 2 2 13 11 260 6005 5158 +10833 2 2 13 11 3761 5433 5839 +10834 2 2 13 11 4679 5521 6575 +10835 2 2 13 11 84 6799 5667 +10836 2 2 13 11 4196 5395 6409 +10837 2 2 13 11 4225 4926 6300 +10838 2 2 13 11 4226 6301 4927 +10839 2 2 13 11 3758 6910 4894 +10840 2 2 13 11 3875 5638 5148 +10841 2 2 13 11 3989 4923 6159 +10842 2 2 13 11 3867 4983 6464 +10843 2 2 13 11 4119 5072 6182 +10844 2 2 13 11 4568 6349 5382 +10845 2 2 13 11 4120 6183 5073 +10846 2 2 13 11 4029 5837 5147 +10847 2 2 13 11 4141 5127 6185 +10848 2 2 13 11 3981 5124 6571 +10849 2 2 13 11 3874 4969 5955 +10850 2 2 13 11 3876 5956 4970 +10851 2 2 13 11 4138 5588 5168 +10852 2 2 13 11 4139 5169 5589 +10853 2 2 13 11 1 6268 98 +10854 2 2 13 11 90 91 5617 +10855 2 2 13 11 3693 5996 5825 +10856 2 2 13 11 4150 5154 6788 +10857 2 2 13 11 151 152 5777 +10858 2 2 13 11 3679 5054 6059 +10859 2 2 13 11 4481 5474 6905 +10860 2 2 13 11 4389 6388 5111 +10861 2 2 13 11 4390 5112 6389 +10862 2 2 13 11 4119 6172 5810 +10863 2 2 13 11 4120 5811 6173 +10864 2 2 13 11 4949 5286 6174 +10865 2 2 13 11 3740 6143 5121 +10866 2 2 13 11 3782 5688 5088 +10867 2 2 13 11 4188 6612 4932 +10868 2 2 13 11 4406 5597 5439 +10869 2 2 13 11 4614 5464 6530 +10870 2 2 13 11 3711 6630 5250 +10871 2 2 13 11 4557 5592 5095 +10872 2 2 13 11 130 131 6266 +10873 2 2 13 11 4612 6155 6002 +10874 2 2 13 11 3686 5063 5803 +10875 2 2 13 11 3812 6864 4965 +10876 2 2 13 11 3813 4966 6865 +10877 2 2 13 11 4570 5745 5241 +10878 2 2 13 11 4255 5145 5551 +10879 2 2 13 11 4265 5992 5712 +10880 2 2 13 11 4266 5713 5993 +10881 2 2 13 11 4420 5804 5497 +10882 2 2 13 11 4597 6216 6921 +10883 2 2 13 11 3860 5948 5071 +10884 2 2 13 11 3698 5067 6455 +10885 2 2 13 11 4402 5025 6457 +10886 2 2 13 11 4642 5788 6816 +10887 2 2 13 11 4513 5504 6382 +10888 2 2 13 11 3861 4922 6497 +10889 2 2 13 11 4183 5871 5608 +10890 2 2 13 11 3821 4947 6146 +10891 2 2 13 11 6594 6090 4330 +10892 2 2 13 11 4305 6437 5008 +10893 2 2 13 11 4306 5009 6438 +10894 2 2 13 11 86 5607 6538 +10895 2 2 13 11 4313 5641 5246 +10896 2 2 13 11 4048 5317 6028 +10897 2 2 13 11 4049 6029 5318 +10898 2 2 13 11 3934 6795 4978 +10899 2 2 13 11 3935 4979 6796 +10900 2 2 13 11 4186 5838 5125 +10901 2 2 13 11 4155 6577 5728 +10902 2 2 13 11 4459 6487 6559 +10903 2 2 13 11 4227 5186 5672 +10904 2 2 13 11 4024 5290 6119 +10905 2 2 13 11 4569 6108 6052 +10906 2 2 13 11 4023 4936 6616 +10907 2 2 13 11 4414 5934 4935 +10908 2 2 13 11 4262 5612 6070 +10909 2 2 13 11 4263 6071 5613 +10910 2 2 13 11 4778 6924 5897 +10911 2 2 13 11 4779 5898 6925 +10912 2 2 13 11 4137 5079 6095 +10913 2 2 13 11 4158 6738 5057 +10914 2 2 13 11 4402 5714 5025 +10915 2 2 13 11 3803 4942 6169 +10916 2 2 13 11 4655 6798 4987 +10917 2 2 13 11 3804 5006 5893 +10918 2 2 13 11 3926 5237 5608 +10919 2 2 13 11 3805 5894 5007 +10920 2 2 13 11 284 6673 6663 +10921 2 2 13 11 4239 5012 5793 +10922 2 2 13 11 4053 5149 6286 +10923 2 2 13 11 4240 5794 5013 +10924 2 2 13 11 4195 5621 6402 +10925 2 2 13 11 138 139 6011 +10926 2 2 13 11 4132 4957 6491 +10927 2 2 13 11 4108 5658 5355 +10928 2 2 13 11 89 6374 5167 +10929 2 2 13 11 4283 5832 6131 +10930 2 2 13 11 4284 6132 5833 +10931 2 2 13 11 4022 4985 5753 +10932 2 2 13 11 4249 6808 4914 +10933 2 2 13 11 4321 5171 5564 +10934 2 2 13 11 4406 4981 6831 +10935 2 2 13 11 4159 5061 6763 +10936 2 2 13 11 114 115 5394 +10937 2 2 13 11 3706 5598 6595 +10938 2 2 13 11 4334 6935 4993 +10939 2 2 13 11 3668 5060 5726 +10940 2 2 13 11 4519 5829 5066 +10941 2 2 13 11 4164 5034 6239 +10942 2 2 13 11 4168 5782 6562 +10943 2 2 13 11 4296 6416 4998 +10944 2 2 13 11 4448 4943 6015 +10945 2 2 13 11 4385 6028 5317 +10946 2 2 13 11 4386 5318 6029 +10947 2 2 13 11 4076 5882 4981 +10948 2 2 13 11 4176 5041 5661 +10949 2 2 13 11 4243 5677 5376 +10950 2 2 13 11 4118 4992 5827 +10951 2 2 13 11 4244 5377 5678 +10952 2 2 13 11 4091 4999 5983 +10953 2 2 13 11 4363 6414 5202 +10954 2 2 13 11 4380 5512 5221 +10955 2 2 13 11 4181 5866 6593 +10956 2 2 13 11 3900 5984 5144 +10957 2 2 13 11 4010 5807 5134 +10958 2 2 13 11 4124 5148 5638 +10959 2 2 13 11 4537 6332 5579 +10960 2 2 13 11 4400 5185 6838 +10961 2 2 13 11 135 136 5474 +10962 2 2 13 11 4014 5287 6543 +10963 2 2 13 11 4715 5709 6405 +10964 2 2 13 11 4377 6530 5464 +10965 2 2 13 11 3833 5808 5145 +10966 2 2 13 11 3874 5955 5690 +10967 2 2 13 11 3876 5691 5956 +10968 2 2 13 11 4527 5086 5953 +10969 2 2 13 11 4528 5954 5087 +10970 2 2 13 11 3660 6588 5321 +10971 2 2 13 11 3794 5431 5265 +10972 2 2 13 11 3795 5266 5432 +10973 2 2 13 11 4305 5008 5918 +10974 2 2 13 11 4701 6610 5608 +10975 2 2 13 11 4156 5955 4969 +10976 2 2 13 11 4306 5919 5009 +10977 2 2 13 11 4157 4970 5956 +10978 2 2 13 11 4327 5593 5902 +10979 2 2 13 11 4231 6169 4942 +10980 2 2 13 11 3843 6398 5230 +10981 2 2 13 11 4449 5988 4955 +10982 2 2 13 11 4400 6406 5005 +10983 2 2 13 11 4477 4945 6042 +10984 2 2 13 11 4463 6571 5124 +10985 2 2 13 11 3728 6012 5874 +10986 2 2 13 11 4765 4971 6663 +10987 2 2 13 11 145 146 6324 +10988 2 2 13 11 5051 6780 6274 +10989 2 2 13 11 4445 6363 5297 +10990 2 2 13 11 3792 6210 4895 +10991 2 2 13 11 3793 4896 6211 +10992 2 2 13 11 4418 5999 4940 +10993 2 2 13 11 136 137 6420 +10994 2 2 13 11 4318 6730 4961 +10995 2 2 13 11 3944 6727 6682 +10996 2 2 13 11 3978 5051 6274 +10997 2 2 13 11 3888 6039 4986 +10998 2 2 13 11 4334 4993 6026 +10999 2 2 13 11 3791 5896 5456 +11000 2 2 13 11 4340 6288 4911 +11001 2 2 13 11 4341 4912 6289 +11002 2 2 13 11 4302 5376 5677 +11003 2 2 13 11 4303 5678 5377 +11004 2 2 13 11 3901 5223 6938 +11005 2 2 13 11 3836 5624 5298 +11006 2 2 13 11 3837 5299 5625 +11007 2 2 13 11 4241 6217 5027 +11008 2 2 13 11 4242 5028 6218 +11009 2 2 13 11 4585 6357 5494 +11010 2 2 13 11 1 99 6268 +11011 2 2 13 11 3825 6922 5015 +11012 2 2 13 11 4615 6044 6265 +11013 2 2 13 11 168 6897 5031 +11014 2 2 13 11 53 5032 6898 +11015 2 2 13 11 83 84 5667 +11016 2 2 13 11 4897 6056 6627 +11017 2 2 13 11 4898 6628 6057 +11018 2 2 13 11 4763 6596 4997 +11019 2 2 13 11 4762 6938 5563 +11020 2 2 13 11 4305 5313 5740 +11021 2 2 13 11 4010 6837 4958 +11022 2 2 13 11 4164 5649 5222 +11023 2 2 13 11 4306 5741 5316 +11024 2 2 13 11 4459 6559 5762 +11025 2 2 13 11 3884 5467 5758 +11026 2 2 13 11 4137 6095 6736 +11027 2 2 13 11 4296 5978 5120 +11028 2 2 13 11 3702 5666 6421 +11029 2 2 13 11 337 5031 6897 +11030 2 2 13 11 239 6898 5032 +11031 2 2 13 11 4504 6233 5392 +11032 2 2 13 11 4163 5164 6235 +11033 2 2 13 11 290 5620 291 +11034 2 2 13 11 4101 6735 4948 +11035 2 2 13 11 4376 5848 5520 +11036 2 2 13 11 128 129 6024 +11037 2 2 13 11 3770 5357 6791 +11038 2 2 13 11 4427 4960 6220 +11039 2 2 13 11 106 107 6542 +11040 2 2 13 11 4217 5311 5443 +11041 2 2 13 11 4903 6892 5275 +11042 2 2 13 11 4389 5815 5486 +11043 2 2 13 11 4390 5487 5816 +11044 2 2 13 11 3968 5008 6437 +11045 2 2 13 11 3969 6438 5009 +11046 2 2 13 11 3832 5447 5551 +11047 2 2 13 11 325 6532 5168 +11048 2 2 13 11 251 5169 6533 +11049 2 2 13 11 3919 5857 6338 +11050 2 2 13 11 3650 5002 6200 +11051 2 2 13 11 3741 5905 5301 +11052 2 2 13 11 4830 6207 5622 +11053 2 2 13 11 4376 5267 5848 +11054 2 2 13 11 3830 5010 6386 +11055 2 2 13 11 3831 6387 5011 +11056 2 2 13 11 4011 6895 4949 +11057 2 2 13 11 3816 5457 5846 +11058 2 2 13 11 3817 5847 5458 +11059 2 2 13 11 4103 5559 5156 +11060 2 2 13 11 4498 6613 5519 +11061 2 2 13 11 4534 5727 5414 +11062 2 2 13 11 4259 4941 6270 +11063 2 2 13 11 4316 6154 4971 +11064 2 2 13 11 4383 5839 5433 +11065 2 2 13 11 4743 5667 6799 +11066 2 2 13 11 3846 5828 5337 +11067 2 2 13 11 4209 5037 6034 +11068 2 2 13 11 276 5626 277 +11069 2 2 13 11 4058 5080 5855 +11070 2 2 13 11 3716 5365 5430 +11071 2 2 13 11 4253 6318 5005 +11072 2 2 13 11 4253 5005 6103 +11073 2 2 13 11 4304 6274 6780 +11074 2 2 13 11 4249 4914 6164 +11075 2 2 13 11 4213 5064 5861 +11076 2 2 13 11 4241 5298 5624 +11077 2 2 13 11 3870 5414 6093 +11078 2 2 13 11 4242 5625 5299 +11079 2 2 13 11 4289 5293 5849 +11080 2 2 13 11 4290 5850 5294 +11081 2 2 13 11 4851 6219 5482 +11082 2 2 13 11 4380 4952 6229 +11083 2 2 13 11 3797 6759 6358 +11084 2 2 13 11 3748 5000 6785 +11085 2 2 13 11 3798 6359 6760 +11086 2 2 13 11 3992 6472 5047 +11087 2 2 13 11 4350 6500 5929 +11088 2 2 13 11 4620 6277 6398 +11089 2 2 13 11 4747 6908 5020 +11090 2 2 13 11 4748 5021 6909 +11091 2 2 13 11 4355 6251 6478 +11092 2 2 13 11 4356 6479 6252 +11093 2 2 13 11 3889 6459 4990 +11094 2 2 13 11 3890 4991 6460 +11095 2 2 13 11 4741 6028 5212 +11096 2 2 13 11 4742 5213 6029 +11097 2 2 13 11 4506 5249 5545 +11098 2 2 13 11 4041 5849 5293 +11099 2 2 13 11 4042 5294 5850 +11100 2 2 13 11 4170 5515 6125 +11101 2 2 13 11 3828 5025 6001 +11102 2 2 13 11 4231 5511 6084 +11103 2 2 13 11 4541 6543 5287 +11104 2 2 13 11 4186 5153 6896 +11105 2 2 13 11 4441 5509 5238 +11106 2 2 13 11 4270 6146 4947 +11107 2 2 13 11 4442 5239 5510 +11108 2 2 13 11 4607 5852 6098 +11109 2 2 13 11 4608 6099 5853 +11110 2 2 13 11 3713 4998 6416 +11111 2 2 13 11 3868 5606 6531 +11112 2 2 13 11 3937 6844 5140 +11113 2 2 13 11 3794 5224 5628 +11114 2 2 13 11 4154 6023 5172 +11115 2 2 13 11 3795 5629 5226 +11116 2 2 13 11 300 5550 6729 +11117 2 2 13 11 131 132 5596 +11118 2 2 13 11 4953 6151 6674 +11119 2 2 13 11 4275 5627 6088 +11120 2 2 13 11 3897 5072 5810 +11121 2 2 13 11 4751 5690 5955 +11122 2 2 13 11 4752 5956 5691 +11123 2 2 13 11 3898 5811 5073 +11124 2 2 13 11 133 4962 5986 +11125 2 2 13 11 294 6794 295 +11126 2 2 13 11 4804 6338 5857 +11127 2 2 13 11 4421 5465 6053 +11128 2 2 13 11 4601 5165 6240 +11129 2 2 13 11 336 6549 337 +11130 2 2 13 11 239 6550 240 +11131 2 2 13 11 3978 6247 5051 +11132 2 2 13 11 3844 5520 5848 +11133 2 2 13 11 4033 5086 6855 +11134 2 2 13 11 4758 6560 5122 +11135 2 2 13 11 4034 6856 5087 +11136 2 2 13 11 4566 5914 5624 +11137 2 2 13 11 4567 5625 5916 +11138 2 2 13 11 3752 4913 6578 +11139 2 2 13 11 4170 6125 5544 +11140 2 2 13 11 3994 5001 6018 +11141 2 2 13 11 3862 5775 6832 +11142 2 2 13 11 4694 6613 6889 +11143 2 2 13 11 3840 5089 5963 +11144 2 2 13 11 4093 5901 6644 +11145 2 2 13 11 4338 5758 5467 +11146 2 2 13 11 4239 5772 6054 +11147 2 2 13 11 4821 6384 6622 +11148 2 2 13 11 4679 5929 6500 +11149 2 2 13 11 4240 6055 5773 +11150 2 2 13 11 3729 6732 6918 +11151 2 2 13 11 4847 6562 5782 +11152 2 2 13 11 4583 5717 5427 +11153 2 2 13 11 4834 6832 5775 +11154 2 2 13 11 3791 5052 5896 +11155 2 2 13 11 3782 4976 6208 +11156 2 2 13 11 4147 6737 5302 +11157 2 2 13 11 4061 6792 5018 +11158 2 2 13 11 4062 5019 6793 +11159 2 2 13 11 4117 5564 5320 +11160 2 2 13 11 3692 5058 5873 +11161 2 2 13 11 3729 6918 5900 +11162 2 2 13 11 81 82 5761 +11163 2 2 13 11 4169 6124 5514 +11164 2 2 13 11 3753 4977 6094 +11165 2 2 13 11 4030 6447 5063 +11166 2 2 13 11 4068 5069 5750 +11167 2 2 13 11 4684 6598 5684 +11168 2 2 13 11 4685 5685 6599 +11169 2 2 13 11 4066 5557 6634 +11170 2 2 13 11 4039 6162 5023 +11171 2 2 13 11 4209 6197 5037 +11172 2 2 13 11 4067 6635 5558 +11173 2 2 13 11 4152 5060 6573 +11174 2 2 13 11 4295 5104 6404 +11175 2 2 13 11 5420 6742 6467 +11176 2 2 13 11 4195 6402 5990 +11177 2 2 13 11 5171 6907 5973 +11178 2 2 13 11 3822 5545 5249 +11179 2 2 13 11 4580 5255 6483 +11180 2 2 13 11 4128 6098 5852 +11181 2 2 13 11 4129 5853 6099 +11182 2 2 13 11 4368 6699 5039 +11183 2 2 13 11 4411 5663 6391 +11184 2 2 13 11 4116 5378 5525 +11185 2 2 13 11 4412 6392 5664 +11186 2 2 13 11 102 103 6340 +11187 2 2 13 11 4169 5531 6124 +11188 2 2 13 11 4437 6891 5074 +11189 2 2 13 11 4264 5065 6432 +11190 2 2 13 11 4024 6720 4983 +11191 2 2 13 11 4295 5144 5984 +11192 2 2 13 11 3869 6339 5338 +11193 2 2 13 11 295 5989 296 +11194 2 2 13 11 4482 5606 6190 +11195 2 2 13 11 3719 4978 6685 +11196 2 2 13 11 3720 6686 4979 +11197 2 2 13 11 4853 6709 5209 +11198 2 2 13 11 3694 5904 5068 +11199 2 2 13 11 4229 5893 5006 +11200 2 2 13 11 140 141 5693 +11201 2 2 13 11 4230 5007 5894 +11202 2 2 13 11 316 6004 317 +11203 2 2 13 11 259 6005 260 +11204 2 2 13 11 4109 5767 5351 +11205 2 2 13 11 4175 5384 6805 +11206 2 2 13 11 4506 5140 6844 +11207 2 2 13 11 4485 5552 5763 +11208 2 2 13 11 4555 4990 6424 +11209 2 2 13 11 4556 6425 4991 +11210 2 2 13 11 3664 5297 6363 +11211 2 2 13 11 4200 5548 6522 +11212 2 2 13 11 4440 5469 5331 +11213 2 2 13 11 4353 5475 5846 +11214 2 2 13 11 4354 5847 5476 +11215 2 2 13 11 4542 6620 6340 +11216 2 2 13 11 4128 6903 5010 +11217 2 2 13 11 4129 5011 6904 +11218 2 2 13 11 4141 5760 5479 +11219 2 2 13 11 4436 5167 6684 +11220 2 2 13 11 3820 5022 5802 +11221 2 2 13 11 4760 6775 6597 +11222 2 2 13 11 4660 6421 5666 +11223 2 2 13 11 3661 4996 6703 +11224 2 2 13 11 4225 6236 5746 +11225 2 2 13 11 4226 5747 6237 +11226 2 2 13 11 4110 5029 5812 +11227 2 2 13 11 3853 5733 5345 +11228 2 2 13 11 4186 5642 5153 +11229 2 2 13 11 4288 5506 5867 +11230 2 2 13 11 4392 5411 6453 +11231 2 2 13 11 4393 6454 5412 +11232 2 2 13 11 4520 6751 5732 +11233 2 2 13 11 4179 6705 5100 +11234 2 2 13 11 3951 6034 5037 +11235 2 2 13 11 4784 6272 5690 +11236 2 2 13 11 4785 5691 6273 +11237 2 2 13 11 4044 5109 6365 +11238 2 2 13 11 4045 6366 5110 +11239 2 2 13 11 3809 6052 6108 +11240 2 2 13 11 3895 5717 6493 +11241 2 2 13 11 4358 5047 6472 +11242 2 2 13 11 3939 5562 5315 +11243 2 2 13 11 4168 6562 5824 +11244 2 2 13 11 4255 5842 5145 +11245 2 2 13 11 3690 5767 5123 +11246 2 2 13 11 3680 6009 6298 +11247 2 2 13 11 3681 6299 6010 +11248 2 2 13 11 4302 5964 5109 +11249 2 2 13 11 4303 5110 5965 +11250 2 2 13 11 152 153 6664 +11251 2 2 13 11 68 69 6665 +11252 2 2 13 11 3845 4997 6936 +11253 2 2 13 11 160 161 5583 +11254 2 2 13 11 60 61 5584 +11255 2 2 13 11 3659 5005 6318 +11256 2 2 13 11 4409 6106 5596 +11257 2 2 13 11 4123 6528 5706 +11258 2 2 13 11 3808 5135 5783 +11259 2 2 13 11 4307 5020 5966 +11260 2 2 13 11 4308 5967 5021 +11261 2 2 13 11 3850 5609 5256 +11262 2 2 13 11 4835 6261 5119 +11263 2 2 13 11 4189 4967 6128 +11264 2 2 13 11 4422 5456 5896 +11265 2 2 13 11 3679 6196 5054 +11266 2 2 13 11 4291 5051 6247 +11267 2 2 13 11 4602 6391 5663 +11268 2 2 13 11 4603 5664 6392 +11269 2 2 13 11 268 6090 269 +11270 2 2 13 11 111 6026 4993 +11271 2 2 13 11 4559 6085 5849 +11272 2 2 13 11 4245 5145 5808 +11273 2 2 13 11 4560 5850 6086 +11274 2 2 13 11 4416 6670 5058 +11275 2 2 13 11 4866 6587 6013 +11276 2 2 13 11 4483 5139 5917 +11277 2 2 13 11 4601 6083 5913 +11278 2 2 13 11 4131 5071 5948 +11279 2 2 13 11 4011 5163 6902 +11280 2 2 13 11 93 94 6853 +11281 2 2 13 11 4436 6434 5167 +11282 2 2 13 11 3993 4957 6743 +11283 2 2 13 11 132 133 5986 +11284 2 2 13 11 3797 6583 5219 +11285 2 2 13 11 3798 5220 6584 +11286 2 2 13 11 4300 5486 5815 +11287 2 2 13 11 4301 5816 5487 +11288 2 2 13 11 4663 6878 5102 +11289 2 2 13 11 4664 5103 6879 +11290 2 2 13 11 3949 5044 6226 +11291 2 2 13 11 4184 5382 5973 +11292 2 2 13 11 4538 5238 6926 +11293 2 2 13 11 4539 6927 5239 +11294 2 2 13 11 4592 6114 5035 +11295 2 2 13 11 4593 5036 6115 +11296 2 2 13 11 4283 6131 5601 +11297 2 2 13 11 4284 5602 6132 +11298 2 2 13 11 3960 5035 6249 +11299 2 2 13 11 3961 6250 5036 +11300 2 2 13 11 4185 5963 5089 +11301 2 2 13 11 4493 5315 5562 +11302 2 2 13 11 4808 5925 5656 +11303 2 2 13 11 3936 5491 6440 +11304 2 2 13 11 3828 5590 5215 +11305 2 2 13 11 3829 5216 5591 +11306 2 2 13 11 3988 6622 6384 +11307 2 2 13 11 3834 6053 5465 +11308 2 2 13 11 4491 6890 6302 +11309 2 2 13 11 141 5146 5693 +11310 2 2 13 11 4259 5101 6011 +11311 2 2 13 11 286 5568 287 +11312 2 2 13 11 3762 6037 5027 +11313 2 2 13 11 4076 4963 6436 +11314 2 2 13 11 3763 5028 6038 +11315 2 2 13 11 3710 5764 6136 +11316 2 2 13 11 4132 6334 5896 +11317 2 2 13 11 285 6154 286 +11318 2 2 13 11 4186 5260 5838 +11319 2 2 13 11 4320 5952 5603 +11320 2 2 13 11 4006 5022 6498 +11321 2 2 13 11 4273 6683 6051 +11322 2 2 13 11 4809 6148 6368 +11323 2 2 13 11 4810 6369 6150 +11324 2 2 13 11 4207 5628 5224 +11325 2 2 13 11 4208 5226 5629 +11326 2 2 13 11 4798 6165 6783 +11327 2 2 13 11 4014 4992 6739 +11328 2 2 13 11 4830 6014 6647 +11329 2 2 13 11 127 5468 6931 +11330 2 2 13 11 4288 5147 5837 +11331 2 2 13 11 4361 6238 5243 +11332 2 2 13 11 4307 5457 6631 +11333 2 2 13 11 4308 6632 5458 +11334 2 2 13 11 4274 5750 5913 +11335 2 2 13 11 4837 6827 6249 +11336 2 2 13 11 4838 6250 6828 +11337 2 2 13 11 4054 4996 6719 +11338 2 2 13 11 4667 6187 5132 +11339 2 2 13 11 4795 6334 6491 +11340 2 2 13 11 4668 5133 6188 +11341 2 2 13 11 4782 6420 6857 +11342 2 2 13 11 3652 6223 6747 +11343 2 2 13 11 4267 6127 6829 +11344 2 2 13 11 4285 6297 5108 +11345 2 2 13 11 3827 6390 5202 +11346 2 2 13 11 4241 5624 5914 +11347 2 2 13 11 4242 5916 5625 +11348 2 2 13 11 3945 6587 5194 +11349 2 2 13 11 3726 5969 5108 +11350 2 2 13 11 4467 5177 6827 +11351 2 2 13 11 4468 6828 5178 +11352 2 2 13 11 4445 5297 6418 +11353 2 2 13 11 4431 6722 5282 +11354 2 2 13 11 3910 5243 6238 +11355 2 2 13 11 4432 5283 6723 +11356 2 2 13 11 4148 5439 5597 +11357 2 2 13 11 4193 5693 5146 +11358 2 2 13 11 4278 6196 6824 +11359 2 2 13 11 4346 6365 5109 +11360 2 2 13 11 4302 5489 6109 +11361 2 2 13 11 4303 6111 5490 +11362 2 2 13 11 4347 5110 6366 +11363 2 2 13 11 4788 5492 6508 +11364 2 2 13 11 303 6220 304 +11365 2 2 13 11 88 5167 6434 +11366 2 2 13 11 331 5966 332 +11367 2 2 13 11 244 5967 245 +11368 2 2 13 11 4641 6078 5725 +11369 2 2 13 11 3843 5748 6409 +11370 2 2 13 11 4314 5177 6426 +11371 2 2 13 11 4315 6427 5178 +11372 2 2 13 11 3945 6013 6587 +11373 2 2 13 11 4113 6315 5190 +11374 2 2 13 11 4183 5608 5237 +11375 2 2 13 11 4200 6522 6652 +11376 2 2 13 11 3814 5420 6467 +11377 2 2 13 11 4203 5068 5904 +11378 2 2 13 11 3832 5551 5570 +11379 2 2 13 11 4025 5522 6907 +11380 2 2 13 11 4179 6523 5119 +11381 2 2 13 11 4417 5230 6398 +11382 2 2 13 11 332 6908 333 +11383 2 2 13 11 243 6909 244 +11384 2 2 13 11 4351 5113 5942 +11385 2 2 13 11 4352 5943 5114 +11386 2 2 13 11 4373 5082 6480 +11387 2 2 13 11 3778 5760 5192 +11388 2 2 13 11 4482 6531 5606 +11389 2 2 13 11 4928 5321 6588 +11390 2 2 13 11 3758 5818 5126 +11391 2 2 13 11 283 6673 284 +11392 2 2 13 11 4438 6035 6298 +11393 2 2 13 11 4439 6299 6036 +11394 2 2 13 11 324 6532 325 +11395 2 2 13 11 251 6533 252 +11396 2 2 13 11 4580 6483 6021 +11397 2 2 13 11 4350 6162 6292 +11398 2 2 13 11 294 5043 6794 +11399 2 2 13 11 4171 6059 5054 +11400 2 2 13 11 4661 5499 6826 +11401 2 2 13 11 4289 5349 5869 +11402 2 2 13 11 4290 5870 5350 +11403 2 2 13 11 4191 6431 5118 +11404 2 2 13 11 3711 5179 5856 +11405 2 2 13 11 4289 5849 6085 +11406 2 2 13 11 4290 6086 5850 +11407 2 2 13 11 4697 6701 4984 +11408 2 2 13 11 3807 5069 6734 +11409 2 2 13 11 3990 5039 6699 +11410 2 2 13 11 3768 5272 6693 +11411 2 2 13 11 3954 6495 6836 +11412 2 2 13 11 4059 6684 5167 +11413 2 2 13 11 3834 5093 6053 +11414 2 2 13 11 153 154 5668 +11415 2 2 13 11 67 68 5669 +11416 2 2 13 11 3850 5074 6891 +11417 2 2 13 11 108 109 5604 +11418 2 2 13 11 4614 5827 6578 +11419 2 2 13 11 3818 5573 6896 +11420 2 2 13 11 3927 5190 6315 +11421 2 2 13 11 4154 5291 6023 +11422 2 2 13 11 4401 5621 5569 +11423 2 2 13 11 307 5622 308 +11424 2 2 13 11 3804 5893 5981 +11425 2 2 13 11 4383 5092 6379 +11426 2 2 13 11 3805 5982 5894 +11427 2 2 13 11 272 5347 6147 +11428 2 2 13 11 4374 6393 5628 +11429 2 2 13 11 4375 5629 6394 +11430 2 2 13 11 3671 5040 6084 +11431 2 2 13 11 4196 6362 5125 +11432 2 2 13 11 4188 5091 5884 +11433 2 2 13 11 304 6452 305 +11434 2 2 13 11 4879 6329 6724 +11435 2 2 13 11 4323 6368 6148 +11436 2 2 13 11 4324 6150 6369 +11437 2 2 13 11 3939 5730 5562 +11438 2 2 13 11 4224 6886 6039 +11439 2 2 13 11 4340 5298 6037 +11440 2 2 13 11 4341 6038 5299 +11441 2 2 13 11 4236 5961 5928 +11442 2 2 13 11 3668 5541 5990 +11443 2 2 13 11 4986 6039 6886 +11444 2 2 13 11 4832 6668 6286 +11445 2 2 13 11 3682 6749 5160 +11446 2 2 13 11 4570 6440 5491 +11447 2 2 13 11 3683 5161 6750 +11448 2 2 13 11 3698 6455 5912 +11449 2 2 13 11 4724 5470 6711 +11450 2 2 13 11 4099 5869 5349 +11451 2 2 13 11 4100 5350 5870 +11452 2 2 13 11 4569 5223 6108 +11453 2 2 13 11 4346 6734 5069 +11454 2 2 13 11 4025 5778 5522 +11455 2 2 13 11 4314 6426 4974 +11456 2 2 13 11 4315 4975 6427 +11457 2 2 13 11 3684 5257 5634 +11458 2 2 13 11 3685 5635 5258 +11459 2 2 13 11 3731 5008 6109 +11460 2 2 13 11 4513 6276 5519 +11461 2 2 13 11 3732 6111 5009 +11462 2 2 13 11 4003 5768 5184 +11463 2 2 13 11 3774 5911 5122 +11464 2 2 13 11 4087 5270 6603 +11465 2 2 13 11 5608 5871 6887 +11466 2 2 13 11 281 5310 6537 +11467 2 2 13 11 3835 5724 5191 +11468 2 2 13 11 3819 5484 5736 +11469 2 2 13 11 146 6435 5131 +11470 2 2 13 11 3957 6850 6494 +11471 2 2 13 11 4197 5305 5836 +11472 2 2 13 11 3694 5068 6335 +11473 2 2 13 11 4031 6418 5297 +11474 2 2 13 11 3825 5196 6488 +11475 2 2 13 11 4672 6503 5045 +11476 2 2 13 11 3982 5081 6227 +11477 2 2 13 11 4673 5046 6504 +11478 2 2 13 11 4454 6776 5780 +11479 2 2 13 11 4035 5994 5070 +11480 2 2 13 11 4566 5624 6478 +11481 2 2 13 11 4567 6479 5625 +11482 2 2 13 11 3727 5039 6262 +11483 2 2 13 11 4258 6590 5997 +11484 2 2 13 11 3684 5634 6396 +11485 2 2 13 11 4054 6719 5407 +11486 2 2 13 11 3685 6397 5635 +11487 2 2 13 11 3705 6451 5790 +11488 2 2 13 11 3996 6926 5238 +11489 2 2 13 11 3997 5239 6927 +11490 2 2 13 11 4274 5913 6083 +11491 2 2 13 11 4675 6671 5300 +11492 2 2 13 11 138 5101 6857 +11493 2 2 13 11 4526 5596 6106 +11494 2 2 13 11 4591 6136 5764 +11495 2 2 13 11 4192 5485 6292 +11496 2 2 13 11 4583 5706 6528 +11497 2 2 13 11 4536 5928 5961 +11498 2 2 13 11 4369 6821 5387 +11499 2 2 13 11 4371 5388 6822 +11500 2 2 13 11 4456 6727 6072 +11501 2 2 13 11 3672 6279 5026 +11502 2 2 13 11 4544 5679 6886 +11503 2 2 13 11 4819 6694 5869 +11504 2 2 13 11 4820 5870 6695 +11505 2 2 13 11 4179 5474 6420 +11506 2 2 13 11 4644 5218 5776 +11507 2 2 13 11 4627 5182 6096 +11508 2 2 13 11 4278 5054 6196 +11509 2 2 13 11 4628 6097 5183 +11510 2 2 13 11 4132 6491 6334 +11511 2 2 13 11 4547 5981 5893 +11512 2 2 13 11 4548 5894 5982 +11513 2 2 13 11 122 6569 6608 +11514 2 2 13 11 4431 5282 6924 +11515 2 2 13 11 4432 6925 5283 +11516 2 2 13 11 4730 6931 5468 +11517 2 2 13 11 4498 5351 5767 +11518 2 2 13 11 4130 5895 5233 +11519 2 2 13 11 3978 4998 6247 +11520 2 2 13 11 125 126 5695 +11521 2 2 13 11 4607 6009 5461 +11522 2 2 13 11 4608 5463 6010 +11523 2 2 13 11 4527 5953 6194 +11524 2 2 13 11 4528 6195 5954 +11525 2 2 13 11 3960 6827 5177 +11526 2 2 13 11 3961 5178 6828 +11527 2 2 13 11 271 6873 5347 +11528 2 2 13 11 4028 5186 5809 +11529 2 2 13 11 3900 5144 6083 +11530 2 2 13 11 4894 6142 5075 +11531 2 2 13 11 3726 5108 6297 +11532 2 2 13 11 4620 5307 6277 +11533 2 2 13 11 336 5055 6549 +11534 2 2 13 11 240 6550 5056 +11535 2 2 13 11 4195 5569 5621 +11536 2 2 13 11 4463 5124 6797 +11537 2 2 13 11 4756 5636 6867 +11538 2 2 13 11 4757 6869 5637 +11539 2 2 13 11 4586 5979 5152 +11540 2 2 13 11 4775 6896 5573 +11541 2 2 13 11 3809 6108 5076 +11542 2 2 13 11 3826 5804 5374 +11543 2 2 13 11 4204 5363 5554 +11544 2 2 13 11 4205 5555 5364 +11545 2 2 13 11 4069 6773 4987 +11546 2 2 13 11 3682 5160 5914 +11547 2 2 13 11 3683 5916 5161 +11548 2 2 13 11 4488 5719 6786 +11549 2 2 13 11 4489 6787 5720 +11550 2 2 13 11 4179 5100 6523 +11551 2 2 13 11 311 5663 312 +11552 2 2 13 11 264 5664 265 +11553 2 2 13 11 4355 5251 6251 +11554 2 2 13 11 4356 6252 5252 +11555 2 2 13 11 3826 5016 6151 +11556 2 2 13 11 3958 5082 6883 +11557 2 2 13 11 3978 6274 5026 +11558 2 2 13 11 4002 6239 5034 +11559 2 2 13 11 4457 5062 6205 +11560 2 2 13 11 3655 6716 5165 +11561 2 2 13 11 4011 5776 5218 +11562 2 2 13 11 4193 5766 5217 +11563 2 2 13 11 3968 5636 5376 +11564 2 2 13 11 3969 5377 5637 +11565 2 2 13 11 288 6564 5362 +11566 2 2 13 11 4181 5737 5193 +11567 2 2 13 11 4217 5443 5998 +11568 2 2 13 11 3968 6867 5636 +11569 2 2 13 11 3969 5637 6869 +11570 2 2 13 11 4275 5974 5911 +11571 2 2 13 11 4269 5163 6174 +11572 2 2 13 11 4568 5368 5845 +11573 2 2 13 11 282 6537 5372 +11574 2 2 13 11 4487 6777 5880 +11575 2 2 13 11 4287 6724 6329 +11576 2 2 13 11 4402 6457 5859 +11577 2 2 13 11 4403 5860 6458 +11578 2 2 13 11 3801 6797 5124 +11579 2 2 13 11 4766 6907 5522 +11580 2 2 13 11 4345 6400 5994 +11581 2 2 13 11 4584 5407 6719 +11582 2 2 13 11 4271 6203 5647 +11583 2 2 13 11 4272 5648 6204 +11584 2 2 13 11 4274 5269 5750 +11585 2 2 13 11 3689 4999 6448 +11586 2 2 13 11 3981 5017 6594 +11587 2 2 13 11 4262 5136 6372 +11588 2 2 13 11 4263 6373 5137 +11589 2 2 13 11 3863 5173 5897 +11590 2 2 13 11 3864 5898 5174 +11591 2 2 13 11 4282 6228 5680 +11592 2 2 13 11 4269 5989 5116 +11593 2 2 13 11 4104 5373 6698 +11594 2 2 13 11 4194 5262 5805 +11595 2 2 13 11 4986 6886 5679 +11596 2 2 13 11 4396 5018 6178 +11597 2 2 13 11 4397 6179 5019 +11598 2 2 13 11 4278 6093 5054 +11599 2 2 13 11 4585 6433 5650 +11600 2 2 13 11 4357 5240 6650 +11601 2 2 13 11 3930 6078 6681 +11602 2 2 13 11 4033 6855 5719 +11603 2 2 13 11 4034 5720 6856 +11604 2 2 13 11 3937 6145 6844 +11605 2 2 13 11 4337 5607 5946 +11606 2 2 13 11 4859 6063 6017 +11607 2 2 13 11 3806 5155 6265 +11608 2 2 13 11 3848 5519 6276 +11609 2 2 13 11 4344 5084 6311 +11610 2 2 13 11 4475 5160 6749 +11611 2 2 13 11 4476 6750 5161 +11612 2 2 13 11 4291 6512 5051 +11613 2 2 13 11 167 6524 5077 +11614 2 2 13 11 54 5078 6525 +11615 2 2 13 11 4194 5170 6450 +11616 2 2 13 11 4147 5861 6737 +11617 2 2 13 11 4823 6736 6095 +11618 2 2 13 11 4248 5856 5179 +11619 2 2 13 11 4214 6153 5198 +11620 2 2 13 11 4360 5455 6324 +11621 2 2 13 11 4559 5849 6459 +11622 2 2 13 11 4560 6460 5850 +11623 2 2 13 11 3725 5704 5247 +11624 2 2 13 11 4292 6207 5214 +11625 2 2 13 11 4297 6335 5068 +11626 2 2 13 11 4727 6463 6385 +11627 2 2 13 11 3692 6733 5058 +11628 2 2 13 11 4163 5764 5164 +11629 2 2 13 11 3794 5265 5692 +11630 2 2 13 11 3889 5514 6459 +11631 2 2 13 11 3890 6460 5515 +11632 2 2 13 11 3795 5694 5266 +11633 2 2 13 11 4486 6880 5214 +11634 2 2 13 11 4707 6824 6196 +11635 2 2 13 11 3866 6309 5084 +11636 2 2 13 11 4344 5672 6202 +11637 2 2 13 11 3843 6409 6687 +11638 2 2 13 11 4004 5075 6142 +11639 2 2 13 11 4192 6017 6063 +11640 2 2 13 11 3869 5338 6225 +11641 2 2 13 11 4261 5576 5704 +11642 2 2 13 11 3960 6249 6827 +11643 2 2 13 11 3961 6828 6250 +11644 2 2 13 11 4011 6174 5163 +11645 2 2 13 11 4483 6577 5831 +11646 2 2 13 11 4809 5719 6855 +11647 2 2 13 11 4810 6856 5720 +11648 2 2 13 11 269 6707 270 +11649 2 2 13 11 3980 5881 6319 +11650 2 2 13 11 3654 6133 5045 +11651 2 2 13 11 3653 5046 6134 +11652 2 2 13 11 3691 5234 6689 +11653 2 2 13 11 3970 5040 6671 +11654 2 2 13 11 143 144 5907 +11655 2 2 13 11 4759 5912 6455 +11656 2 2 13 11 3655 5165 6118 +11657 2 2 13 11 4604 6163 5505 +11658 2 2 13 11 4224 5191 5724 +11659 2 2 13 11 4239 6054 5529 +11660 2 2 13 11 4325 5548 5547 +11661 2 2 13 11 4240 5530 6055 +11662 2 2 13 11 4830 6647 6207 +11663 2 2 13 11 3906 6490 5381 +11664 2 2 13 11 4522 6645 5072 +11665 2 2 13 11 3994 6018 5175 +11666 2 2 13 11 4523 5073 6646 +11667 2 2 13 11 4041 6251 5251 +11668 2 2 13 11 4042 5252 6252 +11669 2 2 13 11 4558 5134 6946 +11670 2 2 13 11 4147 5699 5256 +11671 2 2 13 11 4028 6692 5049 +11672 2 2 13 11 4027 5066 6560 +11673 2 2 13 11 4424 6276 6382 +11674 2 2 13 11 4545 5812 6655 +11675 2 2 13 11 3993 6743 5074 +11676 2 2 13 11 4274 6083 5144 +11677 2 2 13 11 4547 6803 5150 +11678 2 2 13 11 4115 6751 5945 +11679 2 2 13 11 4227 5672 5346 +11680 2 2 13 11 4548 5151 6804 +11681 2 2 13 11 3739 6042 5175 +11682 2 2 13 11 4518 6537 5310 +11683 2 2 13 11 4203 6121 5068 +11684 2 2 13 11 3708 5117 6198 +11685 2 2 13 11 135 5474 6660 +11686 2 2 13 11 4534 6718 5727 +11687 2 2 13 11 3888 5841 6116 +11688 2 2 13 11 4836 5780 6776 +11689 2 2 13 11 4369 6243 5885 +11690 2 2 13 11 4371 5886 6244 +11691 2 2 13 11 4252 6279 5392 +11692 2 2 13 11 4054 6242 5253 +11693 2 2 13 11 5150 6803 6078 +11694 2 2 13 11 4164 5222 5732 +11695 2 2 13 11 3909 5100 6705 +11696 2 2 13 11 163 5369 6327 +11697 2 2 13 11 58 6328 5370 +11698 2 2 13 11 4253 5140 6318 +11699 2 2 13 11 3689 6095 5079 +11700 2 2 13 11 3933 6834 5922 +11701 2 2 13 11 4185 5089 6544 +11702 2 2 13 11 4545 6152 5812 +11703 2 2 13 11 4448 5165 6716 +11704 2 2 13 11 3791 6413 5001 +11705 2 2 13 11 4068 5750 5269 +11706 2 2 13 11 4381 6860 5038 +11707 2 2 13 11 4155 5728 5332 +11708 2 2 13 11 4572 6634 5557 +11709 2 2 13 11 4573 5558 6635 +11710 2 2 13 11 74 6380 5386 +11711 2 2 13 11 4467 5333 6839 +11712 2 2 13 11 3840 5786 5587 +11713 2 2 13 11 4468 6840 5334 +11714 2 2 13 11 4260 5665 5563 +11715 2 2 13 11 4445 6488 5196 +11716 2 2 13 11 4616 6167 5336 +11717 2 2 13 11 4643 5355 5658 +11718 2 2 13 11 92 93 5806 +11719 2 2 13 11 3662 5129 6303 +11720 2 2 13 11 3663 6304 5130 +11721 2 2 13 11 103 104 5980 +11722 2 2 13 11 4185 5361 5654 +11723 2 2 13 11 4812 6747 6565 +11724 2 2 13 11 4527 5132 6187 +11725 2 2 13 11 4528 6188 5133 +11726 2 2 13 11 4417 6398 6277 +11727 2 2 13 11 3974 5214 6207 +11728 2 2 13 11 4479 6286 6668 +11729 2 2 13 11 4701 6659 6610 +11730 2 2 13 11 4180 5718 5546 +11731 2 2 13 11 4210 6447 5159 +11732 2 2 13 11 3697 5284 6711 +11733 2 2 13 11 3825 6488 5796 +11734 2 2 13 11 4241 5914 5160 +11735 2 2 13 11 4242 5161 5916 +11736 2 2 13 11 4317 6539 5063 +11737 2 2 13 11 4271 6096 5182 +11738 2 2 13 11 4272 5183 6097 +11739 2 2 13 11 4410 5426 6323 +11740 2 2 13 11 4222 5190 5968 +11741 2 2 13 11 3990 6699 6858 +11742 2 2 13 11 4265 5168 6532 +11743 2 2 13 11 4266 6533 5169 +11744 2 2 13 11 3927 5968 5190 +11745 2 2 13 11 4215 6664 5668 +11746 2 2 13 11 4216 5669 6665 +11747 2 2 13 11 3797 5434 6583 +11748 2 2 13 11 3798 6584 5435 +11749 2 2 13 11 3665 6185 5127 +11750 2 2 13 11 4300 5387 6821 +11751 2 2 13 11 4301 6822 5388 +11752 2 2 13 11 4512 6588 5950 +11753 2 2 13 11 4942 6429 5197 +11754 2 2 13 11 4271 5157 5939 +11755 2 2 13 11 4272 5940 5158 +11756 2 2 13 11 4559 6459 5514 +11757 2 2 13 11 4560 5515 6460 +11758 2 2 13 11 4124 5638 5448 +11759 2 2 13 11 4738 6344 5146 +11760 2 2 13 11 3662 6368 5129 +11761 2 2 13 11 3663 5130 6369 +11762 2 2 13 11 4457 5448 5638 +11763 2 2 13 11 4416 5058 6733 +11764 2 2 13 11 4326 6561 5128 +11765 2 2 13 11 3952 5172 6023 +11766 2 2 13 11 4431 6327 5369 +11767 2 2 13 11 4432 5370 6328 +11768 2 2 13 11 4258 5735 6590 +11769 2 2 13 11 4423 5268 6350 +11770 2 2 13 11 4455 5386 6380 +11771 2 2 13 11 4227 5809 5186 +11772 2 2 13 11 4576 5495 6706 +11773 2 2 13 11 4061 5141 6792 +11774 2 2 13 11 4062 6793 5142 +11775 2 2 13 11 3797 6358 5035 +11776 2 2 13 11 3798 5036 6359 +11777 2 2 13 11 4297 5068 6401 +11778 2 2 13 11 4265 5712 5445 +11779 2 2 13 11 4266 5446 5713 +11780 2 2 13 11 4243 5376 5636 +11781 2 2 13 11 4244 5637 5377 +11782 2 2 13 11 4013 6672 6431 +11783 2 2 13 11 4531 6654 5991 +11784 2 2 13 11 4494 6275 5769 +11785 2 2 13 11 4349 5587 5786 +11786 2 2 13 11 4179 5119 6905 +11787 2 2 13 11 4194 6450 6456 +11788 2 2 13 11 3713 5729 5332 +11789 2 2 13 11 3814 5512 6137 +11790 2 2 13 11 4378 5972 5565 +11791 2 2 13 11 4655 6919 6798 +11792 2 2 13 11 4271 5939 6203 +11793 2 2 13 11 4272 6204 5940 +11794 2 2 13 11 4292 5622 6207 +11795 2 2 13 11 4330 5124 6594 +11796 2 2 13 11 4268 5572 5902 +11797 2 2 13 11 4020 6345 5282 +11798 2 2 13 11 4021 5283 6346 +11799 2 2 13 11 3974 6207 6647 +11800 2 2 13 11 4322 6748 5121 +11801 2 2 13 11 4728 6608 6569 +11802 2 2 13 11 4640 5281 5844 +11803 2 2 13 11 4428 6715 5259 +11804 2 2 13 11 4512 5950 5657 +11805 2 2 13 11 3652 5307 6223 +11806 2 2 13 11 312 5663 5822 +11807 2 2 13 11 264 5823 5664 +11808 2 2 13 11 3810 5051 6512 +11809 2 2 13 11 3982 6227 6876 +11810 2 2 13 11 4319 6385 5191 +11811 2 2 13 11 4271 6004 5157 +11812 2 2 13 11 4272 5158 6005 +11813 2 2 13 11 3838 5387 5815 +11814 2 2 13 11 3839 5816 5388 +11815 2 2 13 11 76 77 5883 +11816 2 2 13 11 4055 6648 5111 +11817 2 2 13 11 4056 5112 6649 +11818 2 2 13 11 3650 5229 6025 +11819 2 2 13 11 121 6608 5047 +11820 2 2 13 11 4171 5414 5727 +11821 2 2 13 11 4932 6612 5665 +11822 2 2 13 11 4221 6377 5193 +11823 2 2 13 11 3773 5119 6523 +11824 2 2 13 11 4307 5966 6942 +11825 2 2 13 11 317 6004 5182 +11826 2 2 13 11 4308 6943 5967 +11827 2 2 13 11 259 5183 6005 +11828 2 2 13 11 4416 6141 6670 +11829 2 2 13 11 4030 5063 6539 +11830 2 2 13 11 4887 6496 6417 +11831 2 2 13 11 3810 6780 5051 +11832 2 2 13 11 4405 6225 5338 +11833 2 2 13 11 3670 6715 5095 +11834 2 2 13 11 109 6581 5604 +11835 2 2 13 11 4436 5946 5607 +11836 2 2 13 11 4907 6670 6141 +11837 2 2 13 11 5104 6950 6404 +11838 2 2 13 11 4427 5378 6383 +11839 2 2 13 11 4166 5942 5639 +11840 2 2 13 11 4167 5640 5943 +11841 2 2 13 11 4727 5232 6230 +11842 2 2 13 11 3937 5140 6296 +11843 2 2 13 11 3808 6852 5135 +11844 2 2 13 11 4191 5289 6047 +11845 2 2 13 11 4411 5822 5663 +11846 2 2 13 11 4412 5664 5823 +11847 2 2 13 11 4088 5805 5262 +11848 2 2 13 11 4006 6498 5131 +11849 2 2 13 11 4521 6640 5792 +11850 2 2 13 11 312 5822 313 +11851 2 2 13 11 263 5823 264 +11852 2 2 13 11 149 6350 5268 +11853 2 2 13 11 4443 6227 5454 +11854 2 2 13 11 4674 6319 5881 +11855 2 2 13 11 4024 6119 6720 +11856 2 2 13 11 4669 5796 6488 +11857 2 2 13 11 2 123 6569 +11858 2 2 13 11 4309 5143 6513 +11859 2 2 13 11 4151 5427 5717 +11860 2 2 13 11 3729 5813 6732 +11861 2 2 13 11 4472 5357 5775 +11862 2 2 13 11 4347 5135 6852 +11863 2 2 13 11 4420 5722 5339 +11864 2 2 13 11 4261 5704 6257 +11865 2 2 13 11 4926 6316 5352 +11866 2 2 13 11 4927 5353 6317 +11867 2 2 13 11 4249 5139 6808 +11868 2 2 13 11 4250 5263 6370 +11869 2 2 13 11 3823 5358 6128 +11870 2 2 13 11 4251 6371 5264 +11871 2 2 13 11 5118 6431 6672 +11872 2 2 13 11 4428 6514 6213 +11873 2 2 13 11 4500 6950 5104 +11874 2 2 13 11 3846 5838 5260 +11875 2 2 13 11 3871 5565 5972 +11876 2 2 13 11 4339 5938 5250 +11877 2 2 13 11 3971 6417 6496 +11878 2 2 13 11 4447 5900 5808 +11879 2 2 13 11 4200 5547 5548 +11880 2 2 13 11 4074 5469 6508 +11881 2 2 13 11 3981 6594 5124 +11882 2 2 13 11 3878 6706 5495 +11883 2 2 13 11 4116 6383 5378 +11884 2 2 13 11 3982 6876 5743 +11885 2 2 13 11 4114 5198 6234 +11886 2 2 13 11 4152 6137 5512 +11887 2 2 13 11 3758 5126 6910 +11888 2 2 13 11 126 6931 5695 +11889 2 2 13 11 4456 6452 6727 +11890 2 2 13 11 4392 5282 6345 +11891 2 2 13 11 4393 6346 5283 +11892 2 2 13 11 4036 5408 6066 +11893 2 2 13 11 146 147 6435 +11894 2 2 13 11 3983 5128 6561 +11895 2 2 13 11 3818 6896 5153 +11896 2 2 13 11 4213 6175 5274 +11897 2 2 13 11 4159 6265 5155 +11898 2 2 13 11 4574 6051 6683 +11899 2 2 13 11 4588 5407 5958 +11900 2 2 13 11 2 6569 122 +11901 2 2 13 11 5511 6843 6084 +11902 2 2 13 11 101 5385 6769 +11903 2 2 13 11 4077 6168 5280 +11904 2 2 13 11 3701 5563 5665 +11905 2 2 13 11 4296 5723 6756 +11906 2 2 13 11 4387 6585 5100 +11907 2 2 13 11 4338 6231 5692 +11908 2 2 13 11 4228 6025 5229 +11909 2 2 13 11 4345 5994 5248 +11910 2 2 13 11 4017 5097 6546 +11911 2 2 13 11 4298 5295 6770 +11912 2 2 13 11 4299 6771 5296 +11913 2 2 13 11 4018 6547 5098 +11914 2 2 13 11 4296 6756 6044 +11915 2 2 13 11 5040 5300 6671 +11916 2 2 13 11 4212 5320 6349 +11917 2 2 13 11 4510 6030 5173 +11918 2 2 13 11 4511 5174 6031 +11919 2 2 13 11 4960 6727 6452 +11920 2 2 13 11 4089 5519 6613 +11921 2 2 13 11 4695 5441 6060 +11922 2 2 13 11 4696 6061 5442 +11923 2 2 13 11 4358 5166 6140 +11924 2 2 13 11 4692 5659 5963 +11925 2 2 13 11 4194 5937 5170 +11926 2 2 13 11 3974 6816 5214 +11927 2 2 13 11 3699 5125 6362 +11928 2 2 13 11 3772 6718 5752 +11929 2 2 13 11 4261 5877 6721 +11930 2 2 13 11 4355 6341 5251 +11931 2 2 13 11 4356 5252 6343 +11932 2 2 13 11 4753 5969 6623 +11933 2 2 13 11 284 6663 285 +11934 2 2 13 11 4279 6181 5195 +11935 2 2 13 11 3849 6323 5426 +11936 2 2 13 11 4472 6791 5357 +11937 2 2 13 11 3688 6808 5139 +11938 2 2 13 11 4072 6675 5076 +11939 2 2 13 11 3913 6941 6041 +11940 2 2 13 11 3792 5188 6210 +11941 2 2 13 11 3793 6211 5189 +11942 2 2 13 11 3835 5191 6385 +11943 2 2 13 11 4247 5175 6018 +11944 2 2 13 11 3850 6545 5074 +11945 2 2 13 11 4160 5337 5828 +11946 2 2 13 11 4485 6436 5644 +11947 2 2 13 11 4218 6759 5219 +11948 2 2 13 11 4219 5220 6760 +11949 2 2 13 11 4826 6576 5600 +11950 2 2 13 11 3931 6192 5151 +11951 2 2 13 11 3867 6464 5728 +11952 2 2 13 11 3788 6737 5064 +11953 2 2 13 11 121 122 6608 +11954 2 2 13 11 4086 5187 6284 +11955 2 2 13 11 4213 5609 6332 +11956 2 2 13 11 3870 5198 6153 +11957 2 2 13 11 4429 6862 5343 +11958 2 2 13 11 4430 5344 6863 +11959 2 2 13 11 4460 6895 5218 +11960 2 2 13 11 3740 5121 6748 +11961 2 2 13 11 4035 5248 5994 +11962 2 2 13 11 4140 5090 6817 +11963 2 2 13 11 3914 5398 6144 +11964 2 2 13 11 4344 6311 5346 +11965 2 2 13 11 4435 6597 6775 +11966 2 2 13 11 4329 5844 5281 +11967 2 2 13 11 4937 6041 6941 +11968 2 2 13 11 3930 6235 5164 +11969 2 2 13 11 4363 5253 6242 +11970 2 2 13 11 4336 5478 5828 +11971 2 2 13 11 3945 5194 6778 +11972 2 2 13 11 4300 5815 5387 +11973 2 2 13 11 4301 5388 5816 +11974 2 2 13 11 4271 5182 6004 +11975 2 2 13 11 4272 6005 5183 +11976 2 2 13 11 3710 5180 6509 +11977 2 2 13 11 3737 6194 5953 +11978 2 2 13 11 3823 6784 5107 +11979 2 2 13 11 3738 5954 6195 +11980 2 2 13 11 4422 5482 6219 +11981 2 2 13 11 4625 6271 5413 +11982 2 2 13 11 4370 6223 5307 +11983 2 2 13 11 4597 6911 5500 +11984 2 2 13 11 4323 5129 6368 +11985 2 2 13 11 4324 6369 5130 +11986 2 2 13 11 3719 6685 5212 +11987 2 2 13 11 3720 5213 6686 +11988 2 2 13 11 3920 5262 6456 +11989 2 2 13 11 3872 5413 6271 +11990 2 2 13 11 3911 5527 6070 +11991 2 2 13 11 3912 6071 5528 +11992 2 2 13 11 5097 6637 6049 +11993 2 2 13 11 5098 6050 6638 +11994 2 2 13 11 3789 5445 5712 +11995 2 2 13 11 3790 5713 5446 +11996 2 2 13 11 334 5909 335 +11997 2 2 13 11 241 5910 242 +11998 2 2 13 11 4596 6473 5406 +11999 2 2 13 11 4765 6663 6673 +12000 2 2 13 11 4463 5451 5874 +12001 2 2 13 11 137 138 6857 +12002 2 2 13 11 4599 5653 6110 +12003 2 2 13 11 4384 6552 5279 +12004 2 2 13 11 3796 6788 5154 +12005 2 2 13 11 287 5568 6564 +12006 2 2 13 11 4113 5501 6315 +12007 2 2 13 11 4551 5749 5436 +12008 2 2 13 11 3735 5820 6293 +12009 2 2 13 11 4232 5536 5981 +12010 2 2 13 11 4233 5982 5537 +12011 2 2 13 11 4490 6884 5560 +12012 2 2 13 11 3992 6641 5271 +12013 2 2 13 11 4486 5788 5508 +12014 2 2 13 11 3744 5251 6341 +12015 2 2 13 11 3745 6343 5252 +12016 2 2 13 11 4332 5679 5826 +12017 2 2 13 11 4649 6944 5105 +12018 2 2 13 11 4650 5106 6945 +12019 2 2 13 11 4093 6428 5181 +12020 2 2 13 11 4202 6163 5325 +12021 2 2 13 11 4897 5992 5404 +12022 2 2 13 11 4898 5405 5993 +12023 2 2 13 11 4446 5540 6415 +12024 2 2 13 11 4346 5242 6653 +12025 2 2 13 11 4063 5313 6100 +12026 2 2 13 11 3771 5228 6764 +12027 2 2 13 11 4064 6102 5316 +12028 2 2 13 11 4419 5841 5481 +12029 2 2 13 11 3814 6137 5420 +12030 2 2 13 11 92 5806 6906 +12031 2 2 13 11 3743 5436 5749 +12032 2 2 13 11 4736 5780 6899 +12033 2 2 13 11 4389 5111 6648 +12034 2 2 13 11 4390 6649 5112 +12035 2 2 13 11 3779 6893 5553 +12036 2 2 13 11 3697 6711 5470 +12037 2 2 13 11 3968 6437 6867 +12038 2 2 13 11 4176 5661 5842 +12039 2 2 13 11 3969 6869 6438 +12040 2 2 13 11 4286 5574 5670 +12041 2 2 13 11 4360 6324 5131 +12042 2 2 13 11 79 6605 5373 +12043 2 2 13 11 4261 6257 5877 +12044 2 2 13 11 4649 5199 6133 +12045 2 2 13 11 4650 6134 5200 +12046 2 2 13 11 4305 5918 6100 +12047 2 2 13 11 4448 6240 5165 +12048 2 2 13 11 4306 6102 5919 +12049 2 2 13 11 4782 6857 5101 +12050 2 2 13 11 4710 6789 6853 +12051 2 2 13 11 3814 6467 6526 +12052 2 2 13 11 3670 5259 6715 +12053 2 2 13 11 4079 5434 6114 +12054 2 2 13 11 4080 6115 5435 +12055 2 2 13 11 104 105 6348 +12056 2 2 13 11 3841 5546 5959 +12057 2 2 13 11 4133 5338 6339 +12058 2 2 13 11 4269 5286 5989 +12059 2 2 13 11 3735 6293 5765 +12060 2 2 13 11 4224 6039 5191 +12061 2 2 13 11 4789 6466 5302 +12062 2 2 13 11 4245 5808 5900 +12063 2 2 13 11 144 5455 5907 +12064 2 2 13 11 4369 6422 6821 +12065 2 2 13 11 4371 6822 6423 +12066 2 2 13 11 4790 6732 5813 +12067 2 2 13 11 4254 5670 5574 +12068 2 2 13 11 4012 5121 6308 +12069 2 2 13 11 4126 5390 5825 +12070 2 2 13 11 4255 5473 5842 +12071 2 2 13 11 4339 5250 6347 +12072 2 2 13 11 4379 6271 6818 +12073 2 2 13 11 4173 5615 5846 +12074 2 2 13 11 4174 5847 5616 +12075 2 2 13 11 4549 6058 6937 +12076 2 2 13 11 4011 5218 6895 +12077 2 2 13 11 4360 5131 6498 +12078 2 2 13 11 4522 6100 5918 +12079 2 2 13 11 4523 5919 6102 +12080 2 2 13 11 4459 6623 5969 +12081 2 2 13 11 4586 6644 5901 +12082 2 2 13 11 4380 5221 6232 +12083 2 2 13 11 3691 5734 6680 +12084 2 2 13 11 4644 6221 5674 +12085 2 2 13 11 4553 6729 5550 +12086 2 2 13 11 4001 6807 5791 +12087 2 2 13 11 4420 5497 5721 +12088 2 2 13 11 4321 6712 5171 +12089 2 2 13 11 5105 6944 5327 +12090 2 2 13 11 5106 5328 6945 +12091 2 2 13 11 4564 5736 5484 +12092 2 2 13 11 4104 6513 5143 +12093 2 2 13 11 4484 5962 6000 +12094 2 2 13 11 4709 6164 6815 +12095 2 2 13 11 4516 6604 5150 +12096 2 2 13 11 4517 5151 6606 +12097 2 2 13 11 4190 6661 5666 +12098 2 2 13 11 4076 5495 5882 +12099 2 2 13 11 296 5989 5286 +12100 2 2 13 11 4028 6884 5186 +12101 2 2 13 11 4429 6627 6056 +12102 2 2 13 11 4430 6057 6628 +12103 2 2 13 11 3888 5481 5841 +12104 2 2 13 11 4121 5864 5400 +12105 2 2 13 11 4122 5401 5865 +12106 2 2 13 11 3835 6385 6463 +12107 2 2 13 11 3827 5186 6390 +12108 2 2 13 11 4464 5373 6605 +12109 2 2 13 11 3716 6516 5365 +12110 2 2 13 11 4146 5721 5497 +12111 2 2 13 11 4683 5306 5972 +12112 2 2 13 11 4059 5115 6684 +12113 2 2 13 11 4335 6485 5117 +12114 2 2 13 11 3879 5193 6377 +12115 2 2 13 11 129 5225 6024 +12116 2 2 13 11 4490 5202 6390 +12117 2 2 13 11 119 6140 5166 +12118 2 2 13 11 4211 6221 5312 +12119 2 2 13 11 3649 5408 6701 +12120 2 2 13 11 4812 6565 5306 +12121 2 2 13 11 4020 5282 6722 +12122 2 2 13 11 4021 6723 5283 +12123 2 2 13 11 4480 5170 6849 +12124 2 2 13 11 3777 5731 6558 +12125 2 2 13 11 3728 5874 5451 +12126 2 2 13 11 4486 5214 6816 +12127 2 2 13 11 4296 5120 6416 +12128 2 2 13 11 3866 5958 5407 +12129 2 2 13 11 3833 5845 5368 +12130 2 2 13 11 4711 5752 6718 +12131 2 2 13 11 111 112 6026 +12132 2 2 13 11 4599 6110 6143 +12133 2 2 13 11 4247 6241 5175 +12134 2 2 13 11 3739 5175 6241 +12135 2 2 13 11 3727 5508 5788 +12136 2 2 13 11 4166 5594 5942 +12137 2 2 13 11 4167 5943 5595 +12138 2 2 13 11 4376 6066 5408 +12139 2 2 13 11 4887 6526 6467 +12140 2 2 13 11 165 166 6079 +12141 2 2 13 11 55 56 6080 +12142 2 2 13 11 4694 6889 5744 +12143 2 2 13 11 4241 5160 6217 +12144 2 2 13 11 4160 5828 5478 +12145 2 2 13 11 4242 6218 5161 +12146 2 2 13 11 3712 6404 6950 +12147 2 2 13 11 4640 6570 6449 +12148 2 2 13 11 4030 5159 6447 +12149 2 2 13 11 3842 6654 5771 +12150 2 2 13 11 3725 5716 6135 +12151 2 2 13 11 3723 5274 6175 +12152 2 2 13 11 3740 5500 6911 +12153 2 2 13 11 3850 5256 6545 +12154 2 2 13 11 4334 5336 6167 +12155 2 2 13 11 4211 5312 6129 +12156 2 2 13 11 4248 5339 5977 +12157 2 2 13 11 4293 6143 6110 +12158 2 2 13 11 4989 5649 6239 +12159 2 2 13 11 3728 6450 5170 +12160 2 2 13 11 4017 6637 5097 +12161 2 2 13 11 4018 5098 6638 +12162 2 2 13 11 4291 6119 5290 +12163 2 2 13 11 3861 6415 5540 +12164 2 2 13 11 4433 6054 5772 +12165 2 2 13 11 4434 5773 6055 +12166 2 2 13 11 4137 6736 6094 +12167 2 2 13 11 4274 5144 6442 +12168 2 2 13 11 3979 6548 6104 +12169 2 2 13 11 4176 5842 5473 +12170 2 2 13 11 4532 6006 6765 +12171 2 2 13 11 305 6014 306 +12172 2 2 13 11 4035 5155 6700 +12173 2 2 13 11 4686 5805 5521 +12174 2 2 13 11 4102 5196 6502 +12175 2 2 13 11 130 6266 5225 +12176 2 2 13 11 4426 6408 5430 +12177 2 2 13 11 4581 5522 5778 +12178 2 2 13 11 4614 5577 5827 +12179 2 2 13 11 4506 6772 5140 +12180 2 2 13 11 4050 6839 5333 +12181 2 2 13 11 4051 5334 6840 +12182 2 2 13 11 4450 5479 5760 +12183 2 2 13 11 4622 6342 5292 +12184 2 2 13 11 4348 6144 5398 +12185 2 2 13 11 4447 6778 5194 +12186 2 2 13 11 4401 5951 5621 +12187 2 2 13 11 4571 5765 6293 +12188 2 2 13 11 3824 5518 6214 +12189 2 2 13 11 4305 6100 5313 +12190 2 2 13 11 4306 5316 6102 +12191 2 2 13 11 3700 5346 6311 +12192 2 2 13 11 3661 6703 5699 +12193 2 2 13 11 4550 5197 6429 +12194 2 2 13 11 4011 6902 5776 +12195 2 2 13 11 4295 6404 5144 +12196 2 2 13 11 4128 5697 6098 +12197 2 2 13 11 4129 6099 5698 +12198 2 2 13 11 4452 6006 6396 +12199 2 2 13 11 4453 6397 6007 +12200 2 2 13 11 4450 6920 5326 +12201 2 2 13 11 4314 6518 5341 +12202 2 2 13 11 4315 5342 6519 +12203 2 2 13 11 4026 6838 5185 +12204 2 2 13 11 4617 6293 5820 +12205 2 2 13 11 4600 6564 5568 +12206 2 2 13 11 3874 5690 6272 +12207 2 2 13 11 3876 6273 5691 +12208 2 2 13 11 4310 6000 5962 +12209 2 2 13 11 4405 5192 6225 +12210 2 2 13 11 4181 5326 5866 +12211 2 2 13 11 3796 5159 6725 +12212 2 2 13 11 330 6942 331 +12213 2 2 13 11 245 6943 246 +12214 2 2 13 11 4453 6007 6861 +12215 2 2 13 11 4313 5246 6254 +12216 2 2 13 11 4812 6809 5830 +12217 2 2 13 11 4406 6831 5597 +12218 2 2 13 11 4470 6135 5716 +12219 2 2 13 11 3873 6527 5800 +12220 2 2 13 11 4640 5844 6570 +12221 2 2 13 11 4413 6033 6691 +12222 2 2 13 11 4872 6731 6785 +12223 2 2 13 11 4498 6889 6613 +12224 2 2 13 11 3884 6604 5467 +12225 2 2 13 11 4575 6571 5874 +12226 2 2 13 11 3716 5430 6408 +12227 2 2 13 11 4085 6287 5226 +12228 2 2 13 11 4079 6598 5434 +12229 2 2 13 11 4080 5435 6599 +12230 2 2 13 11 3879 6110 5653 +12231 2 2 13 11 4674 6356 5488 +12232 2 2 13 11 4461 6230 5232 +12233 2 2 13 11 5045 6503 5210 +12234 2 2 13 11 3844 6022 5671 +12235 2 2 13 11 5046 5211 6504 +12236 2 2 13 11 4760 5516 6775 +12237 2 2 13 11 4425 5671 6022 +12238 2 2 13 11 3688 6263 6808 +12239 2 2 13 11 4106 6047 5289 +12240 2 2 13 11 4473 6764 5228 +12241 2 2 13 11 4334 5738 6081 +12242 2 2 13 11 4294 5270 6338 +12243 2 2 13 11 4787 5871 5582 +12244 2 2 13 11 4190 5784 6661 +12245 2 2 13 11 4391 5546 5718 +12246 2 2 13 11 314 6049 315 +12247 2 2 13 11 261 6050 262 +12248 2 2 13 11 3880 5826 5679 +12249 2 2 13 11 321 6056 322 +12250 2 2 13 11 254 6057 255 +12251 2 2 13 11 4077 6280 5247 +12252 2 2 13 11 3991 6951 5632 +12253 2 2 13 11 4190 5619 5784 +12254 2 2 13 11 4682 5908 5904 +12255 2 2 13 11 3946 6411 5240 +12256 2 2 13 11 4453 6861 6674 +12257 2 2 13 11 4872 5271 6731 +12258 2 2 13 11 4037 5210 6503 +12259 2 2 13 11 4173 5846 5457 +12260 2 2 13 11 4174 5458 5847 +12261 2 2 13 11 4038 6504 5211 +12262 2 2 13 11 95 6621 5383 +12263 2 2 13 11 3877 5657 6364 +12264 2 2 13 11 4541 5926 6806 +12265 2 2 13 11 4318 6117 5227 +12266 2 2 13 11 4451 5365 6516 +12267 2 2 13 11 4391 5959 5546 +12268 2 2 13 11 3657 5973 5382 +12269 2 2 13 11 4617 5820 6675 +12270 2 2 13 11 4304 5280 6168 +12271 2 2 13 11 4328 6367 5960 +12272 2 2 13 11 4714 6680 5734 +12273 2 2 13 11 4491 6565 6747 +12274 2 2 13 11 4095 5327 6944 +12275 2 2 13 11 4096 6945 5328 +12276 2 2 13 11 4158 5285 6155 +12277 2 2 13 11 3764 5278 6123 +12278 2 2 13 11 4155 5135 6577 +12279 2 2 13 11 4202 5505 6163 +12280 2 2 13 11 4138 5878 5437 +12281 2 2 13 11 4139 5438 5879 +12282 2 2 13 11 4353 5846 5615 +12283 2 2 13 11 4354 5616 5847 +12284 2 2 13 11 3850 6891 6332 +12285 2 2 13 11 3797 5219 6759 +12286 2 2 13 11 3798 6760 5220 +12287 2 2 13 11 4530 6558 5201 +12288 2 2 13 11 3687 5235 6653 +12289 2 2 13 11 4985 6552 5753 +12290 2 2 13 11 4269 6174 5286 +12291 2 2 13 11 4404 6545 5256 +12292 2 2 13 11 4833 6836 6495 +12293 2 2 13 11 3649 6633 5408 +12294 2 2 13 11 3980 6319 6674 +12295 2 2 13 11 4044 6365 5235 +12296 2 2 13 11 4990 5251 6424 +12297 2 2 13 11 4991 6425 5252 +12298 2 2 13 11 4045 5236 6366 +12299 2 2 13 11 3871 5972 5306 +12300 2 2 13 11 4388 6467 6742 +12301 2 2 13 11 4464 6698 5373 +12302 2 2 13 11 4894 6910 5319 +12303 2 2 13 11 327 6091 328 +12304 2 2 13 11 248 6092 249 +12305 2 2 13 11 4254 5574 6462 +12306 2 2 13 11 4213 5861 5609 +12307 2 2 13 11 3920 5890 6567 +12308 2 2 13 11 4223 6016 6126 +12309 2 2 13 11 4214 5329 6676 +12310 2 2 13 11 119 120 6140 +12311 2 2 13 11 4223 5228 6952 +12312 2 2 13 11 3951 5569 6596 +12313 2 2 13 11 4834 6494 6850 +12314 2 2 13 11 3695 6453 5411 +12315 2 2 13 11 3696 5412 6454 +12316 2 2 13 11 4138 5445 5878 +12317 2 2 13 11 4139 5879 5446 +12318 2 2 13 11 3905 6570 5844 +12319 2 2 13 11 4339 5694 6287 +12320 2 2 13 11 4351 6534 5257 +12321 2 2 13 11 4352 5258 6535 +12322 2 2 13 11 3821 6146 5403 +12323 2 2 13 11 4351 5942 5594 +12324 2 2 13 11 4953 6674 6319 +12325 2 2 13 11 4352 5595 5943 +12326 2 2 13 11 4633 5209 6709 +12327 2 2 13 11 4084 5224 6231 +12328 2 2 13 11 3928 5977 5339 +12329 2 2 13 11 3919 6338 5270 +12330 2 2 13 11 3916 6826 5511 +12331 2 2 13 11 3919 6566 5857 +12332 2 2 13 11 3688 5236 6263 +12333 2 2 13 11 4376 6633 5267 +12334 2 2 13 11 4690 6066 5520 +12335 2 2 13 11 3659 6360 5185 +12336 2 2 13 11 4007 6777 5244 +12337 2 2 13 11 4088 5521 5805 +12338 2 2 13 11 3740 6120 6143 +12339 2 2 13 11 3820 5802 6117 +12340 2 2 13 11 5242 6830 6653 +12341 2 2 13 11 3825 5796 6922 +12342 2 2 13 11 272 6147 273 +12343 2 2 13 11 3800 5349 6085 +12344 2 2 13 11 3801 6086 5350 +12345 2 2 13 11 4795 5482 6334 +12346 2 2 13 11 4559 6124 6085 +12347 2 2 13 11 3838 5352 6316 +12348 2 2 13 11 3839 6317 5353 +12349 2 2 13 11 4506 6844 5249 +12350 2 2 13 11 4378 5565 6669 +12351 2 2 13 11 4474 5383 6621 +12352 2 2 13 11 4588 5958 6202 +12353 2 2 13 11 4188 5763 5552 +12354 2 2 13 11 91 6906 5617 +12355 2 2 13 11 4005 5230 6658 +12356 2 2 13 11 4453 6674 6151 +12357 2 2 13 11 3966 5574 6314 +12358 2 2 13 11 4702 5922 6834 +12359 2 2 13 11 4743 6799 5288 +12360 2 2 13 11 300 6729 301 +12361 2 2 13 11 4184 6013 5382 +12362 2 2 13 11 4403 6690 5881 +12363 2 2 13 11 4178 6689 5234 +12364 2 2 13 11 4256 5212 6685 +12365 2 2 13 11 4257 6686 5213 +12366 2 2 13 11 4203 5904 5908 +12367 2 2 13 11 3829 5279 6552 +12368 2 2 13 11 162 163 6327 +12369 2 2 13 11 58 59 6328 +12370 2 2 13 11 4267 5867 5506 +12371 2 2 13 11 4106 6810 5484 +12372 2 2 13 11 4256 5437 5878 +12373 2 2 13 11 4257 5879 5438 +12374 2 2 13 11 3658 5329 5979 +12375 2 2 13 11 4847 5782 5888 +12376 2 2 13 11 4300 6821 6060 +12377 2 2 13 11 4301 6061 6822 +12378 2 2 13 11 3759 5526 6744 +12379 2 2 13 11 4800 6104 6548 +12380 2 2 13 11 4786 6682 6383 +12381 2 2 13 11 4499 5960 6367 +12382 2 2 13 11 149 150 6350 +12383 2 2 13 11 4644 5776 6820 +12384 2 2 13 11 4914 6808 6263 +12385 2 2 13 11 4133 6339 5517 +12386 2 2 13 11 3838 6243 5387 +12387 2 2 13 11 3839 5388 6244 +12388 2 2 13 11 4367 6191 5769 +12389 2 2 13 11 4118 5827 5577 +12390 2 2 13 11 4237 6871 6864 +12391 2 2 13 11 4238 6865 6872 +12392 2 2 13 11 4252 5392 6702 +12393 2 2 13 11 4232 5981 5970 +12394 2 2 13 11 4233 5971 5982 +12395 2 2 13 11 4183 5582 5871 +12396 2 2 13 11 3786 5343 6019 +12397 2 2 13 11 3787 6020 5344 +12398 2 2 13 11 4516 5467 6604 +12399 2 2 13 11 3883 5621 5951 +12400 2 2 13 11 3838 6316 5409 +12401 2 2 13 11 3839 5410 6317 +12402 2 2 13 11 4194 6456 5262 +12403 2 2 13 11 71 72 6375 +12404 2 2 13 11 4739 6126 6016 +12405 2 2 13 11 3689 6448 5375 +12406 2 2 13 11 4017 6045 6062 +12407 2 2 13 11 4018 6064 6046 +12408 2 2 13 11 4209 5275 6197 +12409 2 2 13 11 4652 5800 6527 +12410 2 2 13 11 3671 6190 5300 +12411 2 2 13 11 4770 5524 6757 +12412 2 2 13 11 4394 5261 6361 +12413 2 2 13 11 4206 6789 6160 +12414 2 2 13 11 4258 5907 5455 +12415 2 2 13 11 5347 6835 6147 +12416 2 2 13 11 4328 5841 5923 +12417 2 2 13 11 4507 5434 6598 +12418 2 2 13 11 4508 6599 5435 +12419 2 2 13 11 5063 6447 5803 +12420 2 2 13 11 4143 5818 6382 +12421 2 2 13 11 74 75 6380 +12422 2 2 13 11 157 158 6388 +12423 2 2 13 11 63 64 6389 +12424 2 2 13 11 4535 5809 5987 +12425 2 2 13 11 4197 5941 6946 +12426 2 2 13 11 4576 5882 5495 +12427 2 2 13 11 4715 5817 5709 +12428 2 2 13 11 3852 6819 6623 +12429 2 2 13 11 4153 6161 5493 +12430 2 2 13 11 4164 6239 5649 +12431 2 2 13 11 3718 5556 5960 +12432 2 2 13 11 4287 5825 5996 +12433 2 2 13 11 4659 5617 6906 +12434 2 2 13 11 3896 6193 5787 +12435 2 2 13 11 4709 6384 5785 +12436 2 2 13 11 4273 5221 6526 +12437 2 2 13 11 4342 6468 6540 +12438 2 2 13 11 97 98 6410 +12439 2 2 13 11 4343 6541 6469 +12440 2 2 13 11 4759 6259 5912 +12441 2 2 13 11 334 6916 5909 +12442 2 2 13 11 242 5910 6917 +12443 2 2 13 11 4653 6170 6951 +12444 2 2 13 11 4763 6657 6596 +12445 2 2 13 11 4274 6442 5269 +12446 2 2 13 11 3711 5856 6441 +12447 2 2 13 11 4560 6086 6125 +12448 2 2 13 11 4337 5240 6411 +12449 2 2 13 11 3658 6676 5329 +12450 2 2 13 11 5159 5277 6725 +12451 2 2 13 11 4691 6883 5662 +12452 2 2 13 11 87 88 6434 +12453 2 2 13 11 4643 5995 6754 +12454 2 2 13 11 4227 5987 5809 +12455 2 2 13 11 4769 6059 5742 +12456 2 2 13 11 5443 6586 5998 +12457 2 2 13 11 4655 6138 6919 +12458 2 2 13 11 4809 6855 6148 +12459 2 2 13 11 4810 6150 6856 +12460 2 2 13 11 4633 5784 5619 +12461 2 2 13 11 292 6245 293 +12462 2 2 13 11 4473 6610 6659 +12463 2 2 13 11 4333 5951 6003 +12464 2 2 13 11 3907 5575 6063 +12465 2 2 13 11 4265 6532 5404 +12466 2 2 13 11 4266 5405 6533 +12467 2 2 13 11 3802 5254 6800 +12468 2 2 13 11 3800 6085 6124 +12469 2 2 13 11 3707 5312 6221 +12470 2 2 13 11 3863 6924 5282 +12471 2 2 13 11 3864 5283 6925 +12472 2 2 13 11 4693 5444 6672 +12473 2 2 13 11 3814 6526 5221 +12474 2 2 13 11 4447 5194 6582 +12475 2 2 13 11 278 6269 279 +12476 2 2 13 11 3923 5920 6609 +12477 2 2 13 11 4484 6636 6470 +12478 2 2 13 11 4313 6433 5641 +12479 2 2 13 11 4142 5957 5498 +12480 2 2 13 11 4184 5709 5817 +12481 2 2 13 11 4276 5461 6009 +12482 2 2 13 11 4277 6010 5463 +12483 2 2 13 11 4300 6060 5441 +12484 2 2 13 11 4301 5442 6061 +12485 2 2 13 11 3910 6741 5506 +12486 2 2 13 11 3784 5325 6163 +12487 2 2 13 11 4321 5176 6712 +12488 2 2 13 11 4495 6936 5541 +12489 2 2 13 11 4297 6412 5920 +12490 2 2 13 11 85 5288 6799 +12491 2 2 13 11 3992 6870 6641 +12492 2 2 13 11 4699 6926 6474 +12493 2 2 13 11 4700 6475 6927 +12494 2 2 13 11 3744 6424 5251 +12495 2 2 13 11 3745 5252 6425 +12496 2 2 13 11 3840 5963 5659 +12497 2 2 13 11 4289 6085 5349 +12498 2 2 13 11 4290 5350 6086 +12499 2 2 13 11 4361 5243 6595 +12500 2 2 13 11 4291 5290 6512 +12501 2 2 13 11 4379 5887 5868 +12502 2 2 13 11 4502 5443 6937 +12503 2 2 13 11 4701 5702 6659 +12504 2 2 13 11 3652 6277 5307 +12505 2 2 13 11 4318 5227 6730 +12506 2 2 13 11 4331 5868 5887 +12507 2 2 13 11 4342 5810 6172 +12508 2 2 13 11 4343 6173 5811 +12509 2 2 13 11 4598 5511 6826 +12510 2 2 13 11 4493 5787 6193 +12511 2 2 13 11 4599 6143 6120 +12512 2 2 13 11 4376 5520 6066 +12513 2 2 13 11 299 6352 5550 +12514 2 2 13 11 4134 6576 5421 +12515 2 2 13 11 3949 6226 6559 +12516 2 2 13 11 3835 5576 6186 +12517 2 2 13 11 4507 6666 5557 +12518 2 2 13 11 4508 5558 6667 +12519 2 2 13 11 4265 5404 5992 +12520 2 2 13 11 4266 5993 5405 +12521 2 2 13 11 4294 6603 5270 +12522 2 2 13 11 3801 6125 6086 +12523 2 2 13 11 3901 5902 5572 +12524 2 2 13 11 4165 6932 5734 +12525 2 2 13 11 4283 5431 6393 +12526 2 2 13 11 4284 6394 5432 +12527 2 2 13 11 4392 6752 5282 +12528 2 2 13 11 4440 5331 6677 +12529 2 2 13 11 4393 5283 6753 +12530 2 2 13 11 4562 6744 5526 +12531 2 2 13 11 4271 5647 6096 +12532 2 2 13 11 4272 6097 5648 +12533 2 2 13 11 3828 5215 6457 +12534 2 2 13 11 3829 6458 5216 +12535 2 2 13 11 4106 6677 5331 +12536 2 2 13 11 4800 6939 6104 +12537 2 2 13 11 4555 6062 6045 +12538 2 2 13 11 4556 6046 6064 +12539 2 2 13 11 4316 5568 6154 +12540 2 2 13 11 3892 6131 5832 +12541 2 2 13 11 3893 5833 6132 +12542 2 2 13 11 4419 5923 5841 +12543 2 2 13 11 79 80 6605 +12544 2 2 13 11 4714 5734 6932 +12545 2 2 13 11 4247 6413 5456 +12546 2 2 13 11 4344 6202 5958 +12547 2 2 13 11 4425 5375 6448 +12548 2 2 13 11 4733 5406 6473 +12549 2 2 13 11 3902 6255 5684 +12550 2 2 13 11 4289 6694 5293 +12551 2 2 13 11 3903 5685 6256 +12552 2 2 13 11 4290 5294 6695 +12553 2 2 13 11 4730 5468 6212 +12554 2 2 13 11 3807 5677 6180 +12555 2 2 13 11 4717 6456 6450 +12556 2 2 13 11 3922 6801 5492 +12557 2 2 13 11 4614 6578 5464 +12558 2 2 13 11 4105 5272 6624 +12559 2 2 13 11 4547 5970 5981 +12560 2 2 13 11 3712 5269 6442 +12561 2 2 13 11 4548 5982 5971 +12562 2 2 13 11 95 96 6621 +12563 2 2 13 11 3731 6109 5489 +12564 2 2 13 11 3732 5490 6111 +12565 2 2 13 11 328 6091 6481 +12566 2 2 13 11 248 6482 6092 +12567 2 2 13 11 4564 5484 6810 +12568 2 2 13 11 4328 5960 5556 +12569 2 2 13 11 4417 6658 5230 +12570 2 2 13 11 4427 6383 6682 +12571 2 2 13 11 3934 5437 6795 +12572 2 2 13 11 3935 6796 5438 +12573 2 2 13 11 4494 5769 6191 +12574 2 2 13 11 4821 6622 5500 +12575 2 2 13 11 4334 6081 6935 +12576 2 2 13 11 134 135 6660 +12577 2 2 13 11 3 337 6897 +12578 2 2 13 11 4 6898 239 +12579 2 2 13 11 298 6352 299 +12580 2 2 13 11 4394 5738 5933 +12581 2 2 13 11 3875 6730 5227 +12582 2 2 13 11 3971 6496 5393 +12583 2 2 13 11 3904 5947 6866 +12584 2 2 13 11 4799 6395 6517 +12585 2 2 13 11 4387 5855 6585 +12586 2 2 13 11 3 6897 168 +12587 2 2 13 11 4 53 6898 +12588 2 2 13 11 4518 5396 6161 +12589 2 2 13 11 310 6912 311 +12590 2 2 13 11 265 6913 266 +12591 2 2 13 11 4288 6320 5243 +12592 2 2 13 11 4419 5275 6892 +12593 2 2 13 11 3931 6815 6164 +12594 2 2 13 11 4440 6508 5469 +12595 2 2 13 11 3986 6937 5443 +12596 2 2 13 11 3679 6069 5737 +12597 2 2 13 11 4428 5496 6514 +12598 2 2 13 11 4369 5387 6243 +12599 2 2 13 11 4310 5962 5603 +12600 2 2 13 11 4371 6244 5388 +12601 2 2 13 11 4349 5798 6600 +12602 2 2 13 11 84 85 6799 +12603 2 2 13 11 4195 5990 5541 +12604 2 2 13 11 3666 5557 6666 +12605 2 2 13 11 3691 6680 5234 +12606 2 2 13 11 3667 6667 5558 +12607 2 2 13 11 4625 6818 6271 +12608 2 2 13 11 4761 6351 5539 +12609 2 2 13 11 4444 6399 6486 +12610 2 2 13 11 4714 5903 6680 +12611 2 2 13 11 91 92 6906 +12612 2 2 13 11 126 127 6931 +12613 2 2 13 11 4796 5292 6342 +12614 2 2 13 11 3894 5933 5738 +12615 2 2 13 11 3852 5633 6008 +12616 2 2 13 11 4210 6379 5803 +12617 2 2 13 11 4114 6234 5507 +12618 2 2 13 11 4261 6186 5576 +12619 2 2 13 11 4382 6517 6395 +12620 2 2 13 11 4304 6780 5280 +12621 2 2 13 11 4562 5573 6189 +12622 2 2 13 11 4422 5896 6334 +12623 2 2 13 11 3772 5727 6718 +12624 2 2 13 11 4613 6441 5856 +12625 2 2 13 11 4791 6579 5428 +12626 2 2 13 11 5134 5807 6946 +12627 2 2 13 11 3920 6557 5262 +12628 2 2 13 11 4101 5325 6735 +12629 2 2 13 11 4792 5429 6557 +12630 2 2 13 11 4304 6168 6048 +12631 2 2 13 11 4736 6731 5271 +12632 2 2 13 11 4754 5572 6376 +12633 2 2 13 11 4250 6370 5758 +12634 2 2 13 11 4251 5759 6371 +12635 2 2 13 11 4302 5677 5964 +12636 2 2 13 11 4303 5965 5678 +12637 2 2 13 11 3689 5375 6253 +12638 2 2 13 11 4383 6379 5643 +12639 2 2 13 11 3865 5884 6122 +12640 2 2 13 11 4984 6701 5408 +12641 2 2 13 11 3810 5280 6780 +12642 2 2 13 11 4670 6609 5920 +12643 2 2 13 11 100 101 6769 +12644 2 2 13 11 4825 6160 6789 +12645 2 2 13 11 4401 6003 5951 +12646 2 2 13 11 326 6928 327 +12647 2 2 13 11 249 6929 250 +12648 2 2 13 11 3748 6785 6731 +12649 2 2 13 11 4662 5420 6137 +12650 2 2 13 11 4150 6711 5284 +12651 2 2 13 11 4310 5603 5952 +12652 2 2 13 11 3657 6349 5320 +12653 2 2 13 11 4389 5486 6388 +12654 2 2 13 11 4390 6389 5487 +12655 2 2 13 11 4171 5742 6059 +12656 2 2 13 11 3919 5270 6579 +12657 2 2 13 11 4660 6757 5524 +12658 2 2 13 11 4388 5393 6496 +12659 2 2 13 11 3807 6180 5913 +12660 2 2 13 11 109 110 6581 +12661 2 2 13 11 3980 5860 5881 +12662 2 2 13 11 4332 5826 5790 +12663 2 2 13 11 4282 6768 5421 +12664 2 2 13 11 4864 5941 5836 +12665 2 2 13 11 4279 6820 5776 +12666 2 2 13 11 4268 5593 6851 +12667 2 2 13 11 4565 5413 6953 +12668 2 2 13 11 4456 6647 6014 +12669 2 2 13 11 328 6481 329 +12670 2 2 13 11 247 6482 248 +12671 2 2 13 11 5119 6261 6905 +12672 2 2 13 11 4452 6396 6922 +12673 2 2 13 11 4312 5498 5957 +12674 2 2 13 11 3871 5306 6565 +12675 2 2 13 11 4552 6048 6168 +12676 2 2 13 11 3677 6762 5255 +12677 2 2 13 11 4803 6336 5523 +12678 2 2 13 11 4198 5271 6641 +12679 2 2 13 11 3730 5603 5962 +12680 2 2 13 11 4585 5650 6281 +12681 2 2 13 11 5097 5822 6546 +12682 2 2 13 11 5098 6547 5823 +12683 2 2 13 11 4836 6275 6899 +12684 2 2 13 11 4923 5936 6159 +12685 2 2 13 11 4403 5881 5860 +12686 2 2 13 11 3708 6198 6846 +12687 2 2 13 11 4179 6905 5474 +12688 2 2 13 11 3863 5282 6752 +12689 2 2 13 11 3864 6753 5283 +12690 2 2 13 11 4590 6043 5801 +12691 2 2 13 11 281 6537 282 +12692 2 2 13 11 4472 6575 6791 +12693 2 2 13 11 4254 6462 5899 +12694 2 2 13 11 4312 6068 5644 +12695 2 2 13 11 4460 5550 6352 +12696 2 2 13 11 3970 6671 5851 +12697 2 2 13 11 4802 6866 5947 +12698 2 2 13 11 3857 5529 6054 +12699 2 2 13 11 3858 6055 5530 +12700 2 2 13 11 3932 5888 5782 +12701 2 2 13 11 4819 5857 6566 +12702 2 2 13 11 4273 5673 6683 +12703 2 2 13 11 157 6388 5486 +12704 2 2 13 11 64 5487 6389 +12705 2 2 13 11 4684 5684 6255 +12706 2 2 13 11 4685 6256 5685 +12707 2 2 13 11 4731 6481 6091 +12708 2 2 13 11 4732 6092 6482 +12709 2 2 13 11 3824 6728 5785 +12710 2 2 13 11 4498 5767 6889 +12711 2 2 13 11 4520 5945 6751 +12712 2 2 13 11 4025 6907 6712 +12713 2 2 13 11 4373 6662 6781 +12714 2 2 13 11 4130 6189 5444 +12715 2 2 13 11 4337 6411 5288 +12716 2 2 13 11 4820 6567 5890 +12717 2 2 13 11 287 6564 288 +12718 2 2 13 11 4333 5790 5826 +12719 2 2 13 11 4369 6076 6422 +12720 2 2 13 11 4371 6423 6077 +12721 2 2 13 11 3660 5950 6588 +12722 2 2 13 11 4481 6905 6261 +12723 2 2 13 11 4799 5739 6395 +12724 2 2 13 11 3695 5756 6444 +12725 2 2 13 11 3696 6445 5757 +12726 2 2 13 11 3921 6485 5766 +12727 2 2 13 11 3835 6186 5724 +12728 2 2 13 11 3827 6202 5672 +12729 2 2 13 11 4225 5409 6316 +12730 2 2 13 11 4226 6317 5410 +12731 2 2 13 11 3865 6232 6051 +12732 2 2 13 11 3851 5309 6650 +12733 2 2 13 11 4355 6478 6878 +12734 2 2 13 11 4356 6879 6479 +12735 2 2 13 11 4104 5278 6513 +12736 2 2 13 11 3788 5302 6737 +12737 2 2 13 11 4559 5514 6124 +12738 2 2 13 11 4311 5391 6439 +12739 2 2 13 11 3782 6208 5688 +12740 2 2 13 11 3885 6347 6606 +12741 2 2 13 11 4451 6295 5365 +12742 2 2 13 11 4640 6449 5840 +12743 2 2 13 11 4134 5600 6576 +12744 2 2 13 11 3940 5784 6709 +12745 2 2 13 11 4395 6212 5468 +12746 2 2 13 11 4220 5657 5950 +12747 2 2 13 11 4180 5656 5925 +12748 2 2 13 11 4178 5381 6490 +12749 2 2 13 11 4553 5550 6184 +12750 2 2 13 11 4421 5242 6611 +12751 2 2 13 11 4446 6415 5872 +12752 2 2 13 11 4933 6617 6172 +12753 2 2 13 11 4934 6173 6618 +12754 2 2 13 11 301 6729 5525 +12755 2 2 13 11 4665 6034 6657 +12756 2 2 13 11 4560 6125 5515 +12757 2 2 13 11 3703 5630 6076 +12758 2 2 13 11 3704 6077 5631 +12759 2 2 13 11 3721 6281 5650 +12760 2 2 13 11 4444 6486 5906 +12761 2 2 13 11 4234 5459 6206 +12762 2 2 13 11 4965 6864 6871 +12763 2 2 13 11 4966 6872 6865 +12764 2 2 13 11 4913 5464 6578 +12765 2 2 13 11 3838 5409 6243 +12766 2 2 13 11 3839 6244 5410 +12767 2 2 13 11 4278 6824 5523 +12768 2 2 13 11 4563 6721 5354 +12769 2 2 13 11 4326 6253 5375 +12770 2 2 13 11 3687 6653 6830 +12771 2 2 13 11 5171 6712 6907 +12772 2 2 13 11 4293 5480 6308 +12773 2 2 13 11 3956 6430 5932 +12774 2 2 13 11 4221 6754 5995 +12775 2 2 13 11 3801 5350 6797 +12776 2 2 13 11 4421 6830 5242 +12777 2 2 13 11 4449 6449 6570 +12778 2 2 13 11 4032 6443 5792 +12779 2 2 13 11 4763 5450 6657 +12780 2 2 13 11 4211 5674 6221 +12781 2 2 13 11 4600 6008 5633 +12782 2 2 13 11 3757 6439 5391 +12783 2 2 13 11 3800 6880 5349 +12784 2 2 13 11 3880 6105 5826 +12785 2 2 13 11 333 6916 334 +12786 2 2 13 11 242 6917 243 +12787 2 2 13 11 270 6873 271 +12788 2 2 13 11 4465 6637 5566 +12789 2 2 13 11 4466 5567 6638 +12790 2 2 13 11 4647 6422 6076 +12791 2 2 13 11 4247 5456 6282 +12792 2 2 13 11 4648 6077 6423 +12793 2 2 13 11 4337 5288 6538 +12794 2 2 13 11 102 6340 5385 +12795 2 2 13 11 4106 5289 6810 +12796 2 2 13 11 4228 6214 5518 +12797 2 2 13 11 4262 6070 5527 +12798 2 2 13 11 4263 5528 6071 +12799 2 2 13 11 3748 6899 6275 +12800 2 2 13 11 3872 6953 5413 +12801 2 2 13 11 4333 6003 5790 +12802 2 2 13 11 3832 6514 5496 +12803 2 2 13 11 4675 5851 6671 +12804 2 2 13 11 4538 6444 5756 +12805 2 2 13 11 4539 5757 6445 +12806 2 2 13 11 4334 6167 5738 +12807 2 2 13 11 4545 5872 6415 +12808 2 2 13 11 4211 6129 5553 +12809 2 2 13 11 4422 6334 5482 +12810 2 2 13 11 3871 6636 5565 +12811 2 2 13 11 4633 6709 5784 +12812 2 2 13 11 4883 6885 6068 +12813 2 2 13 11 4724 6725 5277 +12814 2 2 13 11 3734 6690 5330 +12815 2 2 13 11 3951 6596 6657 +12816 2 2 13 11 3834 6859 5324 +12817 2 2 13 11 4540 5324 6859 +12818 2 2 13 11 4521 5792 6443 +12819 2 2 13 11 4563 5354 6774 +12820 2 2 13 11 4220 6364 5657 +12821 2 2 13 11 4631 5507 6234 +12822 2 2 13 11 3807 5964 5677 +12823 2 2 13 11 3808 5678 5965 +12824 2 2 13 11 4268 6851 5819 +12825 2 2 13 11 3722 5644 6068 +12826 2 2 13 11 4317 5538 6539 +12827 2 2 13 11 4768 5819 6851 +12828 2 2 13 11 4197 5836 5941 +12829 2 2 13 11 4222 5968 5875 +12830 2 2 13 11 3726 6170 6403 +12831 2 2 13 11 4055 5352 6648 +12832 2 2 13 11 4056 6649 5353 +12833 2 2 13 11 4706 6470 6636 +12834 2 2 13 11 4313 6574 5650 +12835 2 2 13 11 4361 6595 5598 +12836 2 2 13 11 4017 5566 6637 +12837 2 2 13 11 4018 6638 5567 +12838 2 2 13 11 4319 6116 5556 +12839 2 2 13 11 3726 6403 5969 +12840 2 2 13 11 87 6434 5607 +12841 2 2 13 11 4777 6641 6870 +12842 2 2 13 11 4342 6617 5645 +12843 2 2 13 11 4343 5646 6618 +12844 2 2 13 11 4613 5856 5977 +12845 2 2 13 11 3869 6225 5770 +12846 2 2 13 11 3951 6657 6034 +12847 2 2 13 11 3908 6395 5739 +12848 2 2 13 11 4320 6224 5513 +12849 2 2 13 11 3682 5293 6694 +12850 2 2 13 11 286 6154 5568 +12851 2 2 13 11 3683 6695 5294 +12852 2 2 13 11 3933 5944 6834 +12853 2 2 13 11 3659 5478 6360 +12854 2 2 13 11 4068 5465 6611 +12855 2 2 13 11 4364 5601 6131 +12856 2 2 13 11 4365 6132 5602 +12857 2 2 13 11 3824 6285 5518 +12858 2 2 13 11 4482 5422 6305 +12859 2 2 13 11 3800 6124 5531 +12860 2 2 13 11 3721 6574 5998 +12861 2 2 13 11 4460 6184 5550 +12862 2 2 13 11 4506 5545 6930 +12863 2 2 13 11 5343 6862 6019 +12864 2 2 13 11 5344 6020 6863 +12865 2 2 13 11 4801 6315 5501 +12866 2 2 13 11 3705 5790 6003 +12867 2 2 13 11 283 5372 6673 +12868 2 2 13 11 4530 6238 5985 +12869 2 2 13 11 4429 5363 6862 +12870 2 2 13 11 4430 6863 5364 +12871 2 2 13 11 4154 6713 5291 +12872 2 2 13 11 4160 5545 6176 +12873 2 2 13 11 4436 5607 6434 +12874 2 2 13 11 3731 6645 5918 +12875 2 2 13 11 3791 5456 6413 +12876 2 2 13 11 3801 5544 6125 +12877 2 2 13 11 3732 5919 6646 +12878 2 2 13 11 4376 5408 6633 +12879 2 2 13 11 4440 6677 6708 +12880 2 2 13 11 4638 6563 5389 +12881 2 2 13 11 4333 5906 5951 +12882 2 2 13 11 4484 5565 6636 +12883 2 2 13 11 3943 6805 5384 +12884 2 2 13 11 3767 6246 5880 +12885 2 2 13 11 4417 6277 5830 +12886 2 2 13 11 4143 6382 5504 +12887 2 2 13 11 4229 5725 6078 +12888 2 2 13 11 311 6912 5663 +12889 2 2 13 11 265 5664 6913 +12890 2 2 13 11 324 5404 6532 +12891 2 2 13 11 252 6533 5405 +12892 2 2 13 11 4220 5731 6364 +12893 2 2 13 11 3917 6702 5392 +12894 2 2 13 11 4845 6027 6790 +12895 2 2 13 11 3854 6236 5452 +12896 2 2 13 11 3855 5453 6237 +12897 2 2 13 11 4204 6862 5363 +12898 2 2 13 11 4205 5364 6863 +12899 2 2 13 11 4496 6782 5309 +12900 2 2 13 11 3827 6414 6202 +12901 2 2 13 11 4647 6076 5630 +12902 2 2 13 11 4648 5631 6077 +12903 2 2 13 11 4433 5647 6203 +12904 2 2 13 11 4434 6204 5648 +12905 2 2 13 11 4558 5517 6339 +12906 2 2 13 11 4396 6178 5885 +12907 2 2 13 11 4397 5886 6179 +12908 2 2 13 11 4350 5485 6500 +12909 2 2 13 11 4760 6597 6363 +12910 2 2 13 11 3941 6096 5647 +12911 2 2 13 11 3942 5648 6097 +12912 2 2 13 11 4248 5977 5856 +12913 2 2 13 11 4411 6625 6045 +12914 2 2 13 11 4412 6046 6626 +12915 2 2 13 11 4415 6119 5834 +12916 2 2 13 11 4554 5932 6430 +12917 2 2 13 11 4786 6383 5711 +12918 2 2 13 11 4336 6360 5478 +12919 2 2 13 11 4653 6403 6170 +12920 2 2 13 11 136 6420 5474 +12921 2 2 13 11 4749 6290 6839 +12922 2 2 13 11 4750 6840 6291 +12923 2 2 13 11 4783 5875 5968 +12924 2 2 13 11 4229 6078 6803 +12925 2 2 13 11 3948 5579 6484 +12926 2 2 13 11 4314 5366 6518 +12927 2 2 13 11 4315 6519 5367 +12928 2 2 13 11 4421 6611 5465 +12929 2 2 13 11 3993 5843 6419 +12930 2 2 13 11 4291 5834 6119 +12931 2 2 13 11 4074 6508 5492 +12932 2 2 13 11 4588 6202 6414 +12933 2 2 13 11 4753 6623 6819 +12934 2 2 13 11 4419 5481 6451 +12935 2 2 13 11 4788 6781 6662 +12936 2 2 13 11 3944 6682 6331 +12937 2 2 13 11 4446 5449 6813 +12938 2 2 13 11 5326 6920 5866 +12939 2 2 13 11 4394 6081 5738 +12940 2 2 13 11 4350 6292 5485 +12941 2 2 13 11 4091 5983 6742 +12942 2 2 13 11 4377 5927 5933 +12943 2 2 13 11 4438 6098 5697 +12944 2 2 13 11 4439 5698 6099 +12945 2 2 13 11 3959 5627 6580 +12946 2 2 13 11 3841 6775 5516 +12947 2 2 13 11 4245 6918 5570 +12948 2 2 13 11 4160 6930 5545 +12949 2 2 13 11 4684 6255 6520 +12950 2 2 13 11 4685 6521 6256 +12951 2 2 13 11 3725 6135 6257 +12952 2 2 13 11 4502 6586 5443 +12953 2 2 13 11 4629 6540 6468 +12954 2 2 13 11 4630 6469 6541 +12955 2 2 13 11 4535 5987 6515 +12956 2 2 13 11 4786 6331 6682 +12957 2 2 13 11 4407 6520 6255 +12958 2 2 13 11 4836 6899 5780 +12959 2 2 13 11 4408 6256 6521 +12960 2 2 13 11 4254 6704 5670 +12961 2 2 13 11 4542 5980 6527 +12962 2 2 13 11 4435 5959 6067 +12963 2 2 13 11 4726 6834 5944 +12964 2 2 13 11 4922 5598 6497 +12965 2 2 13 11 4687 5321 6801 +12966 2 2 13 11 3883 5951 5906 +12967 2 2 13 11 4326 5375 6561 +12968 2 2 13 11 4107 6881 5371 +12969 2 2 13 11 4398 6353 6476 +12970 2 2 13 11 4399 6477 6354 +12971 2 2 13 11 4652 6527 5980 +12972 2 2 13 11 4333 6105 5906 +12973 2 2 13 11 3707 6820 5814 +12974 2 2 13 11 4243 6180 5677 +12975 2 2 13 11 4348 5576 6463 +12976 2 2 13 11 4104 6698 5426 +12977 2 2 13 11 4210 5803 6447 +12978 2 2 13 11 3703 6076 5885 +12979 2 2 13 11 3704 5886 6077 +12980 2 2 13 11 4919 5703 6881 +12981 2 2 13 11 4431 5369 6722 +12982 2 2 13 11 4432 6723 5370 +12983 2 2 13 11 3788 5421 6768 +12984 2 2 13 11 3676 6500 5485 +12985 2 2 13 11 3928 5339 6761 +12986 2 2 13 11 3996 6474 6926 +12987 2 2 13 11 3997 6927 6475 +12988 2 2 13 11 3673 5560 6668 +12989 2 2 13 11 4638 5998 6574 +12990 2 2 13 11 4023 5801 6043 +12991 2 2 13 11 4391 6067 5959 +12992 2 2 13 11 4625 5974 6088 +12993 2 2 13 11 4283 6393 5832 +12994 2 2 13 11 4284 5833 6394 +12995 2 2 13 11 4243 5636 6118 +12996 2 2 13 11 3664 6363 6597 +12997 2 2 13 11 4437 6484 5579 +12998 2 2 13 11 4581 6094 6736 +12999 2 2 13 11 3979 6104 5859 +13000 2 2 13 11 3687 6830 5440 +13001 2 2 13 11 4317 5578 6866 +13002 2 2 13 11 4339 6347 5759 +13003 2 2 13 11 4595 6805 5877 +13004 2 2 13 11 3652 5830 6277 +13005 2 2 13 11 3936 6440 6021 +13006 2 2 13 11 4602 5663 6912 +13007 2 2 13 11 4603 6913 5664 +13008 2 2 13 11 4469 5539 6351 +13009 2 2 13 11 4447 5368 6778 +13010 2 2 13 11 4394 5933 5927 +13011 2 2 13 11 3894 5738 6167 +13012 2 2 13 11 4776 6065 6773 +13013 2 2 13 11 4131 6835 5347 +13014 2 2 13 11 4313 5650 6433 +13015 2 2 13 11 4433 6847 5366 +13016 2 2 13 11 4434 5367 6848 +13017 2 2 13 11 4642 6814 5460 +13018 2 2 13 11 4106 5484 6677 +13019 2 2 13 11 3886 5754 6874 +13020 2 2 13 11 3887 6875 5755 +13021 2 2 13 11 4125 6833 5396 +13022 2 2 13 11 3956 6798 6919 +13023 2 2 13 11 3703 5885 6178 +13024 2 2 13 11 3704 6179 5886 +13025 2 2 13 11 4487 5880 6246 +13026 2 2 13 11 4509 6419 5843 +13027 2 2 13 11 4133 6555 5542 +13028 2 2 13 11 4333 5826 6105 +13029 2 2 13 11 3811 5356 6900 +13030 2 2 13 11 4625 6088 6818 +13031 2 2 13 11 4703 6091 6928 +13032 2 2 13 11 4704 6929 6092 +13033 2 2 13 11 4612 6002 5984 +13034 2 2 13 11 4505 6166 6430 +13035 2 2 13 11 4337 6538 5607 +13036 2 2 13 11 4282 5421 6576 +13037 2 2 13 11 3852 6008 6819 +13038 2 2 13 11 3850 6332 5609 +13039 2 2 13 11 4362 5561 6656 +13040 2 2 13 11 3816 6631 5457 +13041 2 2 13 11 3817 5458 6632 +13042 2 2 13 11 3835 6463 5576 +13043 2 2 13 11 4421 5440 6830 +13044 2 2 13 11 5068 6121 6401 +13045 2 2 13 11 4484 6470 5962 +13046 2 2 13 11 4411 6391 6625 +13047 2 2 13 11 4412 6626 6392 +13048 2 2 13 11 4507 6583 5434 +13049 2 2 13 11 4508 5435 6584 +13050 2 2 13 11 3854 5746 6236 +13051 2 2 13 11 3855 6237 5747 +13052 2 2 13 11 4370 6112 6149 +13053 2 2 13 11 4516 6509 5467 +13054 2 2 13 11 4554 6430 6166 +13055 2 2 13 11 4637 6323 5949 +13056 2 2 13 11 4794 5730 6601 +13057 2 2 13 11 4510 5682 6474 +13058 2 2 13 11 4511 6475 5683 +13059 2 2 13 11 4669 6488 6418 +13060 2 2 13 11 3966 6462 5574 +13061 2 2 13 11 3895 6361 5717 +13062 2 2 13 11 4262 6372 5612 +13063 2 2 13 11 4263 5613 6373 +13064 2 2 13 11 4546 5570 6918 +13065 2 2 13 11 326 5588 6928 +13066 2 2 13 11 250 6929 5589 +13067 2 2 13 11 4477 6248 6022 +13068 2 2 13 11 4156 6476 5475 +13069 2 2 13 11 4157 5476 6477 +13070 2 2 13 11 5035 6358 6249 +13071 2 2 13 11 5036 6250 6359 +13072 2 2 13 11 3722 6885 5547 +13073 2 2 13 11 4363 6242 6414 +13074 2 2 13 11 3849 5949 6323 +13075 2 2 13 11 4342 5645 6468 +13076 2 2 13 11 4343 6469 5646 +13077 2 2 13 11 4321 5688 6208 +13078 2 2 13 11 4377 5464 6825 +13079 2 2 13 11 4665 6657 5450 +13080 2 2 13 11 4405 6556 5614 +13081 2 2 13 11 4264 6432 5835 +13082 2 2 13 11 4595 6257 6135 +13083 2 2 13 11 3881 5835 6461 +13084 2 2 13 11 4479 6668 5560 +13085 2 2 13 11 4286 6314 5574 +13086 2 2 13 11 4448 6015 6240 +13087 2 2 13 11 4369 5885 6076 +13088 2 2 13 11 4371 6077 5886 +13089 2 2 13 11 4545 6415 6152 +13090 2 2 13 11 4454 5780 6492 +13091 2 2 13 11 4342 6540 5810 +13092 2 2 13 11 4343 5811 6541 +13093 2 2 13 11 3949 6559 6487 +13094 2 2 13 11 3953 6515 5987 +13095 2 2 13 11 4465 6049 6637 +13096 2 2 13 11 4466 6638 6050 +13097 2 2 13 11 3690 6889 5767 +13098 2 2 13 11 3649 6551 5618 +13099 2 2 13 11 3943 5877 6805 +13100 2 2 13 11 4296 6044 5978 +13101 2 2 13 11 3769 5428 6655 +13102 2 2 13 11 3668 5726 6229 +13103 2 2 13 11 3932 6697 6466 +13104 2 2 13 11 3854 5452 6506 +13105 2 2 13 11 4402 5859 6104 +13106 2 2 13 11 3855 6507 5453 +13107 2 2 13 11 5170 5937 6849 +13108 2 2 13 11 3952 6023 6619 +13109 2 2 13 11 4904 5830 6809 +13110 2 2 13 11 4729 6400 6145 +13111 2 2 13 11 105 5543 6348 +13112 2 2 13 11 3675 6813 5449 +13113 2 2 13 11 4351 5594 6534 +13114 2 2 13 11 4615 5978 6044 +13115 2 2 13 11 4352 6535 5595 +13116 2 2 13 11 4276 6249 6358 +13117 2 2 13 11 4597 5500 6622 +13118 2 2 13 11 4277 6359 6250 +13119 2 2 13 11 4444 5906 6105 +13120 2 2 13 11 4478 5791 6807 +13121 2 2 13 11 4579 6214 5789 +13122 2 2 13 11 3725 6257 5704 +13123 2 2 13 11 329 6481 5686 +13124 2 2 13 11 247 5687 6482 +13125 2 2 13 11 3896 5787 6295 +13126 2 2 13 11 3834 5465 6859 +13127 2 2 13 11 4261 6721 6186 +13128 2 2 13 11 3952 6849 5937 +13129 2 2 13 11 3975 5479 6845 +13130 2 2 13 11 4620 6601 5730 +13131 2 2 13 11 3913 6219 6941 +13132 2 2 13 11 4499 6149 6112 +13133 2 2 13 11 4443 5618 6551 +13134 2 2 13 11 3684 6766 5424 +13135 2 2 13 11 3699 6362 6378 +13136 2 2 13 11 3685 5425 6767 +13137 2 2 13 11 3953 6825 5464 +13138 2 2 13 11 4362 6802 5561 +13139 2 2 13 11 4228 5789 6214 +13140 2 2 13 11 4445 6418 6488 +13141 2 2 13 11 4288 5837 6320 +13142 2 2 13 11 3940 6757 6661 +13143 2 2 13 11 4295 5984 6002 +13144 2 2 13 11 3695 6444 6453 +13145 2 2 13 11 3696 6454 6445 +13146 2 2 13 11 4275 6088 5974 +13147 2 2 13 11 4626 6697 5477 +13148 2 2 13 11 3990 6471 6199 +13149 2 2 13 11 3929 6492 5780 +13150 2 2 13 11 4632 5997 6590 +13151 2 2 13 11 4373 5561 6662 +13152 2 2 13 11 4601 5913 6180 +13153 2 2 13 11 4091 6742 5420 +13154 2 2 13 11 4247 6018 6413 +13155 2 2 13 11 3861 6152 6415 +13156 2 2 13 11 4459 5969 6403 +13157 2 2 13 11 3859 6367 5923 +13158 2 2 13 11 4563 5724 6186 +13159 2 2 13 11 4380 6229 5726 +13160 2 2 13 11 4366 6784 5483 +13161 2 2 13 11 3989 5641 6433 +13162 2 2 13 11 310 5700 6912 +13163 2 2 13 11 266 6913 5701 +13164 2 2 13 11 4766 5973 6907 +13165 2 2 13 11 4580 6021 6440 +13166 2 2 13 11 5082 5662 6883 +13167 2 2 13 11 4331 5887 6651 +13168 2 2 13 11 3692 5654 6733 +13169 2 2 13 11 4823 6095 6253 +13170 2 2 13 11 3740 6748 5500 +13171 2 2 13 11 4727 6144 6463 +13172 2 2 13 11 3868 6531 5952 +13173 2 2 13 11 4379 5868 6271 +13174 2 2 13 11 3883 6058 6402 +13175 2 2 13 11 4424 6382 5818 +13176 2 2 13 11 3845 6522 5548 +13177 2 2 13 11 4547 5893 6803 +13178 2 2 13 11 4548 6804 5894 +13179 2 2 13 11 3884 6370 5970 +13180 2 2 13 11 3885 5971 6371 +13181 2 2 13 11 4444 6357 6281 +13182 2 2 13 11 3918 6401 6121 +13183 2 2 13 11 4207 6396 5634 +13184 2 2 13 11 4208 5635 6397 +13185 2 2 13 11 3770 6791 5429 +13186 2 2 13 11 4433 6203 6054 +13187 2 2 13 11 4434 6055 6204 +13188 2 2 13 11 4256 6795 5437 +13189 2 2 13 11 4257 5438 6796 +13190 2 2 13 11 4585 6281 6357 +13191 2 2 13 11 3892 6534 5594 +13192 2 2 13 11 3893 5595 6535 +13193 2 2 13 11 4506 6930 6772 +13194 2 2 13 11 3859 6149 6367 +13195 2 2 13 11 4492 6364 5731 +13196 2 2 13 11 327 6928 6091 +13197 2 2 13 11 249 6092 6929 +13198 2 2 13 11 4072 6882 6511 +13199 2 2 13 11 4819 6566 6749 +13200 2 2 13 11 4820 6750 6567 +13201 2 2 13 11 4720 6554 6492 +13202 2 2 13 11 3880 6357 6105 +13203 2 2 13 11 4858 6700 5689 +13204 2 2 13 11 4967 5707 6833 +13205 2 2 13 11 4387 5710 6499 +13206 2 2 13 11 3871 6302 6636 +13207 2 2 13 11 4116 5711 6383 +13208 2 2 13 11 4915 6651 5800 +13209 2 2 13 11 4698 6296 5696 +13210 2 2 13 11 4400 5526 6868 +13211 2 2 13 11 4328 5923 6367 +13212 2 2 13 11 3883 6402 5621 +13213 2 2 13 11 3972 6602 5769 +13214 2 2 13 11 3921 5766 6344 +13215 2 2 13 11 4545 6655 5872 +13216 2 2 13 11 4178 5614 6556 +13217 2 2 13 11 4588 6414 6242 +13218 2 2 13 11 4536 6934 5739 +13219 2 2 13 11 3908 5739 6934 +13220 2 2 13 11 3922 6662 5561 +13221 2 2 13 11 3702 6421 5660 +13222 2 2 13 11 3900 6240 6015 +13223 2 2 13 11 4267 5506 6741 +13224 2 2 13 11 4503 6461 5835 +13225 2 2 13 11 3765 6468 5645 +13226 2 2 13 11 3766 5646 6469 +13227 2 2 13 11 4598 6826 5499 +13228 2 2 13 11 4626 6466 6697 +13229 2 2 13 11 3708 6846 5504 +13230 2 2 13 11 4017 6546 6045 +13231 2 2 13 11 4018 6046 6547 +13232 2 2 13 11 4237 6864 5864 +13233 2 2 13 11 4238 5865 6865 +13234 2 2 13 11 4409 6940 6106 +13235 2 2 13 11 3832 5570 6514 +13236 2 2 13 11 4807 6502 5610 +13237 2 2 13 11 4461 6312 6230 +13238 2 2 13 11 3779 5821 6726 +13239 2 2 13 11 4210 5643 6379 +13240 2 2 13 11 3906 5523 6824 +13241 2 2 13 11 3955 5499 6669 +13242 2 2 13 11 4381 5660 6421 +13243 2 2 13 11 3940 6661 5784 +13244 2 2 13 11 4553 5525 6729 +13245 2 2 13 11 4450 6845 5479 +13246 2 2 13 11 3872 6271 5868 +13247 2 2 13 11 4549 6402 6058 +13248 2 2 13 11 4851 6941 6219 +13249 2 2 13 11 4307 6631 5580 +13250 2 2 13 11 4308 5581 6632 +13251 2 2 13 11 3873 5800 6651 +13252 2 2 13 11 3836 6478 5624 +13253 2 2 13 11 3837 5625 6479 +13254 2 2 13 11 4699 6453 6444 +13255 2 2 13 11 4700 6445 6454 +13256 2 2 13 11 4471 6321 6446 +13257 2 2 13 11 3885 5759 6347 +13258 2 2 13 11 3672 6048 6258 +13259 2 2 13 11 4533 5860 6861 +13260 2 2 13 11 4256 5878 6325 +13261 2 2 13 11 4257 6326 5879 +13262 2 2 13 11 3842 6860 5524 +13263 2 2 13 11 4085 5938 6287 +13264 2 2 13 11 4373 6781 5662 +13265 2 2 13 11 4654 6378 6362 +13266 2 2 13 11 3859 6027 6149 +13267 2 2 13 11 4310 6305 6000 +13268 2 2 13 11 4246 6159 5936 +13269 2 2 13 11 3759 6868 5526 +13270 2 2 13 11 4916 6511 6882 +13271 2 2 13 11 4275 6580 5627 +13272 2 2 13 11 4381 5524 6860 +13273 2 2 13 11 4609 6199 6471 +13274 2 2 13 11 4524 6497 5598 +13275 2 2 13 11 4699 6474 5682 +13276 2 2 13 11 4700 5683 6475 +13277 2 2 13 11 5235 6365 6653 +13278 2 2 13 11 4196 6409 5748 +13279 2 2 13 11 3823 5483 6784 +13280 2 2 13 11 4370 6149 6027 +13281 2 2 13 11 4325 5547 6885 +13282 2 2 13 11 4454 6492 6554 +13283 2 2 13 11 4720 6877 6171 +13284 2 2 13 11 3922 5561 6802 +13285 2 2 13 11 3884 5758 6370 +13286 2 2 13 11 3885 6371 5759 +13287 2 2 13 11 3878 6082 6706 +13288 2 2 13 11 4764 6911 6921 +13289 2 2 13 11 4395 6171 6877 +13290 2 2 13 11 3693 6330 5996 +13291 2 2 13 11 4519 6783 5829 +13292 2 2 13 11 4846 5673 6417 +13293 2 2 13 11 4199 6499 5710 +13294 2 2 13 11 4115 6568 5781 +13295 2 2 13 11 4475 6749 6566 +13296 2 2 13 11 4476 6567 6750 +13297 2 2 13 11 4264 5912 6259 +13298 2 2 13 11 3651 5597 6831 +13299 2 2 13 11 4364 6131 6948 +13300 2 2 13 11 4365 6949 6132 +13301 2 2 13 11 4706 6636 6302 +13302 2 2 13 11 4028 5809 6692 +13303 2 2 13 11 3950 5829 6783 +13304 2 2 13 11 3886 6874 6148 +13305 2 2 13 11 3887 6150 6875 +13306 2 2 13 11 3736 6818 6088 +13307 2 2 13 11 4160 5478 6930 +13308 2 2 13 11 4289 5869 6694 +13309 2 2 13 11 4290 6695 5870 +13310 2 2 13 11 4595 5877 6257 +13311 2 2 13 11 4438 6298 6098 +13312 2 2 13 11 4439 6099 6299 +13313 2 2 13 11 4740 6706 6082 +13314 2 2 13 11 3929 6877 6492 +13315 2 2 13 11 4461 6113 6312 +13316 2 2 13 11 4229 6803 5893 +13317 2 2 13 11 4230 5894 6804 +13318 2 2 13 11 4653 6529 6487 +13319 2 2 13 11 3932 5782 6697 +13320 2 2 13 11 4339 6287 5938 +13321 2 2 13 11 3857 6203 5939 +13322 2 2 13 11 3858 5940 6204 +13323 2 2 13 11 4504 6446 6321 +13324 2 2 13 11 3721 5650 6574 +13325 2 2 13 11 3857 6054 6203 +13326 2 2 13 11 3858 6204 6055 +13327 2 2 13 11 4211 5553 6893 +13328 2 2 13 11 4495 6652 6522 +13329 2 2 13 11 3980 6861 5860 +13330 2 2 13 11 3896 6295 6283 +13331 2 2 13 11 4362 6656 5876 +13332 2 2 13 11 3896 6113 6193 +13333 2 2 13 11 4598 6843 5511 +13334 2 2 13 11 4425 6022 6248 +13335 2 2 13 11 3778 6920 5760 +13336 2 2 13 11 4400 6838 5526 +13337 2 2 13 11 4660 6661 6757 +13338 2 2 13 11 3755 6758 6517 +13339 2 2 13 11 4305 5740 6437 +13340 2 2 13 11 4306 6438 5741 +13341 2 2 13 11 4948 6735 5611 +13342 2 2 13 11 4384 5753 6552 +13343 2 2 13 11 3843 6687 6601 +13344 2 2 13 11 4361 5985 6238 +13345 2 2 13 11 3841 5959 6775 +13346 2 2 13 11 4394 6361 6081 +13347 2 2 13 11 4294 6199 6603 +13348 2 2 13 11 4502 6486 6399 +13349 2 2 13 11 4552 6258 6048 +13350 2 2 13 11 3656 5840 6449 +13351 2 2 13 11 4461 6313 6193 +13352 2 2 13 11 4461 6193 6113 +13353 2 2 13 11 4458 5996 6330 +13354 2 2 13 11 4310 5952 6531 +13355 2 2 13 11 3877 6933 5657 +13356 2 2 13 11 3845 6936 6522 +13357 2 2 13 11 4383 5643 6740 +13358 2 2 13 11 5144 6404 6442 +13359 2 2 13 11 4802 5947 6952 +13360 2 2 13 11 3896 6321 6113 +13361 2 2 13 11 4379 6818 6065 +13362 2 2 13 11 4503 6644 6461 +13363 2 2 13 11 4447 6582 5900 +13364 2 2 13 11 4607 6098 6298 +13365 2 2 13 11 4608 6299 6099 +13366 2 2 13 11 4492 5781 6568 +13367 2 2 13 11 3712 6442 6404 +13368 2 2 13 11 4451 6233 6283 +13369 2 2 13 11 3809 5670 6704 +13370 2 2 13 11 3701 6683 5673 +13371 2 2 13 11 4456 6014 6452 +13372 2 2 13 11 3712 6950 5623 +13373 2 2 13 11 4755 6127 6741 +13374 2 2 13 11 4462 6147 6835 +13375 2 2 13 11 4413 6691 5716 +13376 2 2 13 11 3689 6253 6095 +13377 2 2 13 11 4374 5832 6393 +13378 2 2 13 11 4375 6394 5833 +13379 2 2 13 11 4794 6601 6687 +13380 2 2 13 11 3948 6659 5702 +13381 2 2 13 11 4522 5918 6645 +13382 2 2 13 11 4523 6646 5919 +13383 2 2 13 11 3819 5662 6781 +13384 2 2 13 11 4503 5835 6432 +13385 2 2 13 11 4773 6543 6806 +13386 2 2 13 11 4535 6692 5809 +13387 2 2 13 11 4223 6952 5947 +13388 2 2 13 11 4546 6918 6732 +13389 2 2 13 11 4703 6928 5588 +13390 2 2 13 11 4704 5589 6929 +13391 2 2 13 11 4660 5666 6661 +13392 2 2 13 11 4451 6283 6295 +13393 2 2 13 11 4609 6603 6199 +13394 2 2 13 11 3982 6740 5643 +13395 2 2 13 11 3739 6755 6042 +13396 2 2 13 11 3820 6590 5735 +13397 2 2 13 11 3904 6866 5578 +13398 2 2 13 11 3949 6487 6529 +13399 2 2 13 11 153 5668 6664 +13400 2 2 13 11 68 6665 5669 +13401 2 2 13 11 4437 5579 6891 +13402 2 2 13 11 4200 6652 6122 +13403 2 2 13 11 3852 6623 5762 +13404 2 2 13 11 4409 6310 6940 +13405 2 2 13 11 3697 6901 6101 +13406 2 2 13 11 3863 6752 5682 +13407 2 2 13 11 3864 5683 6753 +13408 2 2 13 11 3929 6212 6877 +13409 2 2 13 11 4670 5920 6412 +13410 2 2 13 11 3897 5810 6540 +13411 2 2 13 11 3898 6541 5811 +13412 2 2 13 11 4776 6773 6620 +13413 2 2 13 11 4414 5762 6559 +13414 2 2 13 11 4799 6517 6758 +13415 2 2 13 11 4504 6283 6233 +13416 2 2 13 11 4458 5792 6640 +13417 2 2 13 11 3733 5714 6939 +13418 2 2 13 11 4419 6892 5923 +13419 2 2 13 11 3872 5600 6953 +13420 2 2 13 11 4701 5608 6887 +13421 2 2 13 11 4254 6553 6704 +13422 2 2 13 11 4402 6939 5714 +13423 2 2 13 11 4831 5899 6462 +13424 2 2 13 11 5000 5705 6785 +13425 2 2 13 11 3894 6530 5933 +13426 2 2 13 11 3914 6230 6312 +13427 2 2 13 11 4367 5769 6602 +13428 2 2 13 11 4471 6312 6113 +13429 2 2 13 11 4512 5657 6933 +13430 2 2 13 11 3753 6851 5593 +13431 2 2 13 11 4586 6461 6644 +13432 2 2 13 11 5064 6737 5861 +13433 2 2 13 11 4450 5653 6845 +13434 2 2 13 11 3883 5906 6486 +13435 2 2 13 11 4709 6888 6384 +13436 2 2 13 11 4418 5751 6619 +13437 2 2 13 11 4500 5623 6950 +13438 2 2 13 11 3729 5900 6582 +13439 2 2 13 11 3883 6486 6058 +13440 2 2 13 11 4841 6756 5723 +13441 2 2 13 11 4872 6785 5705 +13442 2 2 13 11 4279 6902 6181 +13443 2 2 13 11 4610 6355 6408 +13444 2 2 13 11 4267 6741 6127 +13445 2 2 13 11 4459 5762 6623 +13446 2 2 13 11 4487 6246 6515 +13447 2 2 13 11 4246 5771 6654 +13448 2 2 13 11 3918 6103 6406 +13449 2 2 13 11 4069 6620 6773 +13450 2 2 13 11 4449 6570 5988 +13451 2 2 13 11 3724 6656 6480 +13452 2 2 13 11 4541 6806 6543 +13453 2 2 13 11 4471 6113 6321 +13454 2 2 13 11 4563 6186 6721 +13455 2 2 13 11 4902 6714 6716 +13456 2 2 13 11 5001 6413 6018 +13457 2 2 13 11 4764 6120 6911 +13458 2 2 13 11 3988 6216 6622 +13459 2 2 13 11 5339 5722 6761 +13460 2 2 13 11 4471 6446 6258 +13461 2 2 13 11 4477 6710 6248 +13462 2 2 13 11 4249 5785 6728 +13463 2 2 13 11 4493 6193 6313 +13464 2 2 13 11 305 6452 6014 +13465 2 2 13 11 3896 6283 6321 +13466 2 2 13 11 4323 6148 6874 +13467 2 2 13 11 4324 6875 6150 +13468 2 2 13 11 4952 6122 6652 +13469 2 2 13 11 4463 5874 6571 +13470 2 2 13 11 5005 6406 6103 +13471 2 2 13 11 4594 6278 6501 +13472 2 2 13 11 4699 6444 6926 +13473 2 2 13 11 4700 6927 6445 +13474 2 2 13 11 3988 6384 6888 +13475 2 2 13 11 4536 6505 6934 +13476 2 2 13 11 4450 5760 6920 +13477 2 2 13 11 4499 6367 6149 +13478 2 2 13 11 4536 5961 6505 +13479 2 2 13 11 3895 6081 6361 +13480 2 2 13 11 4549 5990 6402 +13481 2 2 13 11 4443 6876 6227 +13482 2 2 13 11 4310 6531 6305 +13483 2 2 13 11 4411 6045 6546 +13484 2 2 13 11 4412 6547 6046 +13485 2 2 13 11 4368 5821 6699 +13486 2 2 13 11 3730 5962 6470 +13487 2 2 13 11 4411 6546 5822 +13488 2 2 13 11 4412 5823 6547 +13489 2 2 13 11 4415 6720 6119 +13490 2 2 13 11 4504 6321 6283 +13491 2 2 13 11 3944 6331 6814 +13492 2 2 13 11 4602 6912 5700 +13493 2 2 13 11 4603 5701 6913 +13494 2 2 13 11 4377 5933 6530 +13495 2 2 13 11 4597 6921 6911 +13496 2 2 13 11 3721 5998 6586 +13497 2 2 13 11 4433 5772 6847 +13498 2 2 13 11 4434 6848 5773 +13499 2 2 13 11 4368 6726 5821 +13500 2 2 13 11 3716 6408 6355 +13501 2 2 13 11 4471 6258 6489 +13502 2 2 13 11 4892 6874 5754 +13503 2 2 13 11 4893 5755 6875 +13504 2 2 13 11 4279 5814 6820 +13505 2 2 13 11 4983 6720 6464 +13506 2 2 13 11 5072 6645 6182 +13507 2 2 13 11 5073 6183 6646 +13508 2 2 13 11 4502 6058 6486 +13509 2 2 13 11 3871 6565 6302 +13510 2 2 13 11 3952 6619 6849 +13511 2 2 13 11 3807 6734 5964 +13512 2 2 13 11 4486 6816 5788 +13513 2 2 13 11 3808 5965 6852 +13514 2 2 13 11 4452 6922 5796 +13515 2 2 13 11 4448 6716 6714 +13516 2 2 13 11 3673 6505 5961 +13517 2 2 13 11 4788 6708 6781 +13518 2 2 13 11 3711 6441 6630 +13519 2 2 13 11 4444 6105 6357 +13520 2 2 13 11 98 6268 6410 +13521 2 2 13 11 5243 6320 6595 +13522 2 2 13 11 4510 6474 6591 +13523 2 2 13 11 4511 6592 6475 +13524 2 2 13 11 3722 6068 6885 +13525 2 2 13 11 4639 6630 6441 +13526 2 2 13 11 4635 6761 5722 +13527 2 2 13 11 4555 6045 6625 +13528 2 2 13 11 4556 6626 6046 +13529 2 2 13 11 4887 6467 6496 +13530 2 2 13 11 3905 5988 6570 +13531 2 2 13 11 4697 6551 6701 +13532 2 2 13 11 4597 6622 6216 +13533 2 2 13 11 4345 6145 6400 +13534 2 2 13 11 3690 5744 6889 +13535 2 2 13 11 3721 6399 6281 +13536 2 2 13 11 4697 5743 6876 +13537 2 2 13 11 4832 6934 6505 +13538 2 2 13 11 4505 6410 6268 +13539 2 2 13 11 4444 6281 6399 +13540 2 2 13 11 3811 6900 5858 +13541 2 2 13 11 3714 6847 5772 +13542 2 2 13 11 3715 5773 6848 +13543 2 2 13 11 4552 6489 6258 +13544 2 2 13 11 3724 5876 6656 +13545 2 2 13 11 4477 6042 6755 +13546 2 2 13 11 4684 6666 6598 +13547 2 2 13 11 4685 6599 6667 +13548 2 2 13 11 4770 6757 6696 +13549 2 2 13 11 4348 6463 6144 +13550 2 2 13 11 3819 6781 6708 +13551 2 2 13 11 3873 6651 5887 +13552 2 2 13 11 4845 6790 6890 +13553 2 2 13 11 3723 6887 5871 +13554 2 2 13 11 4458 6724 5996 +13555 2 2 13 11 4987 6798 5932 +13556 2 2 13 11 3684 6006 6766 +13557 2 2 13 11 3685 6767 6007 +13558 2 2 13 11 3843 6601 6398 +13559 2 2 13 11 3706 6595 6320 +13560 2 2 13 11 4383 6740 5839 +13561 2 2 13 11 4583 6528 6493 +13562 2 2 13 11 4769 6754 6069 +13563 2 2 13 11 3956 5932 6798 +13564 2 2 13 11 4426 6687 6409 +13565 2 2 13 11 4684 6520 6666 +13566 2 2 13 11 4685 6667 6521 +13567 2 2 13 11 4663 6341 6878 +13568 2 2 13 11 4664 6879 6343 +13569 2 2 13 11 3672 6258 6446 +13570 2 2 13 11 4576 6706 6553 +13571 2 2 13 11 3649 6701 6551 +13572 2 2 13 11 3671 6084 6843 +13573 2 2 13 11 3940 6696 6757 +13574 2 2 13 11 3974 6647 6072 +13575 2 2 13 11 4355 6878 6341 +13576 2 2 13 11 4356 6343 6879 +13577 2 2 13 11 4546 6823 6213 +13578 2 2 13 11 93 6853 5806 +13579 2 2 13 11 4003 6890 6790 +13580 2 2 13 11 4507 6598 6666 +13581 2 2 13 11 4508 6667 6599 +13582 2 2 13 11 4131 5948 6835 +13583 2 2 13 11 4834 6850 6832 +13584 2 2 13 11 4694 5858 6900 +13585 2 2 13 11 3990 6858 6471 +13586 2 2 13 11 4287 5996 6724 +13587 2 2 13 11 4388 6496 6467 +13588 2 2 13 11 4675 6800 5851 +13589 2 2 13 11 4279 5776 6902 +13590 2 2 13 11 4456 6072 6647 +13591 2 2 13 11 4316 6819 6008 +13592 2 2 13 11 4653 6487 6403 +13593 2 2 13 11 4342 6172 6617 +13594 2 2 13 11 4343 6618 6173 +13595 2 2 13 11 4535 6515 6246 +13596 2 2 13 11 5018 6792 6178 +13597 2 2 13 11 5019 6179 6793 +13598 2 2 13 11 4009 6213 6823 +13599 2 2 13 11 3863 5897 6924 +13600 2 2 13 11 3864 6925 5898 +13601 2 2 13 11 3914 6312 6489 +13602 2 2 13 11 4529 6832 6850 +13603 2 2 13 11 4532 6766 6006 +13604 2 2 13 11 4533 6007 6767 +13605 2 2 13 11 3859 5923 6892 +13606 2 2 13 11 4503 6428 6644 +13607 2 2 13 11 3778 5866 6920 +13608 2 2 13 11 4455 6501 6278 +13609 2 2 13 11 4832 6505 6668 +13610 2 2 13 11 4620 6398 6601 +13611 2 2 13 11 4471 6489 6312 +13612 2 2 13 11 4462 6835 5948 +13613 2 2 13 11 4497 6170 6779 +13614 2 2 13 11 4580 6440 6745 +13615 2 2 13 11 3666 6666 6520 +13616 2 2 13 11 3667 6521 6667 +13617 2 2 13 11 4617 6675 6511 +13618 2 2 13 11 4515 6493 6528 +13619 2 2 13 11 4435 6775 5959 +13620 2 2 13 11 4459 6403 6487 +13621 2 2 13 11 4713 6471 6858 +13622 2 2 13 11 100 6769 6166 +13623 2 2 13 11 4197 6946 5807 +13624 2 2 13 11 4740 6553 6706 +13625 2 2 13 11 4221 6069 6754 +13626 2 2 13 11 4907 6568 6260 +13627 2 2 13 11 3726 6297 6779 +13628 2 2 13 11 4482 6305 6531 +13629 2 2 13 11 4402 6104 6939 +13630 2 2 13 11 4224 6032 6886 +13631 2 2 13 11 4115 6260 6568 +13632 2 2 13 11 331 6942 5966 +13633 2 2 13 11 245 5967 6943 +13634 2 2 13 11 4452 6765 6006 +13635 2 2 13 11 4796 6779 6297 +13636 2 2 13 11 4245 5900 6918 +13637 2 2 13 11 4204 6019 6862 +13638 2 2 13 11 4205 6863 6020 +13639 2 2 13 11 4786 6726 6331 +13640 2 2 13 11 4230 6804 6192 +13641 2 2 13 11 3731 6182 6645 +13642 2 2 13 11 3732 6646 6183 +13643 2 2 13 11 4784 6678 6786 +13644 2 2 13 11 4785 6787 6679 +13645 2 2 13 11 4072 6511 6675 +13646 2 2 13 11 4491 6302 6565 +13647 2 2 13 11 4525 6235 6681 +13648 2 2 13 11 4697 6876 6551 +13649 2 2 13 11 3806 6044 6756 +13650 2 2 13 11 4720 6492 6877 +13651 2 2 13 11 4854 6333 6602 +13652 2 2 13 11 4924 6746 6807 +13653 2 2 13 11 3721 6586 6399 +13654 2 2 13 11 3736 6065 6818 +13655 2 2 13 11 4488 6786 6678 +13656 2 2 13 11 4489 6679 6787 +13657 2 2 13 11 4316 6264 6819 +13658 2 2 13 11 4957 6101 6743 +13659 2 2 13 11 4517 6630 6589 +13660 2 2 13 11 4533 6861 6007 +13661 2 2 13 11 3980 6674 6861 +13662 2 2 13 11 4554 6166 6769 +13663 2 2 13 11 3983 6248 6710 +13664 2 2 13 11 5151 6192 6804 +13665 2 2 13 11 3930 6681 6235 +13666 2 2 13 11 4542 6527 6923 +13667 2 2 13 11 4544 6886 6032 +13668 2 2 13 11 3856 6106 6940 +13669 2 2 13 11 3726 6779 6170 +13670 2 2 13 11 3996 6591 6474 +13671 2 2 13 11 3997 6475 6592 +13672 2 2 13 11 4368 6331 6726 +13673 2 2 13 11 4542 6923 6620 +13674 2 2 13 11 4572 6642 6634 +13675 2 2 13 11 4573 6635 6643 +13676 2 2 13 11 3677 6267 6762 +13677 2 2 13 11 5140 6772 6318 +13678 2 2 13 11 4443 6551 6876 +13679 2 2 13 11 4346 6653 6365 +13680 2 2 13 11 4478 6807 6746 +13681 2 2 13 11 3924 6060 6821 +13682 2 2 13 11 3925 6822 6061 +13683 2 2 13 11 4367 6602 6333 +13684 2 2 13 11 3659 6318 6772 +13685 2 2 13 11 4502 6399 6586 +13686 2 2 13 11 3924 6821 6422 +13687 2 2 13 11 3925 6423 6822 +13688 2 2 13 11 4736 6899 6731 +13689 2 2 13 11 4639 6589 6630 +13690 2 2 13 11 3740 6911 6120 +13691 2 2 13 11 5100 6585 6523 +13692 2 2 13 11 4437 6101 6901 +13693 2 2 13 11 4093 6644 6428 +13694 2 2 13 11 4629 6634 6642 +13695 2 2 13 11 4630 6643 6635 +13696 2 2 13 11 3889 6625 6391 +13697 2 2 13 11 3890 6392 6626 +13698 2 2 13 11 4726 6542 6834 +13699 2 2 13 11 4502 6937 6058 +13700 2 2 13 11 4702 6834 6542 +13701 2 2 13 11 3895 6935 6081 +13702 2 2 13 11 5186 6884 6390 +13703 2 2 13 11 3673 6668 6505 +13704 2 2 13 11 4395 6877 6212 +13705 2 2 13 11 3748 6731 6899 +13706 2 2 13 11 4829 6510 6688 +13707 2 2 13 11 4474 6919 6138 +13708 2 2 13 11 4415 6464 6720 +13709 2 2 13 11 270 6707 6873 +13710 2 2 13 11 4629 6642 6540 +13711 2 2 13 11 4630 6541 6643 +13712 2 2 13 11 3796 6725 6788 +13713 2 2 13 11 3773 6523 6585 +13714 2 2 13 11 4565 6762 6267 +13715 2 2 13 11 4570 6745 6440 +13716 2 2 13 11 4753 6819 6264 +13717 2 2 13 11 5366 6847 6518 +13718 2 2 13 11 5367 6519 6848 +13719 2 2 13 11 4178 6556 6689 +13720 2 2 13 11 3897 6540 6642 +13721 2 2 13 11 3898 6643 6541 +13722 2 2 13 11 4901 6689 6556 +13723 2 2 13 11 4497 6951 6170 +13724 2 2 13 11 3892 6948 6131 +13725 2 2 13 11 3893 6132 6949 +13726 2 2 13 11 4490 6390 6884 +13727 2 2 13 11 3714 6518 6847 +13728 2 2 13 11 3715 6848 6519 +13729 2 2 13 11 3754 6688 6510 +13730 2 2 13 11 4467 6839 6290 +13731 2 2 13 11 4468 6291 6840 +13732 2 2 13 11 4767 6873 6707 +13733 2 2 13 11 3931 6589 6815 +13734 2 2 13 11 4740 6704 6553 +13735 2 2 13 11 4777 6870 6407 +13736 2 2 13 11 4724 6788 6725 +13737 2 2 13 11 4879 6940 6310 +13738 2 2 13 11 4728 6407 6870 +13739 2 2 13 11 4746 6484 6901 +13740 2 2 13 11 4477 6755 6710 +13741 2 2 13 11 4256 6685 6795 +13742 2 2 13 11 4257 6796 6686 +13743 2 2 13 11 4639 6815 6589 +13744 2 2 13 11 4978 6795 6685 +13745 2 2 13 11 4979 6686 6796 +13746 2 2 13 11 4538 6926 6444 +13747 2 2 13 11 4539 6445 6927 +13748 2 2 13 11 4886 6710 6755 +13749 2 2 13 11 4437 6901 6484 +13750 2 2 13 11 3873 6923 6527 +13751 2 2 13 11 4776 6620 6923 +13752 2 2 13 11 4645 6854 6858 +13753 2 2 13 11 4495 6522 6936 +13754 2 2 13 11 4546 6732 6823 +13755 2 2 13 11 4790 6823 6732 +13756 2 2 13 11 4618 6811 6867 +13757 2 2 13 11 4619 6869 6812 +13758 2 2 13 11 333 6908 6916 +13759 2 2 13 11 243 6917 6909 +13760 2 2 13 11 4713 6858 6854 +13761 2 2 13 11 4639 6888 6815 +13762 2 2 13 11 4756 6867 6811 +13763 2 2 13 11 4757 6812 6869 +13764 2 2 13 11 4709 6815 6888 +13765 2 2 13 11 4747 6916 6908 +13766 2 2 13 11 4748 6909 6917 +$EndElements diff --git a/test/mixeddimension/facet/1p_1p/matrixproblem.hh b/test/mixeddimension/facet/1p_1p/matrixproblem.hh new file mode 100644 index 0000000000000000000000000000000000000000..aa73176ec72b4aad17d48402f0d846657a85b3fd --- /dev/null +++ b/test/mixeddimension/facet/1p_1p/matrixproblem.hh @@ -0,0 +1,210 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * + * \brief A test problem for the one-phase model: + * water is flowing from bottom to top through and around a low permeable lens. + */ +#ifndef DUMUX_1PMATRIX_PROBLEM_HH +#define DUMUX_1PMATRIX_PROBLEM_HH + +#include <dumux/mixeddimension/facet/mpfa/properties.hh> +#include <dumux/mixeddimension/subproblemproperties.hh> + +#include <dumux/porousmediumflow/1p/implicit/model.hh> +#include <dumux/porousmediumflow/implicit/problem.hh> + +#include <dumux/material/components/unit.hh> +#include <dumux/material/fluidsystems/liquidphase.hh> + +#include "matrixspatialparams.hh" + +namespace Dumux +{ +template <class TypeTag> +class OnePMpfaMatrixProblem; + +namespace Properties +{ +NEW_TYPE_TAG(OnePMatrixProblem, INHERITS_FROM(OneP)); +NEW_TYPE_TAG(OnePCCMpfaMatrixProblem, INHERITS_FROM(FacetCouplingBulkMpfaModel, OnePMatrixProblem)); + +SET_PROP(OnePMatrixProblem, Fluid) +{ +private: + typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar; +public: + typedef FluidSystems::LiquidPhase<Scalar, Unit<Scalar> > type; +}; + +// Set the problem property +SET_TYPE_PROP(OnePMatrixProblem, Problem, OnePMpfaMatrixProblem<TypeTag>); + +// Set the spatial parameters +SET_TYPE_PROP(OnePMatrixProblem, SpatialParams, OnePMatrixSpatialParams<TypeTag>); + +// Linear solver settings +SET_TYPE_PROP(OnePMatrixProblem, LinearSolver, SuperLUBackend<TypeTag>); + +// Enable gravity +SET_BOOL_PROP(OnePMatrixProblem, ProblemEnableGravity, false); + +// change mpfa method +//SET_PROP(OnePMatrixProblem, MpfaMethod) { static const MpfaMethods value = MpfaMethods::lMethod; }; +} + +/*! + * \ingroup OnePModel + * \ingroup ImplicitTestProblems + * \brief Test problem for the one-phase model + */ + +template <class TypeTag> +class OnePMpfaMatrixProblem : public ImplicitPorousMediaProblem<TypeTag> +{ + using ParentType = ImplicitPorousMediaProblem<TypeTag>; + + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Element = typename GridView::template Codim<0>::Entity; + using Intersection = typename GridView::Intersection; + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Indices = typename GET_PROP_TYPE(TypeTag, Indices); + using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); + using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); + using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); + using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); + using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); + + using GlobalProblemTypeTag = typename GET_PROP_TYPE(TypeTag, GlobalProblemTypeTag); + using CouplingManager = typename GET_PROP_TYPE(GlobalProblemTypeTag, CouplingManager); + + enum + { + conti0EqIdx = Indices::conti0EqIdx, + pressureIdx = Indices::pressureIdx + }; + + static constexpr int numEq = GET_PROP_VALUE(TypeTag, NumEq); + static constexpr int dim = GridView::dimension; + static constexpr int dimWorld = GridView::dimensionworld; + + using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; + + +public: + OnePMpfaMatrixProblem(TimeManager &timeManager, const GridView &gridView) + : ParentType(timeManager, gridView) + { + name_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Problem, Name) + "_matrix"; + eps_ = 1e-6; + } + + /*! + * \brief The problem name. + * + * This is used as a prefix for files generated by the simulation. + */ + const std::string& name() const + { return name_; } + + /*! + * \brief Return the temperature within the domain in [K]. + * + * This problem assumes a temperature of 10 degrees Celsius. + */ + Scalar temperature() const + { return 273.15 + 10; } + + /*! + * \brief Return the sources within the domain. + */ + PrimaryVariables sourceAtPos(const GlobalPosition& globalPos) const + { return PrimaryVariables(0.0); } + + /*! + * \brief Specifies which kind of boundary condition should be + * used for which equation on a given boundary control volume. + */ + BoundaryTypes boundaryTypes(const Element& element, const SubControlVolumeFace& scvf) const + { + BoundaryTypes values; + const auto globalPos = scvf.ipGlobal(); + + values.setAllNeumann(); + if (globalPos[1] < eps_ || globalPos[1] > this->bBoxMax()[1] - eps_) + values.setAllDirichlet(); + + if (couplingManager().isInteriorBoundary(element, scvf)) + values.setAllNeumann(); + + return values; + } + + /*! + * \brief Specifies if a given intersection is on an interior boundary + */ + bool isInteriorBoundary(const Element& element, const Intersection& is) const + { return couplingManager().isInteriorBoundary(element, is); } + + /*! + * \brief Evaluate the boundary conditions for a dirichlet + * control volume. + */ + PrimaryVariables dirichletAtPos(const GlobalPosition& globalPos) const + { + PrimaryVariables values; + values[pressureIdx] = 1.0 + 0.5*globalPos[1]; + return values; + } + + /*! + * \brief Evaluate the boundary conditions for a neumann + * boundary segment. + */ + PrimaryVariables neumannAtPos(const GlobalPosition& globalPos) const + { return PrimaryVariables(0.0); } + + /*! + * \brief Evaluate the initial value for a control volume. + */ + PrimaryVariables initialAtPos(const GlobalPosition& globalPos) const + { + Scalar p = 1.0 + globalPos[1]/this->bBoxMax()[1]; + return PrimaryVariables(p); + } + + //! Set the coupling manager + void setCouplingManager(std::shared_ptr<CouplingManager> cm) + { couplingManager_ = cm; } + + //! Get the coupling manager + const CouplingManager& couplingManager() const + { return *couplingManager_; } + +private: + std::string name_; + Scalar eps_; + std::shared_ptr<CouplingManager> couplingManager_; +}; +} //end namespace + +#endif diff --git a/test/mixeddimension/facet/1p_1p/matrixspatialparams.hh b/test/mixeddimension/facet/1p_1p/matrixspatialparams.hh new file mode 100644 index 0000000000000000000000000000000000000000..9dca660fd919404098220242e8110d91513e3eac --- /dev/null +++ b/test/mixeddimension/facet/1p_1p/matrixspatialparams.hh @@ -0,0 +1,86 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * + * \brief The spatial parameters class for the matrix problem + */ +#ifndef DUMUX_1P_MATRIX_SPATIALPARAMS_HH +#define DUMUX_1P_MATRIX_SPATIALPARAMS_HH + +#include <dumux/material/spatialparams/implicit1p.hh> + +namespace Dumux +{ + +/*! + * \ingroup OnePModel + * \ingroup ImplicitTestProblems + * + * \brief The spatial parameters class for the matrix problem + */ +template<class TypeTag> +class OnePMatrixSpatialParams : public ImplicitSpatialParamsOneP<TypeTag> +{ + using ParentType = ImplicitSpatialParamsOneP<TypeTag>; + + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Element = typename GridView::template Codim<0>::Entity; + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); + + static constexpr int dimWorld = GridView::dimensionworld; + using GlobalPosition = Dune::FieldVector<Scalar,dimWorld>; + + using Tensor = Dune::FieldMatrix<Scalar, dimWorld, dimWorld>; + +public: + using PermeabilityType = Tensor; + + OnePMatrixSpatialParams(const Problem& problem, const GridView& gridView) + : ParentType(problem, gridView) + { + Scalar permeability = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, MatrixPermeability); + + K_[0][0] = permeability; + K_[1][1] = permeability; + K_[0][1] = 0.; + K_[1][0] = 0.; + } + + /*! + * \brief Return the intrinsic permeability for the given position in [m^2]. + */ + Tensor permeabilityAtPos(const GlobalPosition& globalPos) const + { return K_; } + + /*! + * \brief Define the porosity in [-]. + */ + Scalar porosityAtPos(const GlobalPosition& globalPos) const + { return 0.25; } + + +private: + Tensor K_; +}; +} //end namespace + +#endif diff --git a/test/mixeddimension/facet/1p_1p/test_fracture_1p_1p.cc b/test/mixeddimension/facet/1p_1p/test_fracture_1p_1p.cc new file mode 100644 index 0000000000000000000000000000000000000000..2aed429e429e8c63542bc0f0e94f1e4d95dab2ea --- /dev/null +++ b/test/mixeddimension/facet/1p_1p/test_fracture_1p_1p.cc @@ -0,0 +1,45 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/*! + * \file + * + * \brief test for the 1d 3d cell-centered coupled model + */ +#include "config.h" +#include "1d2dtestproblem.hh" +#include <dumux/mixeddimension/facet/start.hh> + +/*! + * \brief Provides an interface for customizing error messages associated with + * reading in parameters. + * + * \param progName The name of the program, that was tried to be started. + * \param errorMsg The error message that was issued by the start function. + * Comprises the thing that went wrong and a general help message. + */ +void usage(const char *progName, const std::string &errorMsg) +{ + // TODO +} + +int main(int argc, char** argv) +{ + typedef TTAG(OnePFacetCoupling) ProblemTypeTag; + return Dumux::start<ProblemTypeTag>(argc, argv, usage); +} diff --git a/test/mixeddimension/facet/1p_1p/test_fracture_1p_1p.input b/test/mixeddimension/facet/1p_1p/test_fracture_1p_1p.input new file mode 100644 index 0000000000000000000000000000000000000000..96b275c2da7a92e80d075c9f2309629f156c2e7e --- /dev/null +++ b/test/mixeddimension/facet/1p_1p/test_fracture_1p_1p.input @@ -0,0 +1,33 @@ +[TimeManager] +DtInitial = 1 # [s] +TEnd = 1 # [s] +MaxTimeStepSize = 1 +DtInitialBulkProblem = 1 # [s] +DtInitialLowDimProblem = 1 # [s] +EpisodeTime = 1 # [s] + +[Grid] +File = ./grids/simplefracture_long.msh + +[Problem] +Name = test_1dfracture + +[MixedDimension] +UseIterativeSolver = False + +[IterativeAlgorithm] +MaxIterations = 100 +Tolerance = 1.0e-8 +Verbose = 1 + +[SpatialParams] +FractureAperture = 1e-1 # [m] +FracturePermeability = 1e-15 # [m^2] +MatrixPermeability = 1e-14 # [m^2] + +[Vtk] +AddVelocity = False + +[Newton] +MaxRelativeShift = 1e-5 +MaxSteps = 20 diff --git a/test/mixeddimension/facet/CMakeLists.txt b/test/mixeddimension/facet/CMakeLists.txt new file mode 100644 index 0000000000000000000000000000000000000000..414572638497a6f9403cd690015c101d7e0b59a7 --- /dev/null +++ b/test/mixeddimension/facet/CMakeLists.txt @@ -0,0 +1,2 @@ +add_subdirectory("1p_1p") +add_subdirectory("1p2c_1p2c") \ No newline at end of file