diff --git a/dumux/discretization/box/boxgeometryhelper.hh b/dumux/discretization/box/boxgeometryhelper.hh index e9e35a8cc342ff25344c6b2b67f2434fbc9694d5..9d72c54b0b9de5aea3ec31b650bdf44156519946 100644 --- a/dumux/discretization/box/boxgeometryhelper.hh +++ b/dumux/discretization/box/boxgeometryhelper.hh @@ -109,7 +109,7 @@ public: return 1.0; } -private: +protected: const typename Element::Geometry& elementGeometry_; //!< Reference to the element geometry std::size_t corners_; // number of element corners std::array p; // the points needed for construction of the geometries @@ -337,7 +337,7 @@ public: return (p[1]-p[0]).two_norm(); } -private: +protected: const typename Element::Geometry& elementGeometry_; //!< Reference to the element geometry std::size_t corners_; // number of element corners std::array p; // the points needed for construction of the geometries @@ -624,7 +624,7 @@ public: return 0.5*Dumux::crossProduct(p[3]-p[0], p[2]-p[1]).two_norm(); } -private: +protected: const typename Element::Geometry& elementGeometry_; //!< Reference to the element geometry std::size_t corners_; // number of element corners std::array p; // the points needed for construction of the scv/scvf geometries diff --git a/dumux/io/vtkoutputmodule.hh b/dumux/io/vtkoutputmodule.hh index daf41b0b1933458f5d65ac27d752d8d95830fe03..f1f115f9d7e906541b89d57dfa36335a234c56fb 100644 --- a/dumux/io/vtkoutputmodule.hh +++ b/dumux/io/vtkoutputmodule.hh @@ -235,6 +235,24 @@ public: } } +protected: + // some return functions for differing implementations to use + const Problem& problem() const { return problem_; } + const FVGridGeometry& fvGridGeometry() const { return gridGeom_; } + const GridVariables& gridVariables() const { return gridVariables_; } + const SolutionVector& sol() const { return sol_; } + + const bool verbose() const { return verbose_; } + const std::string& name() const { return name_; } + const Dune::VTK::DataMode dataMode() const { return dm_; } + + Dune::VTKWriter& writer() { return *writer_; } + Dune::VTKSequenceWriter& sequenceWriter() { return sequenceWriter_; } + + const std::vector& volVarScalarDataInfo() const { return volVarScalarDataInfo_; } + const std::vector& volVarVectorDataInfo() const { return volVarVectorDataInfo_; } + const std::vector& fields() const { return fields_; } + private: //! Assembles the fields and adds them to the writer (conforming output) diff --git a/dumux/material/fluidmatrixinteractions/2p/brookscoreyparams.hh b/dumux/material/fluidmatrixinteractions/2p/brookscoreyparams.hh index 8133b1b846862d1cfd16b628ec992768a5d9525b..39e6ee8da52f4bf8996e0d9f7535b5da915b67b9 100644 --- a/dumux/material/fluidmatrixinteractions/2p/brookscoreyparams.hh +++ b/dumux/material/fluidmatrixinteractions/2p/brookscoreyparams.hh @@ -26,6 +26,8 @@ #ifndef DUMUX_BROOKS_COREY_PARAMS_HH #define DUMUX_BROOKS_COREY_PARAMS_HH +#include + #include namespace Dumux @@ -55,6 +57,16 @@ public: { } + /*! + * \brief Equality comparison with another set of params + */ + template + bool operator== (const OtherParams& otherParams) const + { + return Dune::FloatCmp::eq(pe_, otherParams.pe(), /*eps*/1e-6*pe_) + && Dune::FloatCmp::eq(lambda_, otherParams.lambda(), /*eps*/1e-6*lambda_); + } + /*! * \brief Returns the entry pressure in \f$\mathrm{[Pa]}\f$ */ diff --git a/dumux/material/fluidmatrixinteractions/2p/regularizedbrookscoreyparams.hh b/dumux/material/fluidmatrixinteractions/2p/regularizedbrookscoreyparams.hh index dfcc72527ac6c9f4b40c14f4483a94572c3a9514..014b3510dd46c2356a069e4b9a039a861be3d0ab 100644 --- a/dumux/material/fluidmatrixinteractions/2p/regularizedbrookscoreyparams.hh +++ b/dumux/material/fluidmatrixinteractions/2p/regularizedbrookscoreyparams.hh @@ -25,6 +25,8 @@ #ifndef DUMUX_REGULARIZED_BROOKS_COREY_PARAMS_HH #define DUMUX_REGULARIZED_BROOKS_COREY_PARAMS_HH +#include + #include "brookscoreyparams.hh" namespace Dumux @@ -54,6 +56,16 @@ public: setThresholdSw(0.01); } + /*! + * \brief Equality comparison with another set of params + */ + template + bool operator== (const OtherParams& otherParams) const + { + return Dune::FloatCmp::eq(thresholdSw_, otherParams.thresholdSw(), /*eps*/1e-6*thresholdSw_) + && BrooksCoreyParams::operator==(otherParams); + } + /*! * \brief Set the threshold saturation below which the capillary pressure * is regularized. diff --git a/dumux/porousmediumflow/CMakeLists.txt b/dumux/porousmediumflow/CMakeLists.txt index 378b552ced3af70ee3a1e7995e2cc79170b99877..47d61ae2f2dca3c190957b1a04a67fcafb754276 100644 --- a/dumux/porousmediumflow/CMakeLists.txt +++ b/dumux/porousmediumflow/CMakeLists.txt @@ -9,6 +9,7 @@ add_subdirectory("2pncmin") add_subdirectory("3p") add_subdirectory("3pwateroil") add_subdirectory("3p3c") +add_subdirectory("boxdfm") add_subdirectory("co2") add_subdirectory("compositional") add_subdirectory("immiscible") diff --git a/dumux/porousmediumflow/boxdfm/CMakeLists.txt b/dumux/porousmediumflow/boxdfm/CMakeLists.txt new file mode 100644 index 0000000000000000000000000000000000000000..e85e576492f0497736bc187224620b0004341262 --- /dev/null +++ b/dumux/porousmediumflow/boxdfm/CMakeLists.txt @@ -0,0 +1,11 @@ + +#install headers +install(FILES +fluxvariablescache.hh +fvelementgeometry.hh +fvgridgeometry.hh +geometryhelper.hh +model.hh +subcontrolvolume.hh +subcontrolvolumeface.hh +DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/porousmediumflow/boxdfm) diff --git a/dumux/porousmediumflow/boxdfm/fluxvariablescache.hh b/dumux/porousmediumflow/boxdfm/fluxvariablescache.hh new file mode 100644 index 0000000000000000000000000000000000000000..7d436eabdbeab66cc6e03eeca9bd3eae8d5e6b60 --- /dev/null +++ b/dumux/porousmediumflow/boxdfm/fluxvariablescache.hh @@ -0,0 +1,152 @@ +// -*- 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 . * + *****************************************************************************/ +/*! + * \file + * \brief Cache class for the flux variables to be used + * in conjunction with the box discrete fracture scheme + */ +#ifndef DUMUX_POROUSMEDIUM_BOXDFM_FLUXVARIABLESCACHE_HH +#define DUMUX_POROUSMEDIUM_BOXDFM_FLUXVARIABLESCACHE_HH + +#include + +#include +#include +#include + +namespace Dumux { + +/*! + * \ingroup BoxDiscretization + * \ingroup BoxDFM + * \brief We only store discretization-related quantities for the box method. + * However, we cannot reuse the cache of the standard box method as we have + * to take into account the scvs that lie on fracture facets. + */ +template +class BoxDfmFluxVariablesCache +{ + 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 FluxVariables = typename GET_PROP_TYPE(TypeTag, FluxVariables); + using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry)::LocalView; + using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, GridVolumeVariables)::LocalView; + using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace; + using Element = typename GridView::template Codim<0>::Entity; + using IndexType = typename GridView::IndexSet::IndexType; + using Stencil = std::vector; + using TransmissibilityVector = std::vector; + + using CoordScalar = typename GridView::ctype; + static const int dim = GridView::dimension; + static const int dimWorld = GridView::dimensionworld; + + using FeCache = Dune::PQkLocalFiniteElementCache; + using FeLocalBasis = typename FeCache::FiniteElementType::Traits::LocalBasisType; + using ShapeJacobian = typename FeLocalBasis::Traits::JacobianType; + using ShapeValue = typename Dune::FieldVector; + using JacobianInverseTransposed = typename Element::Geometry::JacobianInverseTransposed; + using GlobalPosition = Dune::FieldVector; + +public: + + void update(const Problem& problem, + const Element& element, + const FVElementGeometry& fvGeometry, + const ElementVolumeVariables& elemVolVars, + const SubControlVolumeFace& scvf) + { + const auto geometry = element.geometry(); + const auto& localBasis = fvGeometry.feLocalBasis(); + + // evaluate shape functions and gradients at the integration point + std::vector shapeVals; + const auto ipLocal = geometry.local(scvf.ipGlobal()); + jacInvT_ = geometry.jacobianInverseTransposed(ipLocal); + localBasis.evaluateJacobian(ipLocal, shapeJacobian_); + localBasis.evaluateFunction(ipLocal, shapeVals); + + // set the shape values + shapeValues_.resize(fvGeometry.numScv(), 0.0); + if (!scvf.isOnFracture()) + std::copy(shapeVals.begin(), shapeVals.end(), shapeValues_.begin()); + else + { + const auto thisFacetIdx = scvf.facetIndexInElement(); + for (const auto& scv: scvs(fvGeometry)) + if (scv.isOnFracture() && scv.facetIndexInElement() == thisFacetIdx) + shapeValues_[scv.indexInElement()] = shapeVals[scv.localDofIndex()]; + } + + // set the shape value gradients + gradN_.resize(fvGeometry.numScv(), GlobalPosition(0.0)); + if (!scvf.isOnFracture()) + { + for (const auto& scv: scvs(fvGeometry)) + if (!scv.isOnFracture()) + jacInvT_.mv(shapeJacobian_[scv.localDofIndex()][0], gradN_[scv.indexInElement()]); + } + else + { + const auto thisFacetIdx = scvf.facetIndexInElement(); + + // first, find all local dofs on this facet + std::vector facetLocalDofs; + for (const auto& scv : scvs(fvGeometry)) + if (scv.isOnFracture() && scv.facetIndexInElement() == thisFacetIdx) + facetLocalDofs.push_back(scv.localDofIndex()); + + for (const auto& scv: scvs(fvGeometry)) + { + // now, create entries for all fracture scvs on this same facet ... + if (scv.isOnFracture() && scv.facetIndexInElement() == thisFacetIdx) + jacInvT_.mv(shapeJacobian_[scv.localDofIndex()][0], gradN_[scv.indexInElement()]); + + // ... and those non-fracture scvs that are not on this facet + else if (!scv.isOnFracture() + && std::find( facetLocalDofs.begin(), + facetLocalDofs.end(), + scv.localDofIndex() ) == facetLocalDofs.end()) + { + jacInvT_.mv(shapeJacobian_[scv.localDofIndex()][0], gradN_[scv.indexInElement()]); + } + } + } + } + + //! return the Jacobian of the shape functions at the integration point + const std::vector& shapeJacobian() const { return shapeJacobian_; } + //! return the shape values for all scvs at the integration point + const std::vector& shapeValues() const { return shapeValues_; } + //! return the shape value gradients for all scvs at the integration point + const JacobianInverseTransposed& jacInvT() const { return jacInvT_; } + //! return the shape value gradients corresponding to an scv + const GlobalPosition& gradN(unsigned int scvIdxInElement) const { return gradN_[scvIdxInElement]; } + +private: + std::vector gradN_; + std::vector shapeJacobian_; + std::vector shapeValues_; + JacobianInverseTransposed jacInvT_; +}; + +} // end namespace Dumux + +#endif diff --git a/dumux/porousmediumflow/boxdfm/fvelementgeometry.hh b/dumux/porousmediumflow/boxdfm/fvelementgeometry.hh new file mode 100644 index 0000000000000000000000000000000000000000..c4a1d936317a29721b8c7498b8f4625ee44eac8d --- /dev/null +++ b/dumux/porousmediumflow/boxdfm/fvelementgeometry.hh @@ -0,0 +1,426 @@ +// -*- 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 . * + *****************************************************************************/ +/*! + * \file + * \ingroup BoxDiscretization + * \brief Base class for the local finite volume geometry for the box discrete + * fracture model. This builds up the sub control volumes and sub control + * volume faces for an element. + */ +#ifndef DUMUX_POROUSMEDIUMFLOW_BOXDFM_FV_ELEMENT_GEOMETRY_HH +#define DUMUX_POROUSMEDIUMFLOW_BOXDFM_FV_ELEMENT_GEOMETRY_HH + +#include +#include +#include + +#include +#include "geometryhelper.hh" + +namespace Dumux { + +/*! + * \ingroup BoxDiscretization + * \brief Base class for the finite volume geometry vector for box discrete fracture model + * This builds up the sub control volumes and sub control volume faces for each element. + * + * \tparam GG the finite volume grid geometry type + * \tparam enableFVGridGeometryCache if the grid geometry is cached or not + */ +template +class BoxDfmFVElementGeometry; + +//! specialization in case the FVElementGeometries are stored +template +class BoxDfmFVElementGeometry +{ + using GridView = typename GG::GridView; + static constexpr int dim = GridView::dimension; + static constexpr int dimWorld = GridView::dimensionworld; + using IndexType = typename GridView::IndexSet::IndexType; + using Element = typename GridView::template Codim<0>::Entity; + using CoordScalar = typename GridView::ctype; + using FeLocalBasis = typename GG::FeCache::FiniteElementType::Traits::LocalBasisType; + using ReferenceElements = typename Dune::ReferenceElements; +public: + //! export type of subcontrol volume + using SubControlVolume = typename GG::SubControlVolume; + //! export type of subcontrol volume face + using SubControlVolumeFace = typename GG::SubControlVolumeFace; + //! export type of finite volume grid geometry + using FVGridGeometry = GG; + //! the maximum number of scvs per element (2^dim for cubes) + //! multiplied by 3 for the maximum number of fracture scvs per vertex + static constexpr std::size_t maxNumElementScvs = (1<::const_iterator> + scvs(const BoxDfmFVElementGeometry& fvGeometry) + { + const auto& g = fvGeometry.fvGridGeometry(); + using Iter = typename std::vector::const_iterator; + return Dune::IteratorRange(g.scvs(fvGeometry.eIdx_).begin(), g.scvs(fvGeometry.eIdx_).end()); + } + + //! iterator range for sub control volumes faces. Iterates over + //! all scvfs of the bound element. + //! This is a free function found by means of ADL + //! To iterate over all sub control volume faces of this FVElementGeometry use + //! for (auto&& scvf : scvfs(fvGeometry)) + friend inline Dune::IteratorRange::const_iterator> + scvfs(const BoxDfmFVElementGeometry& fvGeometry) + { + const auto& g = fvGeometry.fvGridGeometry(); + using Iter = typename std::vector::const_iterator; + return Dune::IteratorRange(g.scvfs(fvGeometry.eIdx_).begin(), g.scvfs(fvGeometry.eIdx_).end()); + } + + //! Get a local finite element basis + const FeLocalBasis& feLocalBasis() const + { return fvGridGeometry().feCache().get(elementPtr_->geometry().type()).localBasis(); } + + //! The total number of sub control volumes + std::size_t numScv() const + { return fvGridGeometry().scvs(eIdx_).size(); } + + //! The total number of sub control volume faces + std::size_t numScvf() const + { return fvGridGeometry().scvfs(eIdx_).size(); } + + //! this function is for compatibility reasons with cc methods + //! The box stencil is always element-local so bind and bindElement + //! are identical. + void bind(const Element& element) + { + this->bindElement(element); + } + + //! Binding of an element, has to be called before using the fvgeometries + //! Prepares all the volume variables within the element + //! For compatibility reasons with the FVGeometry cache being disabled + void bindElement(const Element& element) + { + elementPtr_ = &element; + eIdx_ = fvGridGeometry().elementMapper().index(element); + } + + //! The global finite volume geometry we are a restriction of + const FVGridGeometry& fvGridGeometry() const + { return *fvGridGeometryPtr_; } + +private: + const Element* elementPtr_; + const FVGridGeometry* fvGridGeometryPtr_; + IndexType eIdx_; +}; + +//! specialization in case the FVElementGeometries are not stored +template +class BoxDfmFVElementGeometry +{ + using GridView = typename GG::GridView; + static constexpr int dim = GridView::dimension; + static constexpr int dimWorld = GridView::dimensionworld; + + using IndexType = typename GridView::IndexSet::IndexType; + using Element = typename GridView::template Codim<0>::Entity; + + using CoordScalar = typename GridView::ctype; + using FeLocalBasis = typename GG::FeCache::FiniteElementType::Traits::LocalBasisType; + using ReferenceElements = typename Dune::ReferenceElements; + using FaceReferenceElements = typename Dune::ReferenceElements; + + using GeometryHelper = BoxDfmGeometryHelper; +public: + //! export type of subcontrol volume + using SubControlVolume = typename GG::SubControlVolume; + //! export type of subcontrol volume face + using SubControlVolumeFace = typename GG::SubControlVolumeFace; + //! export type of finite volume grid geometry + using FVGridGeometry = GG; + //! the maximum number of scvs per element (2^dim for cubes) + //! multiplied by 3 for the maximum number of fracture scvs per vertex + static constexpr std::size_t maxNumElementScvs = (1<::const_iterator> + scvs(const BoxDfmFVElementGeometry& fvGeometry) + { + using Iter = typename std::vector::const_iterator; + return Dune::IteratorRange(fvGeometry.scvs_.begin(), fvGeometry.scvs_.end()); + } + + //! iterator range for sub control volumes faces. Iterates over + //! all scvfs of the bound element. + //! This is a free function found by means of ADL + //! To iterate over all sub control volume faces of this FVElementGeometry use + //! for (auto&& scvf : scvfs(fvGeometry)) + friend inline Dune::IteratorRange::const_iterator> + scvfs(const BoxDfmFVElementGeometry& fvGeometry) + { + using Iter = typename std::vector::const_iterator; + return Dune::IteratorRange(fvGeometry.scvfs_.begin(), fvGeometry.scvfs_.end()); + } + + //! Get a local finite element basis + const FeLocalBasis& feLocalBasis() const + { return fvGridGeometry().feCache().get(elementPtr_->geometry().type()).localBasis(); } + + //! 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(); } + + //! this function is for compatibility reasons with cc methods + //! The box stencil is always element-local so bind and bindElement + //! are identical. + void bind(const Element& element) + { + this->bindElement(element); + } + + //! Binding of an element, has to be called before using the fvgeometries + //! Prepares all the volume variables within the element + //! For compatibility reasons with the FVGeometry cache being disabled + void bindElement(const Element& element) + { + elementPtr_ = &element; + eIdx_ = fvGridGeometry().elementMapper().index(element); + makeElementGeometries(element); + } + + //! The global finite volume geometry we are a restriction of + const FVGridGeometry& fvGridGeometry() const + { return *fvGridGeometryPtr_; } + +private: + + void makeElementGeometries(const Element& element) + { + auto eIdx = fvGridGeometry().elementMapper().index(element); + + // get the element geometry + auto elementGeometry = element.geometry(); +#if DUNE_VERSION_NEWER(DUNE_COMMON,2,6) + const auto referenceElement = ReferenceElements::general(elementGeometry.type()); +#else + const auto& referenceElement = ReferenceElements::general(elementGeometry.type()); +#endif + + // get the sub control volume geometries of this element + GeometryHelper geometryHelper(elementGeometry); + + // construct the sub control volumes + scvs_.resize(elementGeometry.corners()); + using LocalIndexType = typename SubControlVolumeFace::Traits::LocalIndexType; + for (LocalIndexType scvLocalIdx = 0; scvLocalIdx < elementGeometry.corners(); ++scvLocalIdx) + { + // get asssociated dof index + const auto dofIdxGlobal = fvGridGeometry().vertexMapper().subIndex(element, scvLocalIdx, dim); + + // add scv to the local container + scvs_[scvLocalIdx] = SubControlVolume(geometryHelper, + scvLocalIdx, + eIdx, + dofIdxGlobal); + } + + // construct the sub control volume faces + const auto numInnerScvf = (dim==1) ? 1 : element.subEntities(dim-1); + scvfs_.resize(numInnerScvf); + + unsigned int scvfLocalIdx = 0; + for (; scvfLocalIdx < numInnerScvf; ++scvfLocalIdx) + { + // find the local scv indices this scvf is connected to + std::vector localScvIndices({static_cast(referenceElement.subEntity(scvfLocalIdx, dim-1, 0, dim)), + static_cast(referenceElement.subEntity(scvfLocalIdx, dim-1, 1, dim))}); + + scvfs_[scvfLocalIdx] = SubControlVolumeFace(geometryHelper, + element, + elementGeometry, + scvfLocalIdx, + std::move(localScvIndices)); + } + + // construct the ... + // ... sub-control volume faces on the domain boundary + // ... sub-control volumes on fracture facets + // ... sub-control volume faces on fracture facets + // NOTE We do not construct fracture scvfs on boundaries here! + // That means specifying Neumann fluxes on only the fractures is not possible + // However, it is difficult to interpret this here as a fracture ending on the boundary + // could also be connected to a facet wich is both boundary and fracture at the same time! + // In that case, the fracture boundary scvf wouldn't make sense. In order to do it properly + // we would have to find only those fractures that are at the boundary and aren't connected + // to a fracture which is a boundary. + LocalIndexType scvLocalIdx = element.subEntities(dim); + for (const auto& intersection : intersections(fvGridGeometry().gridView(), element)) + { + // first, obtain all vertex indices on this intersection + const auto& isGeometry = intersection.geometry(); + const auto numCorners = isGeometry.corners(); + const auto idxInInside = intersection.indexInInside(); + + std::vector isVertexIndices(numCorners); + for (unsigned int vIdxLocal = 0; vIdxLocal < numCorners; ++vIdxLocal) + isVertexIndices[vIdxLocal] = fvGridGeometry().vertexMapper().subIndex(element, + referenceElement.subEntity(idxInInside, 1, vIdxLocal, dim), + dim); + + if (intersection.boundary()) + { + for (unsigned int isScvfLocalIdx = 0; isScvfLocalIdx < numCorners; ++isScvfLocalIdx) + { + // find the scv this scvf is connected to + const LocalIndexType insideScvIdx = static_cast(referenceElement.subEntity(idxInInside, 1, isScvfLocalIdx, dim)); + std::vector localScvIndices = {insideScvIdx, insideScvIdx}; + + scvfs_.emplace_back(geometryHelper, + intersection, + isGeometry, + isScvfLocalIdx, + scvfLocalIdx, + std::move(localScvIndices)); + + // increment local counter + scvfLocalIdx++; + } + } + + // maybe add fracture scvs & scvfs + auto isOnFracture = [&] (auto idx) { return this->fvGridGeometry().dofOnFracture(idx); }; + if ( std::all_of(isVertexIndices.begin(), isVertexIndices.end(), isOnFracture) ) + { + // add fracture scv for each vertex of intersection + const auto curNumScvs = scvs_.size(); + scvs_.reserve(curNumScvs+numCorners); + for (unsigned int vIdxLocal = 0; vIdxLocal < numCorners; ++vIdxLocal) + scvs_.emplace_back(geometryHelper, + intersection, + isGeometry, + vIdxLocal, + static_cast(referenceElement.subEntity(idxInInside, 1, vIdxLocal, dim)), + scvLocalIdx++, + idxInInside, + eIdx, + isVertexIndices[vIdxLocal]); + + // add fracture scvf for each edge of the intersection in 3d + if (dim == 3) + { + const auto& faceReferenceElement = FaceReferenceElements::general(isGeometry.type()); + for (unsigned int edgeIdx = 0; edgeIdx < faceReferenceElement.size(1); ++edgeIdx) + { + // inside/outside scv indices in face local node numbering + std::vector localScvIndices({static_cast(faceReferenceElement.subEntity(edgeIdx, 1, 0, dim-1)), + static_cast(faceReferenceElement.subEntity(edgeIdx, 1, 1, dim-1))}); + + // add offset to get the right scv indices + std::for_each( localScvIndices.begin(), + localScvIndices.end(), + [curNumScvs] (auto& elemLocalIdx) { elemLocalIdx += curNumScvs; } ); + + // add scvf + scvfs_.emplace_back(geometryHelper, + intersection, + isGeometry, + edgeIdx, + scvfLocalIdx++, + std::move(localScvIndices), + intersection.boundary()); + } + } + + // dim == 2, intersection is an edge, make 1 scvf + else + { + // inside/outside scv indices in face local node numbering + std::vector localScvIndices({0, 1}); + + // add offset such that the fracture scvs above are addressed + std::for_each( localScvIndices.begin(), + localScvIndices.end(), + [curNumScvs] (auto& elemLocalIdx) { elemLocalIdx += curNumScvs; } ); + + // add scvf + scvfs_.emplace_back(geometryHelper, + intersection, + isGeometry, + /*idxOnIntersection*/0, + scvfLocalIdx++, + std::move(localScvIndices), + intersection.boundary()); + } + } + } + } + + //! The bound element + const Element* elementPtr_; + IndexType eIdx_; + + //! The global geometry this is a restriction of + const FVGridGeometry* fvGridGeometryPtr_; + + //! vectors to store the geometries locally after binding an element + std::vector scvs_; + std::vector scvfs_; +}; + +} // end namespace Dumux + +#endif diff --git a/dumux/porousmediumflow/boxdfm/fvgridgeometry.hh b/dumux/porousmediumflow/boxdfm/fvgridgeometry.hh new file mode 100644 index 0000000000000000000000000000000000000000..8477d35727706d5e6673c596c66b641574cab261 --- /dev/null +++ b/dumux/porousmediumflow/boxdfm/fvgridgeometry.hh @@ -0,0 +1,525 @@ +// -*- 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 . * + *****************************************************************************/ +/*! + * \file + * \ingroup BoxDiscretization + * \brief Base class for the finite volume geometry vector for box schemes that consider + * extra connectivity between grid vertices on marked codim one entities. On these, + * an additional scvf is created accounting for the additional exchange fluxes between + * these degrees of freedom. + */ +#ifndef DUMUX_POROUSMEDIUMFLOW_BOXDFM_GRID_FVGEOMETRY_HH +#define DUMUX_POROUSMEDIUMFLOW_BOXDFM_GRID_FVGEOMETRY_HH + +#include +#include +#include + +#include +#include +#include +#include + +#include "fvelementgeometry.hh" +#include "geometryhelper.hh" +#include "subcontrolvolume.hh" +#include "subcontrolvolumeface.hh" + +namespace Dumux { + +/*! + * \ingroup BoxDiscretization + * \brief The default traits for the box finite volume grid geometry + * Defines the scv and scvf types and the mapper types + * \tparam the grid view type + */ +template +struct BoxDfmDefaultGridGeometryTraits +: public DefaultMapperTraits +{ + using SubControlVolume = BoxDfmSubControlVolume; + using SubControlVolumeFace = BoxDfmSubControlVolumeFace; + + template + using LocalView = BoxDfmFVElementGeometry; +}; + +/*! + * \ingroup BoxDiscretization + * \brief Base class for the finite volume geometry vector for box schemes + * This builds up the sub control volumes and sub control volume faces + * \note This class is specialized for versions with and without caching the fv geometries on the grid view + */ +template > +class BoxDfmFVGridGeometry; + +/*! + * \ingroup BoxDiscretization + * \brief Base class for the finite volume geometry vector for box schemes that consider + * extra connectivity between grid vertices on marked codim one entities. On these, + * an additional scvf is created accounting for the additional exchange fluxes between + * these degrees of freedom. + * \note For caching enabled we store the fv geometries for the whole grid view which is memory intensive but faster + */ +template +class BoxDfmFVGridGeometry +: public BaseFVGridGeometry, GV, Traits> +{ + using ThisType = BoxDfmFVGridGeometry; + using ParentType = BaseFVGridGeometry; + using IndexType = typename GV::IndexSet::IndexType; + + using Element = typename GV::template Codim<0>::Entity; + using CoordScalar = typename GV::ctype; + static const int dim = GV::dimension; + static const int dimWorld = GV::dimensionworld; + static_assert(dim == 2 || dim == 3, "The box-dfm FVGridGeometry is only implemented in 2 or 3 dimensions."); + + using ReferenceElements = typename Dune::ReferenceElements; + using FaceReferenceElements = typename Dune::ReferenceElements; + + using GeometryHelper = BoxDfmGeometryHelper; + +public: + //! export discretization method + static constexpr DiscretizationMethod discMethod = DiscretizationMethod::box; + + //! export the type of the fv element geometry (the local view type) + using LocalView = typename Traits::template LocalView; + //! export the type of sub control volume + using SubControlVolume = typename Traits::SubControlVolume; + //! export the type of sub control volume + using SubControlVolumeFace = typename Traits::SubControlVolumeFace; + //! export dof mapper type + using DofMapper = typename Traits::VertexMapper; + //! export the finite element cache type + using FeCache = Dune::PQkLocalFiniteElementCache; + //! export the grid view type + using GridView = GV; + + //! Constructor + BoxDfmFVGridGeometry(const GridView gridView) + : ParentType(gridView) {} + + //! the vertex mapper is the dofMapper + //! this is convenience to have better chance to have the same main files for box/tpfa/mpfa... + const DofMapper& dofMapper() const + { return this->vertexMapper(); } + + //! The total number of sub control volumes + std::size_t numScv() const + { return numScv_; } + + //! The total number of sun control volume faces + std::size_t numScvf() const + { return numScvf_; } + + //! The total number of boundary sub control volume faces + //! For compatibility reasons with cc methods + std::size_t numBoundaryScvf() const + { return numBoundaryScvf_; } + + //! The total number of degrees of freedom + std::size_t numDofs() const + { return this->gridView().size(dim); } + + //! update all fvElementGeometries (do this again after grid adaption) + void update(const std::vector& vertexIsOnFracture) + { + fractureDofIndices_ = vertexIsOnFracture; + if (vertexIsOnFracture.size() != this->gridView().size(dim)) + DUNE_THROW(Dune::InvalidStateException, "Provided vector does not have the correct size"); + + ParentType::update(); + + scvs_.clear(); + scvfs_.clear(); + + auto numElements = this->gridView().size(0); + scvs_.resize(numElements); + scvfs_.resize(numElements); + + boundaryDofIndices_.resize(numDofs(), false); + + numScv_ = 0; + numScvf_ = 0; + numBoundaryScvf_ = 0; + // Build the SCV and SCV faces + for (const auto& element : elements(this->gridView())) + { + // fill the element map with seeds + auto eIdx = this->elementMapper().index(element); + + // count + numScv_ += element.subEntities(dim); + numScvf_ += element.subEntities(dim-1); + + // get the element geometry + auto elementGeometry = element.geometry(); + const auto referenceElement = ReferenceElements::general(elementGeometry.type()); + + // instantiate the geometry helper + GeometryHelper geometryHelper(elementGeometry); + + // construct the sub control volumes + scvs_[eIdx].resize(elementGeometry.corners()); + using LocalIndexType = typename SubControlVolumeFace::Traits::LocalIndexType; + for (LocalIndexType scvLocalIdx = 0; scvLocalIdx < elementGeometry.corners(); ++scvLocalIdx) + { + const auto dofIdxGlobal = this->vertexMapper().subIndex(element, scvLocalIdx, dim); + + scvs_[eIdx][scvLocalIdx] = SubControlVolume(geometryHelper, + scvLocalIdx, + eIdx, + dofIdxGlobal); + } + + // construct the sub control volume faces + LocalIndexType scvfLocalIdx = 0; + scvfs_[eIdx].resize(element.subEntities(dim-1)); + for (; scvfLocalIdx < element.subEntities(dim-1); ++scvfLocalIdx) + { + // find the global and local scv indices this scvf is belonging to + std::vector localScvIndices({static_cast(referenceElement.subEntity(scvfLocalIdx, dim-1, 0, dim)), + static_cast(referenceElement.subEntity(scvfLocalIdx, dim-1, 1, dim))}); + + scvfs_[eIdx][scvfLocalIdx] = SubControlVolumeFace(geometryHelper, + element, + elementGeometry, + scvfLocalIdx, + std::move(localScvIndices)); + } + + // construct the ... + // ... sub-control volume faces on the domain boundary + // ... sub-control volumes on fracture facets + // ... sub-control volume faces on fracture facets + // NOTE We do not construct fracture scvfs on boundaries here! + // That means specifying Neumann fluxes on only the fractures is not possible + // However, it is difficult to interpret this here as a fracture ending on the boundary + // could also be connected to a facet wich is both boundary and fracture at the same time! + // In that case, the fracture boundary scvf wouldn't make sense. In order to do it properly + // we would have to find only those fractures that are at the boundary and aren't connected + // to a fracture which is a boundary. + LocalIndexType scvLocalIdx = element.subEntities(dim); + for (const auto& intersection : intersections(this->gridView(), element)) + { + // first, obtain all vertex indices on this intersection + const auto& isGeometry = intersection.geometry(); + const auto numCorners = isGeometry.corners(); + const auto idxInInside = intersection.indexInInside(); + + std::vector isVertexIndices(numCorners); + for (unsigned int vIdxLocal = 0; vIdxLocal < numCorners; ++vIdxLocal) + isVertexIndices[vIdxLocal] = this->vertexMapper().subIndex(element, + referenceElement.subEntity(idxInInside, 1, vIdxLocal, dim), + dim); + // maybe add boundary scvf + if (intersection.boundary()) + { + numScvf_ += isGeometry.corners(); + numBoundaryScvf_ += isGeometry.corners(); + + for (unsigned int isScvfLocalIdx = 0; isScvfLocalIdx < numCorners; ++isScvfLocalIdx) + { + // find the scvs this scvf is belonging to + const LocalIndexType insideScvIdx = static_cast(referenceElement.subEntity(idxInInside, 1, isScvfLocalIdx, dim)); + std::vector localScvIndices = {insideScvIdx, insideScvIdx}; + scvfs_[eIdx].emplace_back(geometryHelper, + intersection, + isGeometry, + isScvfLocalIdx, + scvfLocalIdx++, + std::move(localScvIndices)); + } + + // add all vertices on the intersection to the set of + // boundary vertices + const auto numFaceVerts = referenceElement.size(idxInInside, 1, dim); + for (int localVIdx = 0; localVIdx < numFaceVerts; ++localVIdx) + { + const auto vIdx = referenceElement.subEntity(idxInInside, 1, localVIdx, dim); + const auto vIdxGlobal = this->vertexMapper().subIndex(element, vIdx, dim); + boundaryDofIndices_[vIdxGlobal] = true; + } + } + + // maybe add fracture scvs & scvfs + auto isOnFracture = [&] (auto idx) { return this->fractureDofIndices_[idx]; }; + if ( std::all_of(isVertexIndices.begin(), isVertexIndices.end(), isOnFracture) ) + { + // add fracture scv for each vertex of intersection + numScv_ += numCorners; + const auto curNumScvs = scvs_[eIdx].size(); + scvs_[eIdx].reserve(curNumScvs+numCorners); + for (unsigned int vIdxLocal = 0; vIdxLocal < numCorners; ++vIdxLocal) + scvs_[eIdx].emplace_back(geometryHelper, + intersection, + isGeometry, + vIdxLocal, + static_cast(referenceElement.subEntity(idxInInside, 1, vIdxLocal, dim)), + scvLocalIdx++, + idxInInside, + eIdx, + isVertexIndices[vIdxLocal]); + + // add fracture scvf for each edge of the intersection in 3d + if (dim == 3) + { + const auto& faceReferenceElement = FaceReferenceElements::general(isGeometry.type()); + for (unsigned int edgeIdx = 0; edgeIdx < faceReferenceElement.size(1); ++edgeIdx) + { + // inside/outside scv indices in face local node numbering + std::vector localScvIndices({static_cast(faceReferenceElement.subEntity(edgeIdx, 1, 0, dim-1)), + static_cast(faceReferenceElement.subEntity(edgeIdx, 1, 1, dim-1))}); + + // add offset to get the right scv indices + std::for_each( localScvIndices.begin(), + localScvIndices.end(), + [curNumScvs] (auto& elemLocalIdx) { elemLocalIdx += curNumScvs; } ); + + // add scvf + numScvf_++; + scvfs_[eIdx].emplace_back(geometryHelper, + intersection, + isGeometry, + edgeIdx, + scvfLocalIdx++, + std::move(localScvIndices), + intersection.boundary()); + } + } + + // dim == 2, intersection is an edge, make 1 scvf + else + { + // inside/outside scv indices in face local node numbering + std::vector localScvIndices({0, 1}); + + // add offset such that the fracture scvs above are addressed + std::for_each( localScvIndices.begin(), + localScvIndices.end(), + [curNumScvs] (auto& elemLocalIdx) { elemLocalIdx += curNumScvs; } ); + + // add scvf + numScvf_++; + scvfs_[eIdx].emplace_back(geometryHelper, + intersection, + isGeometry, + /*idxOnIntersection*/0, + scvfLocalIdx++, + std::move(localScvIndices), + intersection.boundary()); + } + } + } + } + } + + //! The finite element cache for creating local FE bases + const FeCache& feCache() const { return feCache_; } + //! Get the local scvs for an element + const std::vector& scvs(IndexType eIdx) const { return scvs_[eIdx]; } + //! Get the local scvfs for an element + const std::vector& scvfs(IndexType eIdx) const { return scvfs_[eIdx]; } + //! If a vertex / d.o.f. is on the boundary + bool dofOnBoundary(unsigned int dofIdx) const { return boundaryDofIndices_[dofIdx]; } + //! If a vertex / d.o.f. is on a fracture + bool dofOnFracture(unsigned int dofIdx) const { return fractureDofIndices_[dofIdx]; } + +private: + const FeCache feCache_; + + std::vector> scvs_; + std::vector> scvfs_; + + // TODO do we need those? + std::size_t numScv_; + std::size_t numScvf_; + std::size_t numBoundaryScvf_; + + // vertices on the boundary & fracture facets + std::vector boundaryDofIndices_; + std::vector fractureDofIndices_; +}; + +/*! + * \ingroup BoxDiscretization + * \brief Base class for the finite volume geometry vector for box schemes + * This builds up the sub control volumes and sub control volume faces + * \note For caching disabled we store only some essential index maps to build up local systems on-demand in + * the corresponding FVElementGeometry + */ +template +class BoxDfmFVGridGeometry +: public BaseFVGridGeometry, GV, Traits> +{ + using ThisType = BoxDfmFVGridGeometry; + using ParentType = BaseFVGridGeometry; + using IndexType = typename GV::IndexSet::IndexType; + + static const int dim = GV::dimension; + static const int dimWorld = GV::dimensionworld; + + using Element = typename GV::template Codim<0>::Entity; + using CoordScalar = typename GV::ctype; + + using ReferenceElements = typename Dune::ReferenceElements; + using FaceReferenceElements = typename Dune::ReferenceElements; + +public: + //! export discretization method + static constexpr DiscretizationMethod discMethod = DiscretizationMethod::box; + + //! export the type of the fv element geometry (the local view type) + using LocalView = typename Traits::template LocalView; + //! export the type of sub control volume + using SubControlVolume = typename Traits::SubControlVolume; + //! export the type of sub control volume + using SubControlVolumeFace = typename Traits::SubControlVolumeFace; + //! export dof mapper type + using DofMapper = typename Traits::VertexMapper; + //! export the finite element cache type + using FeCache = Dune::PQkLocalFiniteElementCache; + //! export the grid view type + using GridView = GV; + + //! Constructor + BoxDfmFVGridGeometry(const GridView gridView) + : ParentType(gridView) {} + + //! the vertex mapper is the dofMapper + //! this is convenience to have better chance to have the same main files for box/tpfa/mpfa... + const DofMapper& dofMapper() const + { return this->vertexMapper(); } + + //! The total number of sub control volumes + std::size_t numScv() const + { return numScv_; } + + //! The total number of sun control volume faces + std::size_t numScvf() const + { return numScvf_; } + + //! The total number of boundary sub control volume faces + //! For compatibility reasons with cc methods + std::size_t numBoundaryScvf() const + { return numBoundaryScvf_; } + + //! The total number of degrees of freedom + std::size_t numDofs() const + { return this->gridView().size(dim); } + + //! update all fvElementGeometries (do this again after grid adaption) + void update(const std::vector& vertexIsOnFracture) + { + fractureDofIndices_ = vertexIsOnFracture; + if (vertexIsOnFracture.size() != this->gridView().size(dim)) + DUNE_THROW(Dune::InvalidStateException, "Provided vector does not have the correct size"); + + ParentType::update(); + + boundaryDofIndices_.resize(numDofs(), false); + + // save global data on the grid's scvs and scvfs + // TODO do we need those information? + numScv_ = 0; + numScvf_ = 0; + numBoundaryScvf_ = 0; + for (const auto& element : elements(this->gridView())) + { + numScv_ += element.subEntities(dim); + numScvf_ += element.subEntities(dim-1); + + const auto elementGeometry = element.geometry(); + const auto referenceElement = ReferenceElements::general(elementGeometry.type()); + + // store the sub control volume face indices on the domain boundary + for (const auto& intersection : intersections(this->gridView(), element)) + { + // first, obtain all vertex indices on this intersection + const auto& isGeometry = intersection.geometry(); + const auto numCorners = isGeometry.corners(); + const auto idxInInside = intersection.indexInInside(); + + std::vector isVertexIndices(numCorners); + for (unsigned int vIdxLocal = 0; vIdxLocal < numCorners; ++vIdxLocal) + isVertexIndices[vIdxLocal] = this->vertexMapper().subIndex(element, + referenceElement.subEntity(idxInInside, 1, vIdxLocal, dim), + dim); + + if (intersection.boundary()) + { + numScvf_ += numCorners; + numBoundaryScvf_ += numCorners; + + // add all vertices on the intersection to the set of + // boundary vertices + const auto fIdx = intersection.indexInInside(); + const auto numFaceVerts = referenceElement.size(fIdx, 1, dim); + for (int localVIdx = 0; localVIdx < numFaceVerts; ++localVIdx) + { + const auto vIdx = referenceElement.subEntity(fIdx, 1, localVIdx, dim); + const auto vIdxGlobal = this->vertexMapper().subIndex(element, vIdx, dim); + boundaryDofIndices_[vIdxGlobal] = true; + } + } + + // maybe add fracture scvs & scvfs + auto isOnFracture = [&] (auto idx) { return this->fractureDofIndices_[idx]; }; + if ( std::all_of(isVertexIndices.begin(), isVertexIndices.end(), isOnFracture) ) + { + const auto isGeometry = intersection.geometry(); + numScv_ += isGeometry.corners(); + numScvf_ += dim == 3 ? FaceReferenceElements::general(isGeometry.type()).size(1) : 1; + } + } + } + } + + //! The finite element cache for creating local FE bases + const FeCache& feCache() const { return feCache_; } + //! If a vertex / d.o.f. is on the boundary + bool dofOnBoundary(unsigned int dofIdx) const { return boundaryDofIndices_[dofIdx]; } + //! If a vertex / d.o.f. is on a fracture + bool dofOnFracture(unsigned int dofIdx) const { return fractureDofIndices_[dofIdx]; } + +private: + + const FeCache feCache_; + + // Information on the global number of geometries + // TODO do we need those information? + std::size_t numScv_; + std::size_t numScvf_; + std::size_t numBoundaryScvf_; + + // vertices on the boundary & fracture facets + std::vector boundaryDofIndices_; + std::vector fractureDofIndices_; +}; + +} // end namespace Dumux + +#endif diff --git a/dumux/porousmediumflow/boxdfm/geometryhelper.hh b/dumux/porousmediumflow/boxdfm/geometryhelper.hh new file mode 100644 index 0000000000000000000000000000000000000000..e79b8a90cbd87bebd37465749bcbbd2a82bb22f9 --- /dev/null +++ b/dumux/porousmediumflow/boxdfm/geometryhelper.hh @@ -0,0 +1,219 @@ +// -*- 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 . * + *****************************************************************************/ +/*! + * \file + * \ingroup BoxDiscretization + * \ingroup BoxDFM + * \brief Helper class constructing the dual grid finite volume geometries + * for the box discrete fracture model. + */ +#ifndef DUMUX_POROUSMEDIUMFLOW_BOXDFM_GEOMETRY_HELPER_HH +#define DUMUX_POROUSMEDIUMFLOW_BOXDFM_GEOMETRY_HELPER_HH + +#include + +namespace Dumux +{ + +//! Create sub control volumes and sub control volume face geometries +template +class BoxDfmGeometryHelper; + +//! A class to create sub control volume and sub control volume face geometries per element +template +class BoxDfmGeometryHelper : public BoxGeometryHelper +{ + using ParentType = BoxGeometryHelper; + + using Intersection = typename GridView::Intersection; + using ScvfCornerStorage = typename ScvfType::Traits::CornerStorage; + + static constexpr auto dim = GridView::dimension; + using Scalar = typename GridView::ctype; + using ReferenceElements = typename Dune::ReferenceElements; + +public: + + //! Pull up constructor of base class + using ParentType::ParentType; + + //! Get the corners of the (d-1)-dimensional fracture scvf + //! The second argument is for compatibility reasons with the 3d case! + ScvfCornerStorage getFractureScvfCorners(const Intersection& is, + const typename Intersection::Geometry& isGeom, + unsigned int idxOnIntersection = 0) const + { return ScvfCornerStorage({isGeom.center()}); } + + + //! get fracture scvf normal vector (simply the unit vector of the edge) + //! The third argument is for compatibility reasons with the 3d case! + typename ScvfType::Traits::GlobalPosition + fractureNormal(const ScvfCornerStorage& p, + const Intersection& is, + unsigned int edgeIndexInIntersection = 0) const + { + assert(isGeom.corners() == 2); + + const auto referenceElement = ReferenceElements::general(this->elementGeometry_.type()); + const auto vIdxLocal0 = referenceElement.subEntity(is.indexInInside(), 1, 0, dim); + const auto vIdxLocal1 = referenceElement.subEntity(is.indexInInside(), 1, 1, dim); + auto n = this->elementGeometry_.corner(vIdxLocal1) - this->elementGeometry_.corner(vIdxLocal0); + n /= n.two_norm(); + return n; + } +}; + +//! A class to create sub control volume and sub control volume face geometries per element +template +class BoxDfmGeometryHelper : public BoxGeometryHelper +{ + using ParentType = BoxGeometryHelper; + + using Intersection = typename GridView::Intersection; + using ScvfCornerStorage = typename ScvfType::Traits::CornerStorage; + + static constexpr auto dim = GridView::dimension; + static constexpr auto dimWorld = GridView::dimensionworld; + using Scalar = typename GridView::ctype; + using ReferenceElements = typename Dune::ReferenceElements; + using FaceReferenceElements = typename Dune::ReferenceElements; + +public: + + //! Pull up constructor of base class + using ParentType::ParentType; + + //! Create the sub control volume face geometries on an intersection marked as fracture + ScvfCornerStorage getFractureScvfCorners(const Intersection& is, + const typename Intersection::Geometry& isGeom, + unsigned int edgeIndexInIntersection) const + { + const auto referenceElement = ReferenceElements::general(this->elementGeometry_.type()); + const auto faceRefElem = FaceReferenceElements::general(isGeom.type()); + + // create point vector for this geometry + typename ScvfType::Traits::GlobalPosition pi[9]; + + // the facet center + pi[0] = isGeom.center(); + + // facet edge midpoints + const auto idxInInside = is.indexInInside(); + for (int i = 0; i < faceRefElem.size(1); ++i) + { + const auto edgeIdxLocal = referenceElement.subEntity(idxInInside, 1, i, dim-1); + pi[i+1] = this->p[edgeIdxLocal+this->corners_+1]; + } + + // proceed according to number of corners + const auto corners = isGeom.corners(); + switch (corners) + { + case 3: // triangle + { + //! Only build the maps the first time we encounter a triangle + static const std::uint8_t fo = 1; //!< face offset in point vector p + static const std::uint8_t map[3][2] = + { + {fo+0, 0}, + {0, fo+1}, + {fo+2, 0} + }; + + return ScvfCornerStorage{ {pi[map[edgeIndexInIntersection][0]], + pi[map[edgeIndexInIntersection][1]]} }; + } + case 4: // quadrilateral + { + //! Only build the maps the first time we encounter a quadrilateral + static const std::uint8_t fo = 1; //!< face offset in point vector p + static const std::uint8_t map[4][2] = + { + {0, fo+0}, + {fo+1, 0}, + {fo+2, 0}, + {0, fo+3} + }; + + return ScvfCornerStorage{ {pi[map[edgeIndexInIntersection][0]], + pi[map[edgeIndexInIntersection][1]]} }; + } + default: + DUNE_THROW(Dune::NotImplemented, "Box fracture scvf geometries for dim=" << dim + << " dimWorld=" << dimWorld + << " corners=" << corners); + } + } + + //! get fracture scvf normal vector + typename ScvfType::Traits::GlobalPosition + fractureNormal(const ScvfCornerStorage& p, + const Intersection& is, + unsigned int edgeIndexInIntersection) const + { + const auto referenceElement = ReferenceElements::general(this->elementGeometry_.type()); + + // first get the intersection corners (maximum "4" is for quadrilateral face) + typename ScvfType::Traits::GlobalPosition c[4]; + + const auto corners = referenceElement.size(is.indexInInside(), 1, dim); + for (int i = 0; i < corners; ++i) + { + const auto vIdxLocal = referenceElement.subEntity(is.indexInInside(), 1, i, dim); + c[i] = this->elementGeometry_.corner(vIdxLocal); + } + + // compute edge vector depending on number of corners + const auto gridEdge = [&] () + { + // triangles + if (corners == 3) + { + if (edgeIndexInIntersection == 0) return c[1]-c[0]; + else if (edgeIndexInIntersection == 1) return c[2]-c[0]; + else if (edgeIndexInIntersection == 2) return c[2]-c[1]; + else DUNE_THROW(Dune::InvalidStateException, "Invalid edge index"); + } + else if (corners == 4) + { + if (edgeIndexInIntersection == 0) return c[2]-c[0]; + else if (edgeIndexInIntersection == 1) return c[3]-c[1]; + else if (edgeIndexInIntersection == 2) return c[1]-c[0]; + else if (edgeIndexInIntersection == 3) return c[3]-c[2]; + else DUNE_THROW(Dune::InvalidStateException, "Invalid edge index"); + } + else + DUNE_THROW(Dune::InvalidStateException, "Invalid face geometry"); + } (); + + // compute lower edge of the scvf + assert(p.size() == 2); + const auto scvfEdge = p[1]-p[0]; + + // compute scvf normal via 2 cross products + const auto faceN = crossProduct(gridEdge, scvfEdge); + auto n = crossProduct(scvfEdge, faceN); + n /= n.two_norm(); + return n; + } +}; + +} // end namespace Dumux + +#endif diff --git a/dumux/porousmediumflow/boxdfm/model.hh b/dumux/porousmediumflow/boxdfm/model.hh new file mode 100644 index 0000000000000000000000000000000000000000..f0d85ae05cc8805074880f4e032f3640552471d4 --- /dev/null +++ b/dumux/porousmediumflow/boxdfm/model.hh @@ -0,0 +1,57 @@ +// -*- 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 . * + *****************************************************************************/ +/*! + * \ingroup Properties + * \file + * \brief Defines a type tag and some properties for porous medium + * flow models using the box scheme extended to discrete fractures. + */ + +#ifndef DUMUX_POROUSMEDIUMFLOW_BOXDFM_MODEL_HH +#define DUMUX_POROUSMEDIUMFLOW_BOXDFM_MODEL_HH + +#include + +#include "fvgridgeometry.hh" +#include "fluxvariablescache.hh" + +namespace Dumux { +namespace Properties { + +//! Type tag for the box scheme. +NEW_TYPE_TAG(BoxDfmModel, INHERITS_FROM(BoxModel)); + +//! Set the default for the global finite volume geometry +SET_PROP(BoxDfmModel, FVGridGeometry) +{ +private: + static constexpr bool enableCache = GET_PROP_VALUE(TypeTag, EnableFVGridGeometryCache); + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); +public: + using type = BoxDfmFVGridGeometry; +}; + +//! The flux variables cache class specific to box-dfm porous medium flow models +SET_TYPE_PROP(BoxDfmModel, FluxVariablesCache, BoxDfmFluxVariablesCache); + +} // namespace Properties +} // namespace Dumux + +#endif diff --git a/dumux/porousmediumflow/boxdfm/subcontrolvolume.hh b/dumux/porousmediumflow/boxdfm/subcontrolvolume.hh new file mode 100644 index 0000000000000000000000000000000000000000..6ad04912928a0ba2d1821cade8ab7de2af3a3850 --- /dev/null +++ b/dumux/porousmediumflow/boxdfm/subcontrolvolume.hh @@ -0,0 +1,241 @@ +// -*- 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 . * + *****************************************************************************/ +/*! + * \file + * \ingroup BoxDiscretization + * \brief the sub control volume for the box discrete fracture scheme + */ +#ifndef DUMUX_POROUSMEDIUMFLOW_BOXDFM_SUBCONTROLVOLUME_HH +#define DUMUX_POROUSMEDIUMFLOW_BOXDFM_SUBCONTROLVOLUME_HH + +#include +#include + +#include +#include +#include + +namespace Dumux { + +/*! + * \ingroup BoxDiscretization + * \brief Default traits class to be used for the sub-control volumes + * for the box discrete fracture scheme + * \tparam GV the type of the grid view + * + * \note We define new traits for the box-dfm sub-control volume face + * as we use a different type of container for storing the scvf corners! + */ +template +struct BoxDfmDefaultScvGeometryTraits +{ + using Grid = typename GridView::Grid; + + static const int dim = Grid::dimension; + static const int dimWorld = Grid::dimensionworld; + + template + struct ScvMLGTraits : public Dune::MultiLinearGeometryTraits + { + // we use static vectors to store the corners as we know + // the number of corners in advance (2^(dim) corners (1<<(dim)) + // However, on fracture scvs the number might be smaller (use ReservedVector) + template< int mydim, int cdim > + struct CornerStorage + { + using Type = Dune::ReservedVector< Dune::FieldVector< ct, cdim >, (1<<(dim)) >; + }; + + // we know all scvfs will have the same geometry type + template< int mydim > + struct hasSingleGeometryType + { + static const bool v = true; + static const unsigned int topologyId = Dune::Impl::CubeTopology< mydim >::type::id; + }; + }; + + using GridIndexType = typename Grid::LeafGridView::IndexSet::IndexType; + using LocalIndexType = unsigned int; + using Scalar = typename Grid::ctype; + using Geometry = Dune::MultiLinearGeometry>; + using CornerStorage = typename ScvMLGTraits::template CornerStorage::Type; + using GlobalPosition = typename CornerStorage::value_type; +}; + +/*! + * \ingroup BoxDiscretization + * \brief the sub control volume for the box discrete fracture scheme + * \tparam GV the type of the grid view + * \tparam T the scvf geometry traits + */ +template > +class BoxDfmSubControlVolume +: public SubControlVolumeBase, T> +{ + using ThisType = BoxDfmSubControlVolume; + using ParentType = SubControlVolumeBase; + using Geometry = typename T::Geometry; + using GridIndexType = typename T::GridIndexType; + using LocalIndexType = typename T::LocalIndexType; + using Scalar = typename T::Scalar; + using GlobalPosition = typename T::GlobalPosition; + using CornerStorage = typename T::CornerStorage; + enum { dim = Geometry::mydimension }; + + static_assert(dim == 2 || dim == 3, "Box-Dfm sub-control volume only implemented in 2d or 3d"); + +public: + //! state the traits public and thus export all types + using Traits = T; + + //! The default constructor + BoxDfmSubControlVolume() = default; + + // the constructor for standard scvs + template + BoxDfmSubControlVolume(const GeometryHelper& geometryHelper, + LocalIndexType scvIdx, + GridIndexType elementIndex, + GridIndexType dofIndex) + : isFractureScv_(false) + , corners_(geometryHelper.getScvCorners(scvIdx)) + , center_(0.0) + , volume_(geometryHelper.scvVolume(corners_)) + , elementIndex_(elementIndex) + , vIdxLocal_(scvIdx) + , elemLocalScvIdx_(scvIdx) + , dofIndex_(dofIndex) + , facetIdx_(0) + { + // compute center point + for (const auto& corner : corners_) + center_ += corner; + center_ /= corners_.size(); + } + + //! Constructor for fracture scvs + //! The corner computation is the same as for boundary scvfs. + //! Also, the scvf area of a boundary scvf is equal to the scv + //! volume (unscaled by the aperture) Thus, we reuse functionality here. + //! In order to get the right dimensions later, one must provide appropriate + //! extrusion factors in the problem corresponding to the fracture aperture. + template + BoxDfmSubControlVolume(const GeometryHelper& geometryHelper, + const Intersection& intersection, + const typename Intersection::Geometry& isGeometry, + LocalIndexType indexInIntersection, + LocalIndexType vIdxLocal, + LocalIndexType elemLocalScvIdx, + LocalIndexType elemLocalFacetIdx, + GridIndexType elementIndex, + GridIndexType dofIndex) + : isFractureScv_(true) + , corners_() + , center_(0.0) + , volume_(0.0) + , elementIndex_(elementIndex) + , vIdxLocal_(vIdxLocal) + , elemLocalScvIdx_(elemLocalScvIdx) + , dofIndex_(dofIndex) + , facetIdx_(elemLocalFacetIdx) + { + // copy corners + auto corners = geometryHelper.getBoundaryScvfCorners(intersection, isGeometry, indexInIntersection); + const auto numCorners = corners.size(); + corners_.resize(numCorners); + for (unsigned int i = 0; i < numCorners; ++i) + corners_[i] = corners[i]; + + // compute volume and scv center + volume_ = geometryHelper.scvfArea(corners); + for (const auto& corner : corners_) + center_ += corner; + center_ /= corners_.size(); + } + + //! The center of the sub control volume + const GlobalPosition& center() const { return center_; } + + //! The volume of the sub control volume + Scalar volume() const { return volume_; } + + //! The element-local vertex index this scv is connected to + LocalIndexType localDofIndex() const { return vIdxLocal_; } + + //! The element-local index of this scv + LocalIndexType indexInElement() const { return elemLocalScvIdx_; } + + //! The element-local facet index for which a fracture scv was created + LocalIndexType facetIndexInElement() const { assert(isFractureScv_); return facetIdx_; } + + //! The index of the dof this scv is embedded in + GridIndexType dofIndex() const { return dofIndex_; } + + // The position of the dof this scv is embedded in (list is defined such that first entry is vertex itself) + const GlobalPosition& dofPosition() const { return corners_[0]; } + + //! The global index of the element this scv is embedded in + GridIndexType elementIndex() const { return elementIndex_; } + + //! Return true if this scv is part of the fracture domain + bool isOnFracture() const { return isFractureScv_; } + + //! The geometry of the sub control volume + // e.g. for integration + Geometry geometry() const + { + if (isFractureScv_) + DUNE_THROW(Dune::InvalidStateException, "The geometry object cannot be defined for fracture scvs " + "because the number of known corners is insufficient. " + "You can do this manually by extract the corners from this scv " + "and extrude them by the corresponding aperture. "); + +#if DUNE_VERSION_NEWER(DUNE_COMMON,2,6) + return Geometry(Dune::GeometryTypes::cube(dim), corners_); +#else + return Geometry(Dune::GeometryType(Dune::GeometryType::cube, dim), corners_); +#endif + } + + //! Return the corner for the given local index + const GlobalPosition& corner(LocalIndexType localIdx) const + { + assert(localIdx < corners_.size() && "provided index exceeds the number of corners"); + return corners_[localIdx]; + } + +private: + bool isFractureScv_; + CornerStorage corners_; + GlobalPosition center_; + Scalar volume_; + GridIndexType elementIndex_; + LocalIndexType vIdxLocal_; + LocalIndexType elemLocalScvIdx_; + GridIndexType dofIndex_; + + // for fracture scvs only! + LocalIndexType facetIdx_; +}; + +} // end namespace + +#endif diff --git a/dumux/porousmediumflow/boxdfm/subcontrolvolumeface.hh b/dumux/porousmediumflow/boxdfm/subcontrolvolumeface.hh new file mode 100644 index 0000000000000000000000000000000000000000..16760c8d01d1bc2c0e84be9bac3bddd1cfa93c6a --- /dev/null +++ b/dumux/porousmediumflow/boxdfm/subcontrolvolumeface.hh @@ -0,0 +1,273 @@ +// -*- 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 . * + *****************************************************************************/ +/*! + * \file + * \brief The sub control volume face class for the box discrete fracture model. + */ +#ifndef DUMUX_POROUSMEDIUMFLOW_BOXDFM_SUBCONTROLVOLUMEFACE_HH +#define DUMUX_POROUSMEDIUMFLOW_BOXDFM_SUBCONTROLVOLUMEFACE_HH + +#include + +#include +#include +#include + +#include +#include +#include + +namespace Dumux { + +/*! + * \ingroup BoxDiscretization + * \brief Default traits class to be used for the sub-control volume faces + * for the box discrete fracture scheme + * \tparam GV the type of the grid view + * + * \note We define new traits for the box-dfm sub-control volume face + * as we use a different type of container for storing the scvf corners! + */ +template +struct BoxDfmDefaultScvfGeometryTraits +{ + using Grid = typename GridView::Grid; + static constexpr int dim = Grid::dimension; + static constexpr int dimWorld = Grid::dimensionworld; + + // we use geometry traits that use static corner vectors to and a fixed geometry type + template + struct ScvfMLGTraits : public Dune::MultiLinearGeometryTraits + { + // we use static vectors to store the corners as we know + // the number of corners in advance (2^(dim-1) corners (1<<(dim-1)) + // However, on fracture scvs the number might be smaller (use ReservedVector) + template< int mydim, int cdim > + struct CornerStorage + { + using Type = Dune::ReservedVector< Dune::FieldVector< ct, cdim >, (1<<(dim-1)) >; + }; + + // we know all scvfs will have the same geometry type + template< int mydim > + struct hasSingleGeometryType + { + static const bool v = true; + static const unsigned int topologyId = Dune::Impl::CubeTopology< mydim >::type::id; + }; + }; + + using GridIndexType = typename Grid::LeafGridView::IndexSet::IndexType; + using LocalIndexType = unsigned int; + using Scalar = typename Grid::ctype; + using Geometry = Dune::MultiLinearGeometry>; + using CornerStorage = typename ScvfMLGTraits::template CornerStorage::Type; + using GlobalPosition = typename CornerStorage::value_type; + using BoundaryFlag = Dumux::BoundaryFlag; +}; + +/*! + * \ingroup BoxDiscretization + * \brief Class for a sub control volume face in the box discrete fracture method, i.e a + * part of the boundary of a sub control volume we compute fluxes on. + * \tparam GV the type of the grid view + * \tparam T the scvf geometry traits + */ +template > +class BoxDfmSubControlVolumeFace +: public SubControlVolumeFaceBase, T> +{ + using ThisType = BoxDfmSubControlVolumeFace; + using ParentType = SubControlVolumeFaceBase; + using GridIndexType = typename T::GridIndexType; + using LocalIndexType = typename T::LocalIndexType; + using Scalar = typename T::Scalar; + using GlobalPosition = typename T::GlobalPosition; + using CornerStorage = typename T::CornerStorage; + using Geometry = typename T::Geometry; + using BoundaryFlag = typename T::BoundaryFlag; + + static_assert(T::dim == 2 || T::dim == 3, "Box-Dfm sub-control volume face only implemented in 2d or 3d"); + +public: + //! state the traits public and thus export all types + using Traits = T; + + //! The default constructor + BoxDfmSubControlVolumeFace() = default; + + //! Constructor for inner scvfs + template + BoxDfmSubControlVolumeFace(const GeometryHelper& geometryHelper, + const Element& element, + const typename Element::Geometry& elemGeometry, + GridIndexType scvfIndex, + std::vector&& scvIndices) + : corners_(geometryHelper.getScvfCorners(scvfIndex)) + , center_(0.0) + , unitOuterNormal_(geometryHelper.normal(corners_, scvIndices)) + , area_(geometryHelper.scvfArea(corners_)) + , scvfIndex_(scvfIndex) + , scvIndices_(std::move(scvIndices)) + , boundary_(false) + , isFractureScvf_(false) + , boundaryFlag_{} + , facetIdx_(0) + { + for (const auto& corner : corners_) + center_ += corner; + center_ /= corners_.size(); + } + + //! Constructor for boundary scvfs + template + BoxDfmSubControlVolumeFace(const GeometryHelper& geometryHelper, + const Intersection& intersection, + const typename Intersection::Geometry& isGeometry, + LocalIndexType indexInIntersection, + GridIndexType scvfIndex, + std::vector&& scvIndices) + : corners_(geometryHelper.getBoundaryScvfCorners(intersection, isGeometry, indexInIntersection)) + , center_(0.0) + , unitOuterNormal_(intersection.centerUnitOuterNormal()) + , area_(geometryHelper.scvfArea(corners_)) + , scvfIndex_(scvfIndex) + , scvIndices_(std::move(scvIndices)) + , boundary_(true) + , isFractureScvf_(false) + , boundaryFlag_{intersection} + , facetIdx_(0) + { + for (const auto& corner : corners_) + center_ += corner; + center_ /= corners_.size(); + } + + //! Constructor for inner fracture scvfs + template + BoxDfmSubControlVolumeFace(const GeometryHelper& geometryHelper, + const Intersection& intersection, + const typename Intersection::Geometry& isGeometry, + LocalIndexType indexInIntersection, + GridIndexType scvfIndex, + std::vector&& scvIndices, + bool boundary) + : corners_(geometryHelper.getFractureScvfCorners(intersection, isGeometry, indexInIntersection)) + , center_(0.0) + , scvfIndex_(scvfIndex) + , scvIndices_(std::move(scvIndices)) + , boundary_(boundary) + , isFractureScvf_(true) + , boundaryFlag_{intersection} + , facetIdx_(intersection.indexInInside()) + { + // The area here is given in meters. In order to + // get the right dimensions, the user has to provide + // the appropriate aperture in the problem (via an extrusion factor) + if (T::dim == 3) + area_ = (corners_[1]-corners_[0]).two_norm(); + else if (T::dim == 2) + area_ = 1.0; + + // obtain the unit normal vector + unitOuterNormal_ = geometryHelper.fractureNormal(corners_, intersection, indexInIntersection); + + // compute the scvf center + for (const auto& corner : corners_) + center_ += corner; + center_ /= corners_.size(); + } + + //! The center of the sub control volume face + const GlobalPosition& center() const { return center_; } + + //! The integration point for flux evaluations in global coordinates + const GlobalPosition& ipGlobal() const { return center_; } + + //! The area of the sub control volume face + Scalar area() const { return area_; } + + //! returns bolean if the sub control volume face is on the boundary + bool boundary() const { return boundary_; } + + //! returns the unit normal vector pointing outwards + const GlobalPosition& unitOuterNormal() const { return unitOuterNormal_; } + + //! The global index of this sub control volume face + GridIndexType index() const { return scvfIndex_; } + + //! Return if this is a fracture scvf + bool isOnFracture() const { return isFractureScvf_; } + + //! The element-local facet index for which a fracture scv was created + LocalIndexType facetIndexInElement() const { assert(isFractureScvf_); return facetIdx_; } + + //! Return the boundary flag + typename BoundaryFlag::value_type boundaryFlag() const { return boundaryFlag_.get(); } + + //! index of the inside sub control volume for spatial param evaluation + LocalIndexType insideScvIdx() const { return scvIndices_[0]; } + + //! index of the outside sub control volume for spatial param evaluation + // This results in undefined behaviour if boundary is true + LocalIndexType outsideScvIdx() const + { + assert(!boundary()); + return scvIndices_[1]; + } + + const GlobalPosition& corner(unsigned int localIdx) const + { + assert(localIdx < corners_.size() && "provided index exceeds the number of corners"); + return corners_[localIdx]; + } + + //! The geometry of the sub control volume face + Geometry geometry() const + { + if (isFractureScvf_) + DUNE_THROW(Dune::InvalidStateException, "The geometry object cannot be defined for fracture scvs " + "because the number of known corners is insufficient. " + "You can do this manually by extract the corners from this scv " + "and extrude them by the corresponding aperture. "); + +#if DUNE_VERSION_NEWER(DUNE_COMMON,2,6) + return Geometry(Dune::GeometryTypes::cube(Geometry::mydimension), corners_); +#else + return Geometry(Dune::GeometryType(Dune::GeometryType::cube, Geometry::mydimension), corners_); +#endif + } + +private: + CornerStorage corners_; + GlobalPosition center_; + GlobalPosition unitOuterNormal_; + Scalar area_; + GridIndexType scvfIndex_; + std::vector scvIndices_; + bool boundary_; + bool isFractureScvf_; + BoundaryFlag boundaryFlag_; + LocalIndexType facetIdx_; +}; + +} // end namespace Dumux + +#endif diff --git a/dumux/porousmediumflow/boxdfm/vtkoutputmodule.hh b/dumux/porousmediumflow/boxdfm/vtkoutputmodule.hh new file mode 100644 index 0000000000000000000000000000000000000000..5ecfba6a63a3757b08b451f2577c6822405bdc9c --- /dev/null +++ b/dumux/porousmediumflow/boxdfm/vtkoutputmodule.hh @@ -0,0 +1,620 @@ +// -*- 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 . * + *****************************************************************************/ +/*! + * \file + * \ingroup InputOutput + * \brief A VTK output module to simplify writing dumux simulation data to VTK format + */ +#ifndef POROUSMEDIUMFLOW_BOXDFM_VTK_OUTPUT_MODULE_HH +#define POROUSMEDIUMFLOW_BOXDFM_VTK_OUTPUT_MODULE_HH + +#include + +#include +#include +#include + +#include + +namespace Dumux { + +/*! + * \ingroup InputOutput + * \brief A VTK output module to simplify writing dumux simulation data to VTK format. + * This output module is specialized for writing out data obtained by the box-dfm + * scheme. It writes out separate vtk files for the solution on the fracture. For + * this, a grid type to be used the fracture-conforming lower-dimensional grid has + * to be provided. + * + * \tparam TypeTag The TypeTag of the problem implementation + * \tparam FractureGrid The Type used for the lower-dimensional grid + * \tparam phaseIdxOffset Used for single-phase problems to retrieve the right phase name + * + * Handles the output of scalar and vector fields to VTK formatted file for multiple + * variables and timesteps. Certain predefined fields can be registered on + * initialization and/or be turned on/off using the designated properties. Additionally + * non-standardized scalar and vector fields can be added to the writer manually. + */ +template +class BoxDfmVtkOutputModule : public VtkOutputModule +{ + using ParentType = VtkOutputModule; + + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + using GridVariables = typename GET_PROP_TYPE(TypeTag, GridVariables); + using SolutionVector = typename GET_PROP_TYPE(TypeTag, SolutionVector); + using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry); + using VelocityOutput = typename GET_PROP_TYPE(TypeTag, VelocityOutput); + using ModelTraits = typename GET_PROP_TYPE(TypeTag, ModelTraits); + static constexpr int numPhases = ModelTraits::numPhases(); + + using VV = typename GridVariables::VolumeVariables; + using FluidSystem = typename VV::FluidSystem; + using Scalar = typename GridVariables::Scalar; + + using GridView = typename FVGridGeometry::GridView; + using FractureGridView = typename FractureGrid::LeafGridView; + using FractureMapper = Dune::MultipleCodimMultipleGeomTypeMapper; + + enum + { + dim = GridView::dimension, + dimWorld = GridView::dimensionworld + }; + + using IndexType = typename GridView::IndexSet::IndexType; + using Element = typename GridView::template Codim<0>::Entity; + using GlobalPosition = typename Element::Geometry::GlobalCoordinate; + using ReferenceElements = typename Dune::ReferenceElements; + + using Field = Vtk::template Field; + using FractureField = Vtk::template Field; + + static_assert(dim > 1, "Box-Dfm output only works for dim > 1"); + static_assert(FractureGrid::dimension == int(dim-1), "Fracture grid must be of codimension one!"); + static_assert(FractureGrid::dimensionworld == int(dimWorld), "Fracture grid has to has the same coordinate dimension!"); + static_assert(FVGridGeometry::discMethod == DiscretizationMethod::box, "Box-Dfm output module can only be used with the box scheme!"); +public: + + //! The constructor + BoxDfmVtkOutputModule(const Problem& problem, + const FVGridGeometry& fvGridGeometry, + const GridVariables& gridVariables, + const SolutionVector& sol, + const std::string& name, + const std::string& paramGroup = "", + Dune::VTK::DataMode dm = Dune::VTK::conforming, + bool verbose = true) + : ParentType(problem, fvGridGeometry, gridVariables, sol, name, paramGroup, dm, verbose) + { + // create the fracture grid and all objects needed on it + initializeFracture(fvGridGeometry); + } + + ////////////////////////////////////////////////////////////////////////////////////////////// + //! Writing data + ////////////////////////////////////////////////////////////////////////////////////////////// + + //! Write the data for this timestep to file in four steps + //! (1) We assemble all registered variable fields + //! (2) We register them with the vtk writer + //! (3) The writer writes the output for us + //! (4) Clear the writer for the next time step + void write(double time, Dune::VTK::OutputType type = Dune::VTK::ascii) + { + Dune::Timer timer; + + // write to file depending on data mode + const auto dm = this->dataMode(); + if (dm == Dune::VTK::conforming) + writeConforming_(time, type); + else if (dm == Dune::VTK::nonconforming) + writeNonConforming_(time, type); + else + DUNE_THROW(Dune::NotImplemented, "Output for provided vtk data mode"); + + //! output + timer.stop(); + if (this->verbose()) + std::cout << "Writing output for problem \"" << this->name() << "\". Took " << timer.elapsed() << " seconds." << std::endl; + } + +private: + //! Assembles the fields and adds them to the writer (conforming output) + void writeConforming_(double time, Dune::VTK::OutputType type) + { + ////////////////////////////////////////////////////////////// + //! (1) Assemble all variable fields and add to writer + ////////////////////////////////////////////////////////////// + + // instatiate the velocity output + VelocityOutput velocityOutput(this->problem(), this->fvGridGeometry(), this->gridVariables(), this->sol()); + std::array, numPhases> velocity; + + // process rank + static bool addProcessRank = getParamFromGroup(this->paramGroup(), "Vtk.AddProcessRank"); + std::vector rank; + + // volume variable data + std::vector> volVarScalarData; + std::vector> volVarScalarDataFracture; + std::vector> volVarVectorData; + std::vector> volVarVectorDataFracture; + + // some references for convenience + const auto& gridView = this->fvGridGeometry().gridView(); + const auto& volVarScalarDataInfo = this->volVarScalarDataInfo(); + const auto& volVarVectorDataInfo = this->volVarVectorDataInfo(); + + //! Abort if no data was registered + if (!volVarScalarDataInfo.empty() + || !volVarVectorDataInfo.empty() + || !this->fields().empty() + || velocityOutput.enableOutput() + || addProcessRank) + { + const auto numCells = gridView.size(0); + const auto numDofs = gridView.size(dim); + const auto numFractureVert = fractureGridView_->size(FractureGridView::dimension); + + // get fields for all volume variables + if (!this->volVarScalarDataInfo().empty()) + { + volVarScalarData.resize(volVarScalarDataInfo.size(), std::vector(numDofs)); + volVarScalarDataFracture.resize(volVarScalarDataInfo.size(), std::vector(numFractureVert)); + } + if (!this->volVarVectorDataInfo().empty()) + { + volVarVectorData.resize(volVarVectorDataInfo.size(), std::vector(numDofs)); + volVarVectorDataFracture.resize(volVarVectorDataInfo.size(), std::vector(numFractureVert)); + } + + if (velocityOutput.enableOutput()) + for (int phaseIdx = 0; phaseIdx < numPhases; ++phaseIdx) + velocity[phaseIdx].resize(numDofs); + + // maybe allocate space for the process rank + if (addProcessRank) rank.resize(numCells); + + for (const auto& element : elements(gridView, Dune::Partitions::interior)) + { + const auto eIdxGlobal = this->fvGridGeometry().elementMapper().index(element); + + auto fvGeometry = localView(this->fvGridGeometry()); + auto elemVolVars = localView(this->gridVariables().curGridVolVars()); + + // If velocity output is enabled we need to bind to the whole stencil + // otherwise element-local data is sufficient + if (velocityOutput.enableOutput()) + { + fvGeometry.bind(element); + elemVolVars.bind(element, fvGeometry, this->sol()); + } + else + { + fvGeometry.bindElement(element); + elemVolVars.bindElement(element, fvGeometry, this->sol()); + } + + if (!volVarScalarDataInfo.empty() || !volVarVectorDataInfo.empty()) + { + for (auto&& scv : scvs(fvGeometry)) + { + const auto dofIdxGlobal = scv.dofIndex(); + const auto& volVars = elemVolVars[scv]; + + if (!scv.isOnFracture()) + { + for (std::size_t i = 0; i < volVarScalarDataInfo.size(); ++i) + volVarScalarData[i][dofIdxGlobal] = volVarScalarDataInfo[i].get(volVars); + for (std::size_t i = 0; i < volVarVectorDataInfo.size(); ++i) + volVarVectorData[i][dofIdxGlobal] = volVarVectorDataInfo[i].get(volVars); + } + else + { + for (std::size_t i = 0; i < volVarScalarDataInfo.size(); ++i) + volVarScalarDataFracture[i][vertexToFractureVertexIdx_[dofIdxGlobal]] = volVarScalarDataInfo[i].get(volVars); + for (std::size_t i = 0; i < volVarVectorDataInfo.size(); ++i) + volVarVectorDataFracture[i][vertexToFractureVertexIdx_[dofIdxGlobal]] = volVarVectorDataInfo[i].get(volVars); + } + } + } + + // velocity output + if (velocityOutput.enableOutput()) + for (int phaseIdx = 0; phaseIdx < numPhases; ++phaseIdx) + velocityOutput.calculateVelocity(velocity[phaseIdx], elemVolVars, fvGeometry, element, phaseIdx); + + //! the rank + if (addProcessRank) + rank[eIdxGlobal] = static_cast(gridView.comm().rank()); + } + + ////////////////////////////////////////////////////////////// + //! (2) Register data fields with the vtk writer + ////////////////////////////////////////////////////////////// + + // volume variables if any + for (std::size_t i = 0; i < volVarScalarDataInfo.size(); ++i) + { + this->sequenceWriter().addVertexData(volVarScalarData[i], volVarScalarDataInfo[i].name); + fractureSequenceWriter_->addVertexData(volVarScalarDataFracture[i], volVarScalarDataInfo[i].name); + } + + for (std::size_t i = 0; i < volVarVectorDataInfo.size(); ++i) + { + this->sequenceWriter().addVertexData( Field(gridView, this->fvGridGeometry().vertexMapper(), volVarVectorData[i], + volVarVectorDataInfo[i].name, /*numComp*/dimWorld, /*codim*/dim).get() ); + fractureSequenceWriter_->addVertexData( FractureField(*fractureGridView_, *fractureVertexMapper_, volVarVectorDataFracture[i], + volVarVectorDataInfo[i].name, /*numComp*/dimWorld, /*codim*/dim-1).get() ); + } + + // the velocity field + if (velocityOutput.enableOutput()) + { + for (int phaseIdx = 0; phaseIdx < numPhases; ++phaseIdx) + this->sequenceWriter().addVertexData( Field(gridView, this->fvGridGeometry().vertexMapper(), velocity[phaseIdx], + "velocity_" + std::string(FluidSystem::phaseName(phaseIdx+phaseIdxOffset)) + " (m/s)", + /*numComp*/dimWorld, /*codim*/dim).get() ); + } + + // the process rank + if (addProcessRank) + this->sequenceWriter().addCellData( Field(gridView, this->fvGridGeometry().elementMapper(), rank, + "process rank", /*numComp*/1, /*codim*/0).get() ); + + // also register additional (non-standardized) user fields if any (only on matrix grid) + for (auto&& field : this->fields()) + { + if (field.codim() == 0) + this->sequenceWriter().addCellData(field.get()); + else if (field.codim() == dim) + this->sequenceWriter().addVertexData(field.get()); + else + DUNE_THROW(Dune::RangeError, "Cannot add wrongly sized vtk scalar field!"); + } + } + + ////////////////////////////////////////////////////////////// + //! (2) The writer writes the output for us + ////////////////////////////////////////////////////////////// + this->sequenceWriter().write(time, type); + fractureSequenceWriter_->write(time, type); + + ////////////////////////////////////////////////////////////// + //! (3) Clear the writer + ////////////////////////////////////////////////////////////// + this->writer().clear(); + fractureWriter_->clear(); + } + + //! Assembles the fields and adds them to the writer (conforming output) + void writeNonConforming_(double time, Dune::VTK::OutputType type) + { + ////////////////////////////////////////////////////////////// + //! (1) Assemble all variable fields and add to writer + ////////////////////////////////////////////////////////////// + + // instatiate the velocity output + VelocityOutput velocityOutput(this->problem(), this->fvGridGeometry(), this->gridVariables(), this->sol()); + std::array, numPhases> velocity; + + // process rank + static bool addProcessRank = getParamFromGroup(this->paramGroup(), "Vtk.AddProcessRank"); + std::vector rank; + + // volume variable data (indexing: volvardata/element/localcorner) + using ScalarDataContainer = std::vector< std::vector >; + using VectorDataContainer = std::vector< std::vector >; + std::vector< ScalarDataContainer > volVarScalarData; + std::vector< ScalarDataContainer > volVarScalarDataFracture; + std::vector< VectorDataContainer > volVarVectorData; + std::vector< VectorDataContainer > volVarVectorDataFracture; + + // some references for convenience + const auto& gridView = this->fvGridGeometry().gridView(); + const auto& volVarScalarDataInfo = this->volVarScalarDataInfo(); + const auto& volVarVectorDataInfo = this->volVarVectorDataInfo(); + + //! Abort if no data was registered + if (!volVarScalarDataInfo.empty() + || !volVarVectorDataInfo.empty() + || !this->fields().empty() + || velocityOutput.enableOutput() + || addProcessRank) + { + const auto numCells = gridView.size(0); + const auto numDofs = gridView.size(dim); + const auto numFractureCells = fractureGridView_->size(0); + + // get fields for all volume variables + if (!this->volVarScalarDataInfo().empty()) + { + volVarScalarData.resize(volVarScalarDataInfo.size(), ScalarDataContainer(numCells)); + volVarScalarDataFracture.resize(volVarScalarDataInfo.size(), ScalarDataContainer(numFractureCells)); + } + if (!this->volVarVectorDataInfo().empty()) + { + volVarVectorData.resize(volVarVectorDataInfo.size(), VectorDataContainer(numCells)); + volVarVectorDataFracture.resize(volVarVectorDataInfo.size(), VectorDataContainer(numFractureCells)); + } + + if (velocityOutput.enableOutput()) + for (int phaseIdx = 0; phaseIdx < numPhases; ++phaseIdx) + velocity[phaseIdx].resize(numDofs); + + // maybe allocate space for the process rank + if (addProcessRank) rank.resize(numCells); + + for (const auto& element : elements(gridView, Dune::Partitions::interior)) + { + const auto eIdxGlobal = this->fvGridGeometry().elementMapper().index(element); + const auto numCorners = element.subEntities(dim); + + auto fvGeometry = localView(this->fvGridGeometry()); + auto elemVolVars = localView(this->gridVariables().curGridVolVars()); + + // resize element-local data containers (for bulk grid) + for (std::size_t i = 0; i < volVarScalarDataInfo.size(); ++i) + volVarScalarData[i][eIdxGlobal].resize(numCorners); + for (std::size_t i = 0; i < volVarVectorDataInfo.size(); ++i) + volVarVectorData[i][eIdxGlobal].resize(numCorners); + + // If velocity output is enabled we need to bind to the whole stencil + // otherwise element-local data is sufficient + if (velocityOutput.enableOutput()) + { + fvGeometry.bind(element); + elemVolVars.bind(element, fvGeometry, this->sol()); + } + else + { + fvGeometry.bindElement(element); + elemVolVars.bindElement(element, fvGeometry, this->sol()); + } + + if (!volVarScalarDataInfo.empty() || !volVarVectorDataInfo.empty()) + { + for (auto&& scv : scvs(fvGeometry)) + { + const auto& volVars = elemVolVars[scv]; + + if (!scv.isOnFracture()) + { + for (std::size_t i = 0; i < volVarScalarDataInfo.size(); ++i) + volVarScalarData[i][eIdxGlobal][scv.localDofIndex()] = volVarScalarDataInfo[i].get(volVars); + for (std::size_t i = 0; i < volVarVectorDataInfo.size(); ++i) + volVarVectorData[i][eIdxGlobal][scv.localDofIndex()] = volVarVectorDataInfo[i].get(volVars); + } + else + { + const auto fIdx = scv.facetIndexInElement(); + const auto& localMap = fractureElementMap_[eIdxGlobal]; + const auto fracEIdx = std::find_if(localMap.begin(), localMap.end(), [fIdx] (const auto& p) { return p.first == fIdx; })->second; + for (std::size_t i = 0; i < volVarScalarDataInfo.size(); ++i) + volVarScalarDataFracture[i][fracEIdx].push_back(volVarScalarDataInfo[i].get(volVars)); + for (std::size_t i = 0; i < volVarVectorDataInfo.size(); ++i) + volVarVectorDataFracture[i][fracEIdx].push_back(volVarVectorDataInfo[i].get(volVars)); + } + } + } + + // velocity output + if (velocityOutput.enableOutput()) + for (int phaseIdx = 0; phaseIdx < numPhases; ++phaseIdx) + velocityOutput.calculateVelocity(velocity[phaseIdx], elemVolVars, fvGeometry, element, phaseIdx); + + //! the rank + if (addProcessRank) + rank[eIdxGlobal] = static_cast(gridView.comm().rank()); + } + + ////////////////////////////////////////////////////////////// + //! (2) Register data fields with the vtk writer + ////////////////////////////////////////////////////////////// + + // volume variables if any + for (std::size_t i = 0; i < volVarScalarDataInfo.size(); ++i) + { + this->sequenceWriter().addVertexData( Field(gridView, this->fvGridGeometry().elementMapper(), volVarScalarData[i], + volVarScalarDataInfo[i].name, /*numComp*/1, /*codim*/dim, + /*nonconforming*/this->dataMode()).get() ); + fractureSequenceWriter_->addVertexData( FractureField(*fractureGridView_, *fractureElementMapper_, volVarScalarDataFracture[i], + volVarScalarDataInfo[i].name, /*numComp*/1, /*codim*/dim-1, + /*nonconforming*/this->dataMode()).get() ); + } + + for (std::size_t i = 0; i < volVarVectorDataInfo.size(); ++i) + { + this->sequenceWriter().addVertexData( Field(gridView, this->fvGridGeometry().elementMapper(), volVarVectorData[i], + volVarVectorDataInfo[i].name, /*numComp*/dimWorld, /*codim*/dim, + /*nonconforming*/this->dataMode()).get() ); + fractureSequenceWriter_->addVertexData( FractureField(*fractureGridView_, *fractureElementMapper_, volVarVectorDataFracture[i], + volVarVectorDataInfo[i].name, /*numComp*/dimWorld, /*codim*/dim-1, + /*nonconforming*/this->dataMode()).get() ); + } + + // the velocity field + if (velocityOutput.enableOutput()) + { + for (int phaseIdx = 0; phaseIdx < numPhases; ++phaseIdx) + this->sequenceWriter().addVertexData( Field(gridView, this->fvGridGeometry().vertexMapper(), velocity[phaseIdx], + "velocity_" + std::string(FluidSystem::phaseName(phaseIdx+phaseIdxOffset)) + " (m/s)", + /*numComp*/dimWorld, /*codim*/dim).get() ); + } + + // the process rank + if (addProcessRank) + this->sequenceWriter().addCellData( Field(gridView, this->fvGridGeometry().elementMapper(), rank, + "process rank", /*numComp*/1, /*codim*/0).get() ); + + // also register additional (non-standardized) user fields if any (only on matrix grid) + for (auto&& field : this->fields()) + { + if (field.codim() == 0) + this->sequenceWriter().addCellData(field.get()); + else if (field.codim() == dim) + this->sequenceWriter().addVertexData(field.get()); + else + DUNE_THROW(Dune::RangeError, "Cannot add wrongly sized vtk scalar field!"); + } + } + + ////////////////////////////////////////////////////////////// + //! (2) The writer writes the output for us + ////////////////////////////////////////////////////////////// + this->sequenceWriter().write(time, type); + fractureSequenceWriter_->write(time, type); + + ////////////////////////////////////////////////////////////// + //! (3) Clear the writer + ////////////////////////////////////////////////////////////// + this->writer().clear(); + fractureWriter_->clear(); + } + + //! Creates the lower-dimensional fracture grid, index maps and writers + void initializeFracture(const FVGridGeometry& fvGridGeometry) + { + const auto& gridView = fvGridGeometry.gridView(); + Dune::GridFactory gridFactory; + + // insert fracture vertices + std::size_t fracVertexCount = 0; + vertexToFractureVertexIdx_.resize(gridView.size(dim)); + for (const auto& v : vertices(gridView)) + { + const auto vIdxGlobal = fvGridGeometry.vertexMapper().index(v); + if (fvGridGeometry.dofOnFracture(vIdxGlobal)) + { + gridFactory.insertVertex(v.geometry().center()); + vertexToFractureVertexIdx_[vIdxGlobal] = fracVertexCount++; + } + } + + // insert fracture elements + std::size_t fractureElementCount = 0; + fractureElementMap_.resize(gridView.size(0)); + std::set< std::pair > handledFacets; + auto vertIsOnFracture = [&fvGridGeometry] (auto idx) { return fvGridGeometry.dofOnFracture(idx); }; + + for (const auto& element : elements(gridView)) + { + const auto eIdxGlobal = fvGridGeometry.elementMapper().index(element); + const auto referenceElement = ReferenceElements::general(element.geometry().type()); + + for (const auto& is : intersections(gridView, element)) + { + // obtain all vertex indices on this intersection + const auto& isGeometry = is.geometry(); + const auto numCorners = isGeometry.corners(); + const auto indexInInside = is.indexInInside(); + + std::vector isVertexIndices(numCorners); + for (unsigned int i = 0; i < numCorners; ++i) + isVertexIndices[i] = fvGridGeometry.vertexMapper().subIndex(element, + referenceElement.subEntity(indexInInside, 1, i, dim), + dim); + + // determine if this is a fracture facet & if it has to be inserted + bool insertFacet = false; + if ( std::all_of(isVertexIndices.begin(), isVertexIndices.end(), vertIsOnFracture) ) + { + insertFacet = true; + if (!is.boundary()) + { + // only proceed if facet has not been handled yet + const auto outsideEIdx = fvGridGeometry.elementMapper().index(is.outside()); + const auto idxInOutside = is.indexInOutside(); + const auto pair = std::make_pair(outsideEIdx, idxInOutside); + if (handledFacets.count( pair ) != 0) + { + insertFacet = false; + + // obtain the fracture grid elem idx from outside map and insert to map + const auto& outsideMap = fractureElementMap_[outsideEIdx]; + auto it = std::find_if(outsideMap.begin(), outsideMap.end(), [idxInOutside] (const auto& p) { return p.first == idxInOutside; }); + fractureElementMap_[eIdxGlobal].push_back( std::make_pair(indexInInside, it->second) ); + } + } + } + + if (insertFacet) + { + // transform intersection vertex indices to frac grid indices + std::for_each( isVertexIndices.begin(), + isVertexIndices.end(), + [&] (auto& idx) { idx = this->vertexToFractureVertexIdx_[idx]; } ); + + // insert the element + gridFactory.insertElement(isGeometry.type(), isVertexIndices); + + // insert to set of handled facets + handledFacets.insert( std::make_pair(eIdxGlobal, indexInInside) ); + fractureElementMap_[eIdxGlobal].push_back( std::make_pair(indexInInside, fractureElementCount) ); + fractureElementCount++; + } + } + } + + // make grid and get grid view + auto grid = gridFactory.createGrid(); + fractureGridView_ = std::make_unique(grid->leafGridView()); + + // update fracture mappers + fractureVertexMapper_ = std::make_unique(*fractureGridView_, Dune::mcmgVertexLayout()); + fractureElementMapper_ = std::make_unique(*fractureGridView_, Dune::mcmgElementLayout()); + + // obtain map fracture insertion indices -> fracture grid indices + std::vector insToVertexIdx(fractureGridView_->size(FractureGridView::dimension)); + std::vector insToElemIdx(fractureGridView_->size(0)); + for (const auto& v : vertices(*fractureGridView_)) insToVertexIdx[ gridFactory.insertionIndex(v) ] = fractureVertexMapper_->index(v); + for (const auto& e : elements(*fractureGridView_)) insToElemIdx[ gridFactory.insertionIndex(e) ] = fractureElementMapper_->index(e); + + // update vertex index map + for (IndexType dofIdx = 0; dofIdx < gridView.size(GridView::dimension); ++dofIdx) + if (fvGridGeometry.dofOnFracture(dofIdx)) + vertexToFractureVertexIdx_[dofIdx] = insToVertexIdx[ vertexToFractureVertexIdx_[dofIdx] ]; + + // update fracture element map + for (auto& elemLocalMap : fractureElementMap_) + for (auto& dataPair : elemLocalMap) + dataPair.second = insToElemIdx[ dataPair.second ]; + + // instantiate writers for the fracture + fractureWriter_ = std::make_shared< Dune::VTKWriter >(*fractureGridView_, this->dataMode()); + fractureSequenceWriter_ = std::make_unique< Dune::VTKSequenceWriter >(fractureWriter_, this->name() + "_fracture"); + } + + std::unique_ptr fractureVertexMapper_; + std::unique_ptr fractureElementMapper_; + std::unique_ptr fractureGridView_; + std::shared_ptr> fractureWriter_; + std::unique_ptr< Dune::VTKSequenceWriter > fractureSequenceWriter_; + + // maps to a bulk grid vertex the vertex index within the fracture grid + std::vector vertexToFractureVertexIdx_; + + // maps to the local facet indices of an element the corresponding fracture element indices + std::vector< std::vector> > fractureElementMap_; +}; + +} // end namespace Dumux + +#endif diff --git a/test/porousmediumflow/2p/implicit/CMakeLists.txt b/test/porousmediumflow/2p/implicit/CMakeLists.txt index b32b5495d7ee09e1249a4e8ea2b90094cd204445..b18c82cdbfb9e845d52c5cee9ba8922cf4253df7 100644 --- a/test/porousmediumflow/2p/implicit/CMakeLists.txt +++ b/test/porousmediumflow/2p/implicit/CMakeLists.txt @@ -1,4 +1,5 @@ add_subdirectory(adaptive) +add_subdirectory(boxdfm) add_subdirectory(fracture) add_subdirectory(incompressible) add_subdirectory(nonisothermal) diff --git a/test/porousmediumflow/2p/implicit/boxdfm/CMakeLists.txt b/test/porousmediumflow/2p/implicit/boxdfm/CMakeLists.txt new file mode 100644 index 0000000000000000000000000000000000000000..0e406950f9cd71a0860dbb372d52c326418db527 --- /dev/null +++ b/test/porousmediumflow/2p/implicit/boxdfm/CMakeLists.txt @@ -0,0 +1,100 @@ +dune_symlink_to_source_files(FILES "test_2p.input" "grids") + +# quadrilaterals yasp +dune_add_test(NAME test_2pboxdfm_quads_yasp + SOURCES test_2pboxdfm.cc + CMAKE_GUARD dune-foamgrid_FOUND + COMPILE_DEFINITIONS GRIDTYPE=Dune::YaspGrid<2> + COMPILE_DEFINITIONS FRACTUREGRIDTYPE=Dune::FoamGrid<1,2> + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/2pboxdfm_2d_quads-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/2pboxdfm_quads_yasp-00063.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_2pboxdfm_quads_yasp test_2p.input -Problem.Name 2pboxdfm_quads_yasp") + +# quadrilaterals alu grid +dune_add_test(NAME test_2pboxdfm_quads_alu + SOURCES test_2pboxdfm.cc + CMAKE_GUARD dune-alugrid_FOUND + CMAKE_GUARD dune-foamgrid_FOUND + COMPILE_DEFINITIONS GRIDTYPE=Dune::ALUGrid<2,2,Dune::cube,Dune::nonconforming> + COMPILE_DEFINITIONS FRACTUREGRIDTYPE=Dune::FoamGrid<1,2> + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/2pboxdfm_2d_quads-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/2pboxdfm_quads_alu-00063.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_2pboxdfm_quads_alu test_2p.input -Problem.Name 2pboxdfm_quads_alu") + +# quadrilaterals ug grid +dune_add_test(NAME test_2pboxdfm_quads_ug + SOURCES test_2pboxdfm.cc + CMAKE_GUARD dune-uggrid_FOUND + CMAKE_GUARD dune-foamgrid_FOUND + COMPILE_DEFINITIONS GRIDTYPE=Dune::UGGrid<2> + COMPILE_DEFINITIONS FRACTUREGRIDTYPE=Dune::FoamGrid<1,2> + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/2pboxdfm_2d_quads-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/2pboxdfm_quads_ug-00063.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_2pboxdfm_quads_ug test_2p.input -Problem.Name 2pboxdfm_quads_ug") + +# triangles alu +dune_add_test(NAME test_2pboxdfm_trias_alu + SOURCES test_2pboxdfm.cc + CMAKE_GUARD dune-foamgrid_FOUND + CMAKE_GUARD dune-alugrid_FOUND + COMPILE_DEFINITIONS GRIDTYPE=Dune::ALUGrid<2,2,Dune::simplex,Dune::nonconforming> + COMPILE_DEFINITIONS FRACTUREGRIDTYPE=Dune::FoamGrid<1,2> + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/2pboxdfm_2d_trias-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/2pboxdfm_trias_alu-00063.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_2pboxdfm_trias_alu test_2p.input -Problem.Name 2pboxdfm_trias_alu -Grid.File grids/2d_trias.msh") + +# triangles ug +dune_add_test(NAME test_2pboxdfm_trias_ug + SOURCES test_2pboxdfm.cc + CMAKE_GUARD dune-uggrid_FOUND + CMAKE_GUARD dune-foamgrid_FOUND + COMPILE_DEFINITIONS GRIDTYPE=Dune::UGGrid<2> + COMPILE_DEFINITIONS FRACTUREGRIDTYPE=Dune::FoamGrid<1,2> + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/2pboxdfm_2d_trias-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/2pboxdfm_trias_ug-00063.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_2pboxdfm_trias_ug test_2p.input -Problem.Name 2pboxdfm_trias_ug -Grid.File grids/2d_trias.msh") + +# tetrahedra alu +dune_add_test(NAME test_2pboxdfm_tets_alu + SOURCES test_2pboxdfm.cc + CMAKE_GUARD dune-foamgrid_FOUND + CMAKE_GUARD dune-alugrid_FOUND + COMPILE_DEFINITIONS GRIDTYPE=Dune::ALUGrid<3,3,Dune::simplex,Dune::nonconforming> + COMPILE_DEFINITIONS FRACTUREGRIDTYPE=Dune::FoamGrid<2,3> + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/2pboxdfm_3d_tets-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/2pboxdfm_tets_alu-00051.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_2pboxdfm_tets_alu test_2p.input -Problem.Name 2pboxdfm_tets_alu -Grid.File grids/3d_simplex.msh") + +# tetrahedra ug +dune_add_test(NAME test_2pboxdfm_tets_ug + SOURCES test_2pboxdfm.cc + CMAKE_GUARD dune-uggrid_FOUND + CMAKE_GUARD dune-foamgrid_FOUND + COMPILE_DEFINITIONS GRIDTYPE=Dune::UGGrid<3> + COMPILE_DEFINITIONS FRACTUREGRIDTYPE=Dune::FoamGrid<2,3> + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/2pboxdfm_3d_tets-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/2pboxdfm_tets_ug-00051.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_2pboxdfm_tets_ug test_2p.input -Problem.Name 2pboxdfm_tets_ug -Grid.File grids/3d_simplex.msh") + +set(CMAKE_BUILD_TYPE Release) + +#install sources +install(FILES +problem.hh +spatialparams.hh +test_2p_fv.cc +DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/test/implicit/2p/incompressible) diff --git a/test/porousmediumflow/2p/implicit/boxdfm/grids/2d_quads.msh b/test/porousmediumflow/2p/implicit/boxdfm/grids/2d_quads.msh new file mode 100644 index 0000000000000000000000000000000000000000..bc6b82e34facce6a479f8dfb44c6cffe9808e95e --- /dev/null +++ b/test/porousmediumflow/2p/implicit/boxdfm/grids/2d_quads.msh @@ -0,0 +1,3670 @@ +$MeshFormat +2.2 0 8 +$EndMeshFormat +$Nodes +1770 +1 0 0 0 +2 1 0 0 +3 1 1 0 +4 0 1 0 +5 0 0.5 0 +6 1 0.5 0 +7 0 0.4827586206895834 0 +8 0 0.4655172413791668 0 +9 0 0.4482758620687501 0 +10 0 0.4310344827584053 0 +11 0 0.4137931034481802 0 +12 0 0.396551724137955 0 +13 0 0.3793103448277298 0 +14 0 0.3620689655175046 0 +15 0 0.3448275862072794 0 +16 0 0.3275862068970541 0 +17 0 0.3103448275868289 0 +18 0 0.2931034482766036 0 +19 0 0.2758620689663784 0 +20 0 0.2586206896561532 0 +21 0 0.2413793103458323 0 +22 0 0.2241379310354157 0 +23 0 0.2068965517249991 0 +24 0 0.1896551724145825 0 +25 0 0.1724137931041659 0 +26 0 0.1551724137937493 0 +27 0 0.1379310344833328 0 +28 0 0.1206896551729162 0 +29 0 0.1034482758624996 0 +30 0 0.08620689655208297 0 +31 0 0.06896551724166639 0 +32 0 0.0517241379312498 0 +33 0 0.03448275862083316 0 +34 0 0.01724137931041664 0 +35 0.03448275862062319 0 0 +36 0.06896551724124121 0 0 +37 0.1034482758618778 0 0 +38 0.1379310344824967 0 0 +39 0.1724137931030857 0 0 +40 0.2068965517236747 0 0 +41 0.2413793103442637 0 0 +42 0.2758620689648527 0 0 +43 0.3103448275854417 0 0 +44 0.3448275862060307 0 0 +45 0.3793103448266197 0 0 +46 0.4137931034472087 0 0 +47 0.4482758620677977 0 0 +48 0.4827586206883868 0 0 +49 0.5172413793090714 0 0 +50 0.5517241379298521 0 0 +51 0.5862068965506327 0 0 +52 0.6206896551714133 0 0 +53 0.6551724137921939 0 0 +54 0.6896551724129745 0 0 +55 0.7241379310337551 0 0 +56 0.7586206896545358 0 0 +57 0.7931034482753163 0 0 +58 0.827586206896097 0 0 +59 0.8620689655168776 0 0 +60 0.8965517241376582 0 0 +61 0.9310344827584388 0 0 +62 0.9655172413792195 0 0 +63 1 0.0172413793103116 0 +64 1 0.03448275862062061 0 +65 1 0.05172413793093891 0 +66 1 0.06896551724124836 0 +67 1 0.08620689655154284 0 +68 1 0.1034482758618374 0 +69 1 0.1206896551721319 0 +70 1 0.1379310344824264 0 +71 1 0.1551724137927208 0 +72 1 0.1724137931030153 0 +73 1 0.1896551724133099 0 +74 1 0.2068965517236044 0 +75 1 0.2241379310338988 0 +76 1 0.2413793103441934 0 +77 1 0.2586206896545357 0 +78 1 0.275862068964926 0 +79 1 0.2931034482753164 0 +80 1 0.3103448275857066 0 +81 1 0.327586206896097 0 +82 1 0.3448275862064872 0 +83 1 0.3620689655168776 0 +84 1 0.3793103448272679 0 +85 1 0.3965517241376582 0 +86 1 0.4137931034480485 0 +87 1 0.4310344827584388 0 +88 1 0.4482758620688291 0 +89 1 0.4655172413792194 0 +90 1 0.4827586206896097 0 +91 0.9655172413791667 0.5 0 +92 0.9310344827583336 0.5 0 +93 0.8965517241375003 0.5 0 +94 0.8620689655168107 0.5 0 +95 0.8275862068963603 0.5 0 +96 0.79310344827591 0.5 0 +97 0.7586206896554596 0.5 0 +98 0.7241379310350091 0.5 0 +99 0.6896551724145588 0.5 0 +100 0.6551724137941082 0.5 0 +101 0.6206896551736578 0.5 0 +102 0.5862068965532072 0.5 0 +103 0.5517241379327569 0.5 0 +104 0.5172413793123064 0.5 0 +105 0.4827586206916645 0.5 0 +106 0.4482758620708314 0.5 0 +107 0.4137931034499982 0.5 0 +108 0.379310344829165 0.5 0 +109 0.3448275862083318 0.5 0 +110 0.3103448275874986 0.5 0 +111 0.2758620689666655 0.5 0 +112 0.2413793103458324 0.5 0 +113 0.2068965517249991 0.5 0 +114 0.1724137931041659 0.5 0 +115 0.1379310344833328 0.5 0 +116 0.1034482758624996 0.5 0 +117 0.06896551724166633 0.5 0 +118 0.03448275862083328 0.5 0 +119 0 0.5172413793103449 0 +120 0 0.5344827586206896 0 +121 0 0.5517241379310345 0 +122 0 0.5689655172413793 0 +123 0 0.5862068965517242 0 +124 0 0.603448275862069 0 +125 0 0.6206896551724138 0 +126 0 0.6379310344827587 0 +127 0 0.6551724137931034 0 +128 0 0.6724137931034483 0 +129 0 0.6896551724137931 0 +130 0 0.7068965517241379 0 +131 0 0.7241379310344828 0 +132 0 0.7413793103448276 0 +133 0 0.7586206896551724 0 +134 0 0.7758620689655172 0 +135 0 0.7931034482758621 0 +136 0 0.8103448275862069 0 +137 0 0.8275862068965517 0 +138 0 0.8448275862068966 0 +139 0 0.8620689655172413 0 +140 0 0.8793103448275862 0 +141 0 0.896551724137931 0 +142 0 0.9137931034482758 0 +143 0 0.9310344827586207 0 +144 0 0.9482758620689655 0 +145 0 0.9655172413793103 0 +146 0 0.9827586206896551 0 +147 0.03448275862062319 1 0 +148 0.06896551724124121 1 0 +149 0.1034482758618778 1 0 +150 0.1379310344824967 1 0 +151 0.1724137931030857 1 0 +152 0.2068965517236747 1 0 +153 0.2413793103442637 1 0 +154 0.2758620689648527 1 0 +155 0.3103448275854417 1 0 +156 0.3448275862060307 1 0 +157 0.3793103448266197 1 0 +158 0.4137931034472087 1 0 +159 0.4482758620677977 1 0 +160 0.4827586206883868 1 0 +161 0.5172413793090714 1 0 +162 0.5517241379298521 1 0 +163 0.5862068965506327 1 0 +164 0.6206896551714133 1 0 +165 0.6551724137921939 1 0 +166 0.6896551724129745 1 0 +167 0.7241379310337551 1 0 +168 0.7586206896545358 1 0 +169 0.7931034482753163 1 0 +170 0.827586206896097 1 0 +171 0.8620689655168776 1 0 +172 0.8965517241376582 1 0 +173 0.9310344827584388 1 0 +174 0.9655172413792195 1 0 +175 1 0.9827586206896551 0 +176 1 0.9655172413793104 0 +177 1 0.9482758620689655 0 +178 1 0.9310344827586207 0 +179 1 0.9137931034482758 0 +180 1 0.896551724137931 0 +181 1 0.8793103448275862 0 +182 1 0.8620689655172413 0 +183 1 0.8448275862068966 0 +184 1 0.8275862068965517 0 +185 1 0.8103448275862069 0 +186 1 0.7931034482758621 0 +187 1 0.7758620689655172 0 +188 1 0.7586206896551724 0 +189 1 0.7413793103448276 0 +190 1 0.7241379310344828 0 +191 1 0.7068965517241379 0 +192 1 0.6896551724137931 0 +193 1 0.6724137931034483 0 +194 1 0.6551724137931034 0 +195 1 0.6379310344827587 0 +196 1 0.6206896551724138 0 +197 1 0.603448275862069 0 +198 1 0.5862068965517242 0 +199 1 0.5689655172413793 0 +200 1 0.5517241379310345 0 +201 1 0.5344827586206897 0 +202 1 0.5172413793103449 0 +203 0.9655172413791685 0.5172413793103449 0 +204 0.9655172413791704 0.5344827586206896 0 +205 0.9655172413791723 0.5517241379310345 0 +206 0.9655172413791738 0.5689655172413793 0 +207 0.9655172413791758 0.5862068965517242 0 +208 0.9655172413791777 0.603448275862069 0 +209 0.9655172413791794 0.6206896551724138 0 +210 0.9655172413791812 0.6379310344827587 0 +211 0.9655172413791832 0.6551724137931034 0 +212 0.965517241379185 0.6724137931034483 0 +213 0.9655172413791866 0.6896551724137931 0 +214 0.9655172413791885 0.7068965517241379 0 +215 0.9655172413791905 0.7241379310344828 0 +216 0.9655172413791923 0.7413793103448276 0 +217 0.965517241379194 0.7586206896551724 0 +218 0.9655172413791958 0.7758620689655172 0 +219 0.9655172413791976 0.7931034482758621 0 +220 0.9655172413791993 0.8103448275862069 0 +221 0.9655172413792013 0.8275862068965518 0 +222 0.9655172413792034 0.8448275862068966 0 +223 0.9655172413792051 0.8620689655172413 0 +224 0.9655172413792069 0.8793103448275862 0 +225 0.9655172413792088 0.896551724137931 0 +226 0.9655172413792105 0.9137931034482758 0 +227 0.9655172413792122 0.9310344827586204 0 +228 0.965517241379214 0.9482758620689655 0 +229 0.9655172413792157 0.9655172413793103 0 +230 0.9655172413792176 0.9827586206896551 0 +231 0.9310344827583372 0.5172413793103449 0 +232 0.9310344827583407 0.5344827586206896 0 +233 0.9310344827583444 0.5517241379310345 0 +234 0.931034482758348 0.5689655172413793 0 +235 0.9310344827583518 0.5862068965517242 0 +236 0.9310344827583553 0.603448275862069 0 +237 0.9310344827583591 0.6206896551724138 0 +238 0.9310344827583625 0.6379310344827587 0 +239 0.9310344827583662 0.6551724137931034 0 +240 0.9310344827583699 0.6724137931034483 0 +241 0.9310344827583735 0.6896551724137931 0 +242 0.9310344827583774 0.7068965517241379 0 +243 0.9310344827583809 0.7241379310344828 0 +244 0.9310344827583844 0.7413793103448276 0 +245 0.931034482758388 0.7586206896551724 0 +246 0.9310344827583917 0.7758620689655172 0 +247 0.9310344827583954 0.7931034482758621 0 +248 0.9310344827583988 0.8103448275862069 0 +249 0.9310344827584027 0.8275862068965518 0 +250 0.9310344827584062 0.8448275862068966 0 +251 0.9310344827584096 0.8620689655172413 0 +252 0.9310344827584133 0.8793103448275862 0 +253 0.931034482758417 0.896551724137931 0 +254 0.9310344827584206 0.9137931034482758 0 +255 0.9310344827584244 0.9310344827586207 0 +256 0.9310344827584279 0.9482758620689655 0 +257 0.9310344827584315 0.9655172413793103 0 +258 0.9310344827584351 0.9827586206896552 0 +259 0.8965517241375058 0.5172413793103449 0 +260 0.8965517241375112 0.5344827586206896 0 +261 0.8965517241375167 0.5517241379310345 0 +262 0.896551724137522 0.5689655172413793 0 +263 0.8965517241375276 0.5862068965517242 0 +264 0.8965517241375329 0.603448275862069 0 +265 0.8965517241375385 0.6206896551724138 0 +266 0.8965517241375438 0.6379310344827587 0 +267 0.8965517241375491 0.6551724137931034 0 +268 0.8965517241375547 0.6724137931034483 0 +269 0.8965517241375602 0.6896551724137931 0 +270 0.8965517241375656 0.7068965517241379 0 +271 0.8965517241375711 0.7241379310344828 0 +272 0.8965517241375767 0.7413793103448276 0 +273 0.896551724137582 0.7586206896551724 0 +274 0.8965517241375873 0.775862068965517 0 +275 0.8965517241375929 0.7931034482758621 0 +276 0.8965517241375982 0.8103448275862069 0 +277 0.8965517241376038 0.8275862068965515 0 +278 0.8965517241376091 0.8448275862068966 0 +279 0.8965517241376144 0.8620689655172413 0 +280 0.8965517241376202 0.8793103448275862 0 +281 0.8965517241376255 0.896551724137931 0 +282 0.8965517241376308 0.9137931034482758 0 +283 0.8965517241376366 0.9310344827586207 0 +284 0.8965517241376419 0.9482758620689655 0 +285 0.8965517241376473 0.9655172413793103 0 +286 0.8965517241376526 0.9827586206896551 0 +287 0.8620689655168129 0.5172413793103449 0 +288 0.8620689655168152 0.5344827586206896 0 +289 0.8620689655168178 0.5517241379310345 0 +290 0.8620689655168198 0.5689655172413793 0 +291 0.8620689655168222 0.5862068965517242 0 +292 0.8620689655168247 0.603448275862069 0 +293 0.8620689655168269 0.6206896551724138 0 +294 0.862068965516829 0.6379310344827587 0 +295 0.8620689655168312 0.6551724137931034 0 +296 0.862068965516834 0.6724137931034483 0 +297 0.8620689655168361 0.6896551724137931 0 +298 0.8620689655168383 0.7068965517241379 0 +299 0.8620689655168406 0.7241379310344825 0 +300 0.8620689655168429 0.7413793103448276 0 +301 0.8620689655168453 0.7586206896551724 0 +302 0.8620689655168475 0.7758620689655172 0 +303 0.8620689655168499 0.7931034482758621 0 +304 0.8620689655168521 0.8103448275862069 0 +305 0.8620689655168544 0.8275862068965517 0 +306 0.8620689655168567 0.8448275862068966 0 +307 0.862068965516859 0.8620689655172413 0 +308 0.8620689655168615 0.8793103448275862 0 +309 0.8620689655168637 0.896551724137931 0 +310 0.8620689655168662 0.9137931034482758 0 +311 0.8620689655168684 0.9310344827586207 0 +312 0.8620689655168708 0.9482758620689655 0 +313 0.8620689655168731 0.9655172413793103 0 +314 0.8620689655168753 0.9827586206896552 0 +315 0.8275862068963512 0.5172413793103449 0 +316 0.8275862068963423 0.5344827586206896 0 +317 0.8275862068963332 0.5517241379310345 0 +318 0.8275862068963241 0.5689655172413793 0 +319 0.8275862068963148 0.5862068965517242 0 +320 0.8275862068963059 0.603448275862069 0 +321 0.8275862068962969 0.6206896551724138 0 +322 0.8275862068962877 0.6379310344827587 0 +323 0.8275862068962785 0.6551724137931034 0 +324 0.8275862068962695 0.6724137931034483 0 +325 0.8275862068962604 0.6896551724137931 0 +326 0.8275862068962513 0.7068965517241379 0 +327 0.8275862068962422 0.7241379310344828 0 +328 0.8275862068962331 0.7413793103448276 0 +329 0.8275862068962242 0.7586206896551724 0 +330 0.8275862068962151 0.7758620689655172 0 +331 0.827586206896206 0.7931034482758621 0 +332 0.8275862068961971 0.8103448275862069 0 +333 0.8275862068961878 0.8275862068965517 0 +334 0.8275862068961786 0.8448275862068966 0 +335 0.8275862068961696 0.8620689655172413 0 +336 0.8275862068961608 0.8793103448275863 0 +337 0.8275862068961514 0.896551724137931 0 +338 0.8275862068961425 0.9137931034482758 0 +339 0.8275862068961332 0.9310344827586206 0 +340 0.8275862068961243 0.9482758620689655 0 +341 0.8275862068961152 0.9655172413793103 0 +342 0.8275862068961061 0.9827586206896551 0 +343 0.7931034482758895 0.5172413793103449 0 +344 0.7931034482758691 0.5344827586206896 0 +345 0.7931034482758487 0.5517241379310345 0 +346 0.793103448275828 0.5689655172413793 0 +347 0.7931034482758076 0.5862068965517242 0 +348 0.793103448275787 0.603448275862069 0 +349 0.7931034482757664 0.6206896551724138 0 +350 0.7931034482757463 0.6379310344827587 0 +351 0.7931034482757257 0.6551724137931034 0 +352 0.7931034482757051 0.6724137931034483 0 +353 0.7931034482756848 0.6896551724137931 0 +354 0.7931034482756641 0.7068965517241379 0 +355 0.7931034482756437 0.7241379310344825 0 +356 0.7931034482756235 0.7413793103448276 0 +357 0.7931034482756029 0.7586206896551724 0 +358 0.7931034482755824 0.7758620689655172 0 +359 0.793103448275562 0.7931034482758621 0 +360 0.7931034482755414 0.8103448275862069 0 +361 0.7931034482755213 0.8275862068965517 0 +362 0.7931034482755005 0.8448275862068966 0 +363 0.7931034482754803 0.8620689655172413 0 +364 0.7931034482754593 0.8793103448275861 0 +365 0.7931034482754391 0.896551724137931 0 +366 0.7931034482754186 0.9137931034482758 0 +367 0.7931034482753981 0.9310344827586207 0 +368 0.7931034482753777 0.9482758620689655 0 +369 0.7931034482753573 0.9655172413793103 0 +370 0.7931034482753369 0.9827586206896551 0 +371 0.7586206896554276 0.5172413793103449 0 +372 0.7586206896553959 0.5344827586206896 0 +373 0.7586206896553641 0.5517241379310345 0 +374 0.7586206896553321 0.5689655172413793 0 +375 0.7586206896553005 0.5862068965517242 0 +376 0.7586206896552685 0.603448275862069 0 +377 0.7586206896552367 0.6206896551724138 0 +378 0.7586206896552047 0.6379310344827587 0 +379 0.7586206896551729 0.6551724137931034 0 +380 0.758620689655141 0.6724137931034483 0 +381 0.758620689655109 0.6896551724137931 0 +382 0.7586206896550772 0.7068965517241379 0 +383 0.7586206896550455 0.7241379310344828 0 +384 0.7586206896550137 0.7413793103448276 0 +385 0.7586206896549818 0.7586206896551724 0 +386 0.75862068965495 0.7758620689655172 0 +387 0.758620689654918 0.7931034482758621 0 +388 0.758620689654886 0.8103448275862069 0 +389 0.7586206896548543 0.8275862068965517 0 +390 0.7586206896548225 0.8448275862068966 0 +391 0.7586206896547906 0.8620689655172413 0 +392 0.7586206896547586 0.8793103448275862 0 +393 0.7586206896547272 0.896551724137931 0 +394 0.7586206896546952 0.9137931034482758 0 +395 0.7586206896546631 0.9310344827586207 0 +396 0.7586206896546311 0.9482758620689655 0 +397 0.7586206896545996 0.9655172413793103 0 +398 0.7586206896545676 0.9827586206896552 0 +399 0.7241379310349658 0.5172413793103449 0 +400 0.7241379310349225 0.5344827586206896 0 +401 0.7241379310348792 0.5517241379310345 0 +402 0.7241379310348361 0.5689655172413793 0 +403 0.7241379310347928 0.5862068965517242 0 +404 0.7241379310347495 0.603448275862069 0 +405 0.7241379310347063 0.6206896551724138 0 +406 0.7241379310346632 0.6379310344827587 0 +407 0.7241379310346199 0.6551724137931034 0 +408 0.7241379310345768 0.6724137931034483 0 +409 0.7241379310345335 0.6896551724137931 0 +410 0.7241379310344904 0.7068965517241379 0 +411 0.7241379310344469 0.7241379310344828 0 +412 0.7241379310344038 0.7413793103448276 0 +413 0.7241379310343605 0.7586206896551724 0 +414 0.7241379310343172 0.7758620689655173 0 +415 0.7241379310342742 0.7931034482758621 0 +416 0.7241379310342306 0.8103448275862069 0 +417 0.7241379310341876 0.8275862068965517 0 +418 0.7241379310341443 0.8448275862068966 0 +419 0.724137931034101 0.8620689655172413 0 +420 0.7241379310340579 0.8793103448275862 0 +421 0.7241379310340144 0.896551724137931 0 +422 0.7241379310339713 0.9137931034482758 0 +423 0.7241379310339282 0.9310344827586208 0 +424 0.7241379310338847 0.9482758620689655 0 +425 0.7241379310338416 0.9655172413793103 0 +426 0.7241379310337983 0.9827586206896551 0 +427 0.6896551724145039 0.5172413793103449 0 +428 0.6896551724144495 0.5344827586206896 0 +429 0.6896551724143949 0.5517241379310345 0 +430 0.6896551724143403 0.5689655172413793 0 +431 0.6896551724142856 0.5862068965517242 0 +432 0.6896551724142308 0.603448275862069 0 +433 0.6896551724141764 0.6206896551724138 0 +434 0.6896551724141218 0.6379310344827587 0 +435 0.6896551724140672 0.6551724137931034 0 +436 0.6896551724140125 0.6724137931034483 0 +437 0.6896551724139579 0.6896551724137931 0 +438 0.6896551724139031 0.7068965517241379 0 +439 0.6896551724138487 0.7241379310344827 0 +440 0.6896551724137938 0.7413793103448276 0 +441 0.6896551724137394 0.7586206896551724 0 +442 0.6896551724136846 0.7758620689655173 0 +443 0.6896551724136302 0.7931034482758621 0 +444 0.6896551724135755 0.8103448275862069 0 +445 0.6896551724135207 0.8275862068965517 0 +446 0.6896551724134661 0.8448275862068966 0 +447 0.6896551724134115 0.8620689655172413 0 +448 0.6896551724133571 0.8793103448275863 0 +449 0.6896551724133024 0.896551724137931 0 +450 0.6896551724132476 0.9137931034482758 0 +451 0.689655172413193 0.9310344827586206 0 +452 0.6896551724131383 0.9482758620689655 0 +453 0.6896551724130837 0.9655172413793103 0 +454 0.6896551724130291 0.9827586206896551 0 +455 0.655172413794042 0.5172413793103449 0 +456 0.6551724137939761 0.5344827586206896 0 +457 0.6551724137939101 0.5517241379310345 0 +458 0.6551724137938442 0.5689655172413793 0 +459 0.6551724137937782 0.5862068965517242 0 +460 0.6551724137937123 0.603448275862069 0 +461 0.6551724137936461 0.6206896551724138 0 +462 0.6551724137935802 0.6379310344827587 0 +463 0.655172413793514 0.6551724137931034 0 +464 0.655172413793448 0.6724137931034483 0 +465 0.6551724137933821 0.6896551724137931 0 +466 0.6551724137933161 0.7068965517241379 0 +467 0.6551724137932502 0.7241379310344828 0 +468 0.655172413793184 0.7413793103448276 0 +469 0.6551724137931181 0.7586206896551724 0 +470 0.6551724137930521 0.7758620689655172 0 +471 0.655172413792986 0.7931034482758621 0 +472 0.65517241379292 0.8103448275862069 0 +473 0.6551724137928541 0.8275862068965515 0 +474 0.6551724137927881 0.8448275862068966 0 +475 0.6551724137927222 0.8620689655172413 0 +476 0.655172413792656 0.8793103448275862 0 +477 0.6551724137925898 0.896551724137931 0 +478 0.6551724137925241 0.9137931034482758 0 +479 0.6551724137924579 0.9310344827586208 0 +480 0.6551724137923918 0.9482758620689655 0 +481 0.655172413792326 0.9655172413793103 0 +482 0.6551724137922599 0.9827586206896552 0 +483 0.6206896551735805 0.5172413793103449 0 +484 0.6206896551735028 0.5344827586206896 0 +485 0.6206896551734256 0.5517241379310345 0 +486 0.6206896551733481 0.5689655172413793 0 +487 0.6206896551732708 0.5862068965517242 0 +488 0.6206896551731935 0.603448275862069 0 +489 0.6206896551731158 0.6206896551724138 0 +490 0.6206896551730385 0.6379310344827587 0 +491 0.6206896551729613 0.6551724137931034 0 +492 0.6206896551728838 0.6724137931034483 0 +493 0.6206896551728065 0.6896551724137931 0 +494 0.620689655172729 0.7068965517241379 0 +495 0.6206896551726515 0.7241379310344827 0 +496 0.6206896551725742 0.7413793103448276 0 +497 0.620689655172497 0.7586206896551724 0 +498 0.6206896551724195 0.7758620689655173 0 +499 0.620689655172342 0.7931034482758621 0 +500 0.6206896551722647 0.8103448275862069 0 +501 0.6206896551721872 0.8275862068965517 0 +502 0.6206896551721099 0.8448275862068966 0 +503 0.6206896551720325 0.8620689655172413 0 +504 0.6206896551719552 0.8793103448275862 0 +505 0.6206896551718775 0.896551724137931 0 +506 0.6206896551718002 0.9137931034482758 0 +507 0.6206896551717229 0.9310344827586203 0 +508 0.6206896551716454 0.9482758620689655 0 +509 0.6206896551715679 0.9655172413793103 0 +510 0.6206896551714907 0.9827586206896551 0 +511 0.5862068965531184 0.5172413793103449 0 +512 0.5862068965530298 0.5344827586206896 0 +513 0.5862068965529408 0.5517241379310345 0 +514 0.5862068965528522 0.5689655172413793 0 +515 0.5862068965527634 0.5862068965517242 0 +516 0.5862068965526746 0.603448275862069 0 +517 0.586206896552586 0.6206896551724138 0 +518 0.5862068965524971 0.6379310344827587 0 +519 0.5862068965524083 0.6551724137931034 0 +520 0.5862068965523195 0.6724137931034483 0 +521 0.5862068965522307 0.6896551724137931 0 +522 0.5862068965521421 0.7068965517241379 0 +523 0.586206896552053 0.7241379310344828 0 +524 0.5862068965519645 0.7413793103448276 0 +525 0.5862068965518756 0.7586206896551724 0 +526 0.5862068965517868 0.7758620689655172 0 +527 0.5862068965516982 0.7931034482758621 0 +528 0.5862068965516094 0.8103448275862069 0 +529 0.5862068965515206 0.8275862068965517 0 +530 0.5862068965514318 0.8448275862068966 0 +531 0.5862068965513429 0.8620689655172413 0 +532 0.5862068965512541 0.879310344827586 0 +533 0.5862068965511653 0.896551724137931 0 +534 0.5862068965510767 0.9137931034482758 0 +535 0.5862068965509879 0.9310344827586207 0 +536 0.5862068965508991 0.9482758620689655 0 +537 0.5862068965508105 0.9655172413793103 0 +538 0.5862068965507217 0.9827586206896551 0 +539 0.551724137932657 0.5172413793103449 0 +540 0.5517241379325566 0.5344827586206896 0 +541 0.5517241379324562 0.5517241379310345 0 +542 0.5517241379323563 0.5689655172413793 0 +543 0.5517241379322562 0.5862068965517242 0 +544 0.551724137932156 0.603448275862069 0 +545 0.5517241379320557 0.6206896551724138 0 +546 0.5517241379319555 0.6379310344827587 0 +547 0.5517241379318554 0.6551724137931034 0 +548 0.5517241379317552 0.6724137931034483 0 +549 0.5517241379316551 0.6896551724137931 0 +550 0.5517241379315549 0.7068965517241379 0 +551 0.5517241379314548 0.7241379310344828 0 +552 0.5517241379313544 0.7413793103448276 0 +553 0.5517241379312545 0.7586206896551724 0 +554 0.5517241379311542 0.7758620689655172 0 +555 0.551724137931054 0.7931034482758621 0 +556 0.5517241379309539 0.8103448275862069 0 +557 0.5517241379308537 0.8275862068965517 0 +558 0.5517241379307536 0.8448275862068966 0 +559 0.5517241379306534 0.8620689655172413 0 +560 0.5517241379305533 0.8793103448275862 0 +561 0.5517241379304529 0.896551724137931 0 +562 0.551724137930353 0.9137931034482758 0 +563 0.5517241379302527 0.9310344827586207 0 +564 0.5517241379301525 0.9482758620689655 0 +565 0.5517241379300524 0.9655172413793103 0 +566 0.5517241379299522 0.9827586206896548 0 +567 0.5172413793121949 0.5172413793103449 0 +568 0.5172413793120832 0.5344827586206896 0 +569 0.5172413793119718 0.5517241379310345 0 +570 0.5172413793118601 0.5689655172413793 0 +571 0.5172413793117486 0.5862068965517242 0 +572 0.5172413793116372 0.603448275862069 0 +573 0.5172413793115257 0.6206896551724138 0 +574 0.517241379311414 0.6379310344827587 0 +575 0.5172413793113023 0.6551724137931034 0 +576 0.5172413793111909 0.6724137931034483 0 +577 0.5172413793110794 0.6896551724137931 0 +578 0.5172413793109677 0.7068965517241379 0 +579 0.5172413793108562 0.7241379310344828 0 +580 0.5172413793107448 0.7413793103448276 0 +581 0.5172413793106331 0.7586206896551724 0 +582 0.5172413793105216 0.7758620689655172 0 +583 0.5172413793104101 0.7931034482758621 0 +584 0.5172413793102985 0.8103448275862069 0 +585 0.517241379310187 0.8275862068965517 0 +586 0.5172413793100753 0.8448275862068966 0 +587 0.5172413793099638 0.8620689655172413 0 +588 0.5172413793098524 0.8793103448275862 0 +589 0.5172413793097407 0.896551724137931 0 +590 0.5172413793096292 0.9137931034482758 0 +591 0.5172413793095177 0.9310344827586207 0 +592 0.5172413793094061 0.9482758620689655 0 +593 0.5172413793092946 0.9655172413793103 0 +594 0.5172413793091829 0.9827586206896551 0 +595 0.4827586206915514 0.5172413793103449 0 +596 0.4827586206914384 0.5344827586206896 0 +597 0.4827586206913255 0.5517241379310345 0 +598 0.4827586206912124 0.5689655172413793 0 +599 0.4827586206910993 0.5862068965517242 0 +600 0.4827586206909863 0.603448275862069 0 +601 0.4827586206908734 0.6206896551724138 0 +602 0.4827586206907604 0.6379310344827587 0 +603 0.4827586206906473 0.6551724137931034 0 +604 0.4827586206905342 0.6724137931034483 0 +605 0.4827586206904213 0.6896551724137931 0 +606 0.4827586206903082 0.7068965517241379 0 +607 0.4827586206901953 0.7241379310344829 0 +608 0.4827586206900821 0.7413793103448276 0 +609 0.4827586206899691 0.7586206896551724 0 +610 0.482758620689856 0.7758620689655171 0 +611 0.4827586206897431 0.7931034482758621 0 +612 0.48275862068963 0.8103448275862069 0 +613 0.4827586206895171 0.8275862068965517 0 +614 0.4827586206894039 0.8448275862068966 0 +615 0.4827586206892909 0.8620689655172413 0 +616 0.482758620689178 0.8793103448275862 0 +617 0.4827586206890649 0.896551724137931 0 +618 0.4827586206889518 0.9137931034482758 0 +619 0.4827586206888388 0.9310344827586207 0 +620 0.4827586206887259 0.9482758620689655 0 +621 0.4827586206886127 0.9655172413793103 0 +622 0.4827586206884997 0.9827586206896552 0 +623 0.4482758620707268 0.5172413793103449 0 +624 0.4482758620706222 0.5344827586206896 0 +625 0.4482758620705176 0.5517241379310345 0 +626 0.4482758620704128 0.5689655172413793 0 +627 0.4482758620703083 0.5862068965517242 0 +628 0.4482758620702038 0.603448275862069 0 +629 0.4482758620700991 0.6206896551724137 0 +630 0.4482758620699946 0.6379310344827587 0 +631 0.4482758620698899 0.6551724137931034 0 +632 0.4482758620697852 0.6724137931034483 0 +633 0.4482758620696807 0.6896551724137931 0 +634 0.448275862069576 0.7068965517241379 0 +635 0.4482758620694715 0.7241379310344828 0 +636 0.4482758620693668 0.7413793103448276 0 +637 0.4482758620692622 0.7586206896551724 0 +638 0.4482758620691576 0.7758620689655172 0 +639 0.448275862069053 0.7931034482758621 0 +640 0.4482758620689484 0.8103448275862069 0 +641 0.4482758620688438 0.8275862068965518 0 +642 0.4482758620687393 0.8448275862068966 0 +643 0.4482758620686345 0.8620689655172413 0 +644 0.44827586206853 0.8793103448275863 0 +645 0.4482758620684253 0.896551724137931 0 +646 0.4482758620683207 0.9137931034482758 0 +647 0.4482758620682161 0.9310344827586208 0 +648 0.4482758620681115 0.9482758620689655 0 +649 0.448275862068007 0.9655172413793103 0 +650 0.4482758620679023 0.9827586206896551 0 +651 0.4137931034499019 0.5172413793103449 0 +652 0.4137931034498058 0.5344827586206896 0 +653 0.4137931034497095 0.5517241379310345 0 +654 0.4137931034496135 0.5689655172413793 0 +655 0.4137931034495173 0.5862068965517242 0 +656 0.4137931034494211 0.603448275862069 0 +657 0.4137931034493249 0.6206896551724138 0 +658 0.4137931034492287 0.6379310344827587 0 +659 0.4137931034491324 0.6551724137931034 0 +660 0.4137931034490363 0.6724137931034482 0 +661 0.4137931034489402 0.6896551724137931 0 +662 0.413793103448844 0.7068965517241379 0 +663 0.4137931034487478 0.7241379310344828 0 +664 0.4137931034486515 0.7413793103448276 0 +665 0.4137931034485554 0.7586206896551724 0 +666 0.4137931034484592 0.7758620689655172 0 +667 0.413793103448363 0.7931034482758621 0 +668 0.4137931034482667 0.8103448275862069 0 +669 0.4137931034481707 0.8275862068965518 0 +670 0.4137931034480744 0.8448275862068966 0 +671 0.4137931034479783 0.8620689655172413 0 +672 0.4137931034478821 0.8793103448275862 0 +673 0.4137931034477857 0.896551724137931 0 +674 0.4137931034476896 0.9137931034482758 0 +675 0.4137931034475935 0.9310344827586208 0 +676 0.4137931034474973 0.9482758620689655 0 +677 0.4137931034474011 0.9655172413793103 0 +678 0.4137931034473049 0.9827586206896549 0 +679 0.3793103448290773 0.5172413793103449 0 +680 0.3793103448289895 0.5344827586206896 0 +681 0.3793103448289017 0.5517241379310345 0 +682 0.3793103448288139 0.5689655172413792 0 +683 0.3793103448287262 0.5862068965517242 0 +684 0.3793103448286385 0.603448275862069 0 +685 0.3793103448285507 0.6206896551724139 0 +686 0.3793103448284629 0.6379310344827587 0 +687 0.3793103448283751 0.6551724137931034 0 +688 0.3793103448282873 0.6724137931034482 0 +689 0.3793103448281996 0.6896551724137931 0 +690 0.3793103448281118 0.7068965517241379 0 +691 0.3793103448280241 0.7241379310344829 0 +692 0.3793103448279362 0.7413793103448276 0 +693 0.3793103448278485 0.7586206896551724 0 +694 0.3793103448277607 0.7758620689655171 0 +695 0.379310344827673 0.7931034482758621 0 +696 0.3793103448275852 0.8103448275862069 0 +697 0.3793103448274975 0.8275862068965518 0 +698 0.3793103448274097 0.8448275862068966 0 +699 0.3793103448273218 0.8620689655172413 0 +700 0.3793103448272341 0.8793103448275859 0 +701 0.3793103448271464 0.896551724137931 0 +702 0.3793103448270585 0.9137931034482758 0 +703 0.3793103448269708 0.9310344827586206 0 +704 0.3793103448268831 0.9482758620689655 0 +705 0.3793103448267953 0.9655172413793103 0 +706 0.3793103448267074 0.9827586206896548 0 +707 0.3448275862082525 0.5172413793103449 0 +708 0.3448275862081731 0.5344827586206896 0 +709 0.3448275862080937 0.5517241379310345 0 +710 0.3448275862080145 0.5689655172413793 0 +711 0.344827586207935 0.5862068965517242 0 +712 0.3448275862078557 0.603448275862069 0 +713 0.3448275862077763 0.6206896551724138 0 +714 0.3448275862076969 0.6379310344827587 0 +715 0.3448275862076176 0.6551724137931034 0 +716 0.3448275862075383 0.6724137931034483 0 +717 0.3448275862074589 0.6896551724137931 0 +718 0.3448275862073796 0.7068965517241379 0 +719 0.3448275862073003 0.7241379310344828 0 +720 0.3448275862072209 0.7413793103448276 0 +721 0.3448275862071416 0.7586206896551725 0 +722 0.3448275862070621 0.7758620689655171 0 +723 0.3448275862069828 0.7931034482758621 0 +724 0.3448275862069035 0.8103448275862069 0 +725 0.3448275862068241 0.8275862068965517 0 +726 0.3448275862067448 0.8448275862068966 0 +727 0.3448275862066654 0.8620689655172413 0 +728 0.344827586206586 0.879310344827586 0 +729 0.3448275862065068 0.896551724137931 0 +730 0.3448275862064274 0.9137931034482758 0 +731 0.344827586206348 0.9310344827586203 0 +732 0.3448275862062687 0.9482758620689655 0 +733 0.3448275862061894 0.9655172413793103 0 +734 0.34482758620611 0.9827586206896552 0 +735 0.3103448275874277 0.5172413793103449 0 +736 0.3103448275873567 0.5344827586206896 0 +737 0.3103448275872858 0.5517241379310345 0 +738 0.3103448275872148 0.5689655172413793 0 +739 0.310344827587144 0.5862068965517242 0 +740 0.310344827587073 0.603448275862069 0 +741 0.310344827587002 0.6206896551724138 0 +742 0.3103448275869312 0.6379310344827587 0 +743 0.3103448275868602 0.6551724137931034 0 +744 0.3103448275867893 0.6724137931034483 0 +745 0.3103448275867184 0.6896551724137931 0 +746 0.3103448275866475 0.7068965517241379 0 +747 0.3103448275865764 0.7241379310344828 0 +748 0.3103448275865056 0.7413793103448276 0 +749 0.3103448275864347 0.7586206896551724 0 +750 0.3103448275863637 0.7758620689655173 0 +751 0.3103448275862928 0.7931034482758621 0 +752 0.3103448275862218 0.8103448275862069 0 +753 0.310344827586151 0.8275862068965517 0 +754 0.3103448275860801 0.8448275862068966 0 +755 0.3103448275860091 0.8620689655172413 0 +756 0.3103448275859382 0.8793103448275863 0 +757 0.3103448275858672 0.896551724137931 0 +758 0.3103448275857964 0.9137931034482758 0 +759 0.3103448275857253 0.9310344827586206 0 +760 0.3103448275856545 0.9482758620689655 0 +761 0.3103448275855835 0.9655172413793103 0 +762 0.3103448275855126 0.9827586206896551 0 +763 0.275862068966603 0.5172413793103449 0 +764 0.2758620689665405 0.5344827586206896 0 +765 0.275862068966478 0.5517241379310345 0 +766 0.2758620689664155 0.5689655172413793 0 +767 0.275862068966353 0.5862068965517242 0 +768 0.2758620689662905 0.603448275862069 0 +769 0.275862068966228 0.6206896551724138 0 +770 0.2758620689661655 0.6379310344827587 0 +771 0.2758620689661029 0.6551724137931035 0 +772 0.2758620689660405 0.6724137931034483 0 +773 0.275862068965978 0.6896551724137931 0 +774 0.2758620689659154 0.7068965517241379 0 +775 0.2758620689658529 0.7241379310344829 0 +776 0.2758620689657905 0.7413793103448276 0 +777 0.2758620689657278 0.7586206896551724 0 +778 0.2758620689656653 0.7758620689655171 0 +779 0.2758620689656028 0.7931034482758621 0 +780 0.2758620689655403 0.8103448275862069 0 +781 0.2758620689654778 0.8275862068965517 0 +782 0.2758620689654153 0.8448275862068966 0 +783 0.2758620689653528 0.8620689655172413 0 +784 0.2758620689652903 0.8793103448275862 0 +785 0.2758620689652278 0.896551724137931 0 +786 0.2758620689651653 0.9137931034482758 0 +787 0.2758620689651028 0.9310344827586207 0 +788 0.2758620689650402 0.9482758620689655 0 +789 0.2758620689649778 0.9655172413793103 0 +790 0.2758620689649152 0.9827586206896551 0 +791 0.2413793103457783 0.5172413793103449 0 +792 0.2413793103457242 0.5344827586206896 0 +793 0.2413793103456701 0.5517241379310344 0 +794 0.241379310345616 0.5689655172413793 0 +795 0.2413793103455619 0.5862068965517242 0 +796 0.2413793103455079 0.603448275862069 0 +797 0.2413793103454537 0.6206896551724138 0 +798 0.2413793103453997 0.6379310344827587 0 +799 0.2413793103453455 0.6551724137931034 0 +800 0.2413793103452915 0.6724137931034481 0 +801 0.2413793103452374 0.6896551724137931 0 +802 0.2413793103451833 0.7068965517241379 0 +803 0.2413793103451292 0.7241379310344827 0 +804 0.2413793103450751 0.7413793103448277 0 +805 0.241379310345021 0.7586206896551723 0 +806 0.241379310344967 0.7758620689655173 0 +807 0.2413793103449128 0.7931034482758621 0 +808 0.2413793103448588 0.8103448275862069 0 +809 0.2413793103448046 0.8275862068965517 0 +810 0.2413793103447506 0.8448275862068966 0 +811 0.2413793103446965 0.8620689655172413 0 +812 0.2413793103446423 0.8793103448275862 0 +813 0.2413793103445883 0.896551724137931 0 +814 0.2413793103445342 0.9137931034482758 0 +815 0.2413793103444801 0.9310344827586207 0 +816 0.241379310344426 0.9482758620689655 0 +817 0.2413793103443719 0.9655172413793103 0 +818 0.2413793103443178 0.9827586206896551 0 +819 0.2068965517249534 0.5172413793103449 0 +820 0.2068965517249077 0.5344827586206896 0 +821 0.2068965517248621 0.5517241379310345 0 +822 0.2068965517248165 0.5689655172413793 0 +823 0.2068965517247708 0.5862068965517241 0 +824 0.2068965517247251 0.603448275862069 0 +825 0.2068965517246794 0.6206896551724138 0 +826 0.2068965517246337 0.6379310344827587 0 +827 0.2068965517245881 0.6551724137931035 0 +828 0.2068965517245424 0.6724137931034483 0 +829 0.2068965517244968 0.6896551724137931 0 +830 0.2068965517244511 0.7068965517241379 0 +831 0.2068965517244054 0.7241379310344828 0 +832 0.2068965517243597 0.7413793103448276 0 +833 0.2068965517243141 0.7586206896551724 0 +834 0.2068965517242684 0.7758620689655173 0 +835 0.2068965517242227 0.7931034482758621 0 +836 0.206896551724177 0.8103448275862069 0 +837 0.2068965517241315 0.8275862068965515 0 +838 0.2068965517240857 0.8448275862068966 0 +839 0.2068965517240401 0.8620689655172413 0 +840 0.2068965517239944 0.8793103448275862 0 +841 0.2068965517239487 0.896551724137931 0 +842 0.206896551723903 0.9137931034482758 0 +843 0.2068965517238574 0.9310344827586207 0 +844 0.2068965517238117 0.9482758620689655 0 +845 0.2068965517237661 0.9655172413793103 0 +846 0.2068965517237204 0.9827586206896552 0 +847 0.1724137931041287 0.5172413793103449 0 +848 0.1724137931040914 0.5344827586206896 0 +849 0.1724137931040542 0.5517241379310345 0 +850 0.172413793104017 0.5689655172413793 0 +851 0.1724137931039797 0.5862068965517242 0 +852 0.1724137931039424 0.603448275862069 0 +853 0.1724137931039052 0.6206896551724137 0 +854 0.1724137931038679 0.6379310344827587 0 +855 0.1724137931038307 0.6551724137931034 0 +856 0.1724137931037934 0.6724137931034483 0 +857 0.1724137931037562 0.6896551724137931 0 +858 0.1724137931037189 0.7068965517241378 0 +859 0.1724137931036817 0.7241379310344828 0 +860 0.1724137931036445 0.7413793103448276 0 +861 0.1724137931036072 0.7586206896551724 0 +862 0.17241379310357 0.7758620689655172 0 +863 0.1724137931035327 0.7931034482758621 0 +864 0.1724137931034955 0.8103448275862069 0 +865 0.1724137931034582 0.8275862068965517 0 +866 0.1724137931034209 0.8448275862068966 0 +867 0.1724137931033837 0.8620689655172413 0 +868 0.1724137931033464 0.8793103448275861 0 +869 0.1724137931033092 0.896551724137931 0 +870 0.1724137931032719 0.9137931034482758 0 +871 0.1724137931032347 0.9310344827586207 0 +872 0.1724137931031974 0.9482758620689655 0 +873 0.1724137931031602 0.9655172413793103 0 +874 0.1724137931031229 0.9827586206896551 0 +875 0.137931034483304 0.5172413793103449 0 +876 0.1379310344832752 0.5344827586206896 0 +877 0.1379310344832463 0.5517241379310345 0 +878 0.1379310344832175 0.5689655172413792 0 +879 0.1379310344831886 0.5862068965517242 0 +880 0.1379310344831598 0.603448275862069 0 +881 0.137931034483131 0.6206896551724136 0 +882 0.1379310344831021 0.6379310344827587 0 +883 0.1379310344830733 0.6551724137931034 0 +884 0.1379310344830445 0.6724137931034483 0 +885 0.1379310344830156 0.6896551724137931 0 +886 0.1379310344829868 0.7068965517241379 0 +887 0.137931034482958 0.7241379310344828 0 +888 0.1379310344829292 0.7413793103448276 0 +889 0.1379310344829003 0.7586206896551724 0 +890 0.1379310344828715 0.7758620689655172 0 +891 0.1379310344828427 0.7931034482758621 0 +892 0.1379310344828139 0.8103448275862069 0 +893 0.137931034482785 0.8275862068965517 0 +894 0.1379310344827562 0.8448275862068966 0 +895 0.1379310344827274 0.8620689655172413 0 +896 0.1379310344826985 0.8793103448275862 0 +897 0.1379310344826697 0.896551724137931 0 +898 0.1379310344826409 0.9137931034482758 0 +899 0.137931034482612 0.9310344827586206 0 +900 0.1379310344825832 0.9482758620689655 0 +901 0.1379310344825544 0.9655172413793103 0 +902 0.1379310344825255 0.9827586206896549 0 +903 0.1034482758624782 0.5172413793103449 0 +904 0.1034482758624567 0.5344827586206896 0 +905 0.1034482758624353 0.5517241379310345 0 +906 0.1034482758624139 0.5689655172413793 0 +907 0.1034482758623924 0.5862068965517243 0 +908 0.103448275862371 0.603448275862069 0 +909 0.1034482758623495 0.6206896551724138 0 +910 0.1034482758623281 0.6379310344827587 0 +911 0.1034482758623066 0.6551724137931034 0 +912 0.1034482758622852 0.6724137931034483 0 +913 0.1034482758622638 0.6896551724137933 0 +914 0.1034482758622423 0.7068965517241379 0 +915 0.1034482758622209 0.7241379310344829 0 +916 0.1034482758621994 0.7413793103448276 0 +917 0.103448275862178 0.7586206896551724 0 +918 0.1034482758621565 0.7758620689655173 0 +919 0.1034482758621351 0.7931034482758621 0 +920 0.1034482758621137 0.8103448275862069 0 +921 0.1034482758620922 0.8275862068965517 0 +922 0.1034482758620708 0.8448275862068966 0 +923 0.1034482758620494 0.8620689655172413 0 +924 0.1034482758620279 0.8793103448275862 0 +925 0.1034482758620065 0.896551724137931 0 +926 0.103448275861985 0.9137931034482758 0 +927 0.1034482758619636 0.9310344827586207 0 +928 0.1034482758619422 0.9482758620689655 0 +929 0.1034482758619207 0.9655172413793103 0 +930 0.1034482758618993 0.9827586206896551 0 +931 0.06896551724165167 0.5172413793103449 0 +932 0.06896551724163702 0.5344827586206896 0 +933 0.06896551724162234 0.5517241379310345 0 +934 0.06896551724160768 0.5689655172413793 0 +935 0.06896551724159306 0.5862068965517242 0 +936 0.06896551724157837 0.603448275862069 0 +937 0.06896551724156372 0.6206896551724138 0 +938 0.06896551724154906 0.6379310344827588 0 +939 0.06896551724153438 0.6551724137931034 0 +940 0.06896551724151972 0.6724137931034483 0 +941 0.06896551724150507 0.689655172413793 0 +942 0.06896551724149041 0.7068965517241379 0 +943 0.06896551724147576 0.7241379310344828 0 +944 0.06896551724146111 0.7413793103448276 0 +945 0.06896551724144642 0.7586206896551724 0 +946 0.0689655172414318 0.7758620689655172 0 +947 0.06896551724141714 0.7931034482758621 0 +948 0.06896551724140246 0.8103448275862069 0 +949 0.0689655172413878 0.8275862068965517 0 +950 0.06896551724137315 0.8448275862068966 0 +951 0.06896551724135849 0.8620689655172413 0 +952 0.06896551724134381 0.8793103448275862 0 +953 0.06896551724132916 0.896551724137931 0 +954 0.0689655172413145 0.9137931034482758 0 +955 0.06896551724129985 0.9310344827586207 0 +956 0.06896551724128519 0.9482758620689655 0 +957 0.06896551724127054 0.9655172413793103 0 +958 0.06896551724125588 0.9827586206896552 0 +959 0.03448275862082603 0.5172413793103449 0 +960 0.03448275862081879 0.5344827586206897 0 +961 0.03448275862081154 0.5517241379310345 0 +962 0.0344827586208043 0.5689655172413793 0 +963 0.03448275862079705 0.5862068965517242 0 +964 0.03448275862078981 0.6034482758620691 0 +965 0.03448275862078257 0.6206896551724138 0 +966 0.03448275862077532 0.6379310344827587 0 +967 0.03448275862076808 0.6551724137931034 0 +968 0.03448275862076083 0.6724137931034484 0 +969 0.03448275862075359 0.689655172413793 0 +970 0.03448275862074635 0.7068965517241379 0 +971 0.0344827586207391 0.7241379310344828 0 +972 0.03448275862073186 0.7413793103448277 0 +973 0.03448275862072461 0.7586206896551724 0 +974 0.03448275862071737 0.7758620689655172 0 +975 0.03448275862071012 0.7931034482758621 0 +976 0.03448275862070288 0.8103448275862069 0 +977 0.03448275862069564 0.8275862068965517 0 +978 0.03448275862068839 0.8448275862068966 0 +979 0.03448275862068115 0.8620689655172413 0 +980 0.0344827586206739 0.8793103448275862 0 +981 0.03448275862066666 0.896551724137931 0 +982 0.03448275862065941 0.9137931034482758 0 +983 0.03448275862065217 0.9310344827586204 0 +984 0.03448275862064493 0.9482758620689655 0 +985 0.03448275862063768 0.9655172413793103 0 +986 0.03448275862063044 0.9827586206896551 0 +987 0.03448275862082603 0.4827586206895844 0 +988 0.06896551724165169 0.4827586206895851 0 +989 0.1034482758624782 0.482758620689586 0 +990 0.137931034483304 0.482758620689587 0 +991 0.1724137931041287 0.4827586206895879 0 +992 0.2068965517249534 0.4827586206895887 0 +993 0.2413793103457783 0.4827586206895896 0 +994 0.275862068966603 0.4827586206895906 0 +995 0.3103448275874277 0.4827586206895916 0 +996 0.3448275862082524 0.4827586206895924 0 +997 0.3793103448290773 0.4827586206895934 0 +998 0.413793103449902 0.4827586206895942 0 +999 0.4482758620707268 0.4827586206895953 0 +1000 0.4827586206915515 0.4827586206895961 0 +1001 0.5172413793121949 0.482758620689597 0 +1002 0.5517241379326567 0.482758620689598 0 +1003 0.5862068965531185 0.4827586206895988 0 +1004 0.6206896551735804 0.4827586206895997 0 +1005 0.6551724137940422 0.4827586206896006 0 +1006 0.6896551724145041 0.4827586206896015 0 +1007 0.7241379310349659 0.4827586206896025 0 +1008 0.7586206896554277 0.4827586206896035 0 +1009 0.7931034482758896 0.4827586206896043 0 +1010 0.8275862068963512 0.4827586206896053 0 +1011 0.862068965516813 0.482758620689606 0 +1012 0.8965517241375058 0.4827586206896071 0 +1013 0.9310344827583373 0.4827586206896079 0 +1014 0.9655172413791686 0.4827586206896088 0 +1015 0.03448275862081879 0.4655172413791686 0 +1016 0.06896551724163701 0.4655172413791704 0 +1017 0.1034482758624567 0.4655172413791723 0 +1018 0.1379310344832751 0.4655172413791741 0 +1019 0.1724137931040914 0.4655172413791759 0 +1020 0.2068965517249077 0.4655172413791777 0 +1021 0.2413793103457242 0.4655172413791795 0 +1022 0.2758620689665406 0.4655172413791814 0 +1023 0.3103448275873567 0.4655172413791832 0 +1024 0.3448275862081731 0.465517241379185 0 +1025 0.3793103448289895 0.4655172413791866 0 +1026 0.4137931034498059 0.4655172413791885 0 +1027 0.4482758620706221 0.4655172413791905 0 +1028 0.4827586206914384 0.4655172413791921 0 +1029 0.5172413793120835 0.465517241379194 0 +1030 0.5517241379325566 0.4655172413791958 0 +1031 0.5862068965530297 0.4655172413791976 0 +1032 0.6206896551735029 0.4655172413791996 0 +1033 0.6551724137939761 0.4655172413792014 0 +1034 0.6896551724144493 0.465517241379203 0 +1035 0.7241379310349226 0.4655172413792048 0 +1036 0.758620689655396 0.4655172413792066 0 +1037 0.793103448275869 0.4655172413792086 0 +1038 0.8275862068963421 0.4655172413792104 0 +1039 0.8620689655168152 0.4655172413792122 0 +1040 0.8965517241375112 0.465517241379214 0 +1041 0.9310344827583409 0.4655172413792157 0 +1042 0.9655172413791704 0.4655172413792175 0 +1043 0.03448275862081154 0.4482758620687529 0 +1044 0.06896551724162235 0.4482758620687556 0 +1045 0.1034482758624353 0.4482758620687584 0 +1046 0.1379310344832463 0.448275862068761 0 +1047 0.1724137931040541 0.4482758620687637 0 +1048 0.2068965517248621 0.4482758620687665 0 +1049 0.2413793103456701 0.4482758620687691 0 +1050 0.275862068966478 0.448275862068772 0 +1051 0.3103448275872858 0.4482758620687746 0 +1052 0.3448275862080938 0.4482758620687775 0 +1053 0.3793103448289017 0.44827586206878 0 +1054 0.4137931034497097 0.4482758620687828 0 +1055 0.4482758620705175 0.4482758620687856 0 +1056 0.4827586206913255 0.4482758620687883 0 +1057 0.5172413793119718 0.4482758620687909 0 +1058 0.5517241379324562 0.4482758620687937 0 +1059 0.5862068965529409 0.4482758620687964 0 +1060 0.6206896551734257 0.4482758620687992 0 +1061 0.6551724137939103 0.4482758620688019 0 +1062 0.6896551724143949 0.4482758620688045 0 +1063 0.7241379310348792 0.4482758620688073 0 +1064 0.758620689655364 0.4482758620688101 0 +1065 0.7931034482758486 0.4482758620688128 0 +1066 0.827586206896333 0.4482758620688154 0 +1067 0.8620689655168177 0.4482758620688182 0 +1068 0.8965517241375165 0.448275862068821 0 +1069 0.9310344827583444 0.4482758620688236 0 +1070 0.9655172413791724 0.4482758620688263 0 +1071 0.0344827586208043 0.4310344827584064 0 +1072 0.0689655172416077 0.4310344827584077 0 +1073 0.1034482758624138 0.4310344827584089 0 +1074 0.1379310344832175 0.4310344827584099 0 +1075 0.1724137931040169 0.4310344827584111 0 +1076 0.2068965517248164 0.4310344827584123 0 +1077 0.241379310345616 0.4310344827584134 0 +1078 0.2758620689664156 0.4310344827584146 0 +1079 0.3103448275872149 0.4310344827584157 0 +1080 0.3448275862080144 0.431034482758417 0 +1081 0.379310344828814 0.431034482758418 0 +1082 0.4137931034496135 0.4310344827584192 0 +1083 0.4482758620704129 0.4310344827584203 0 +1084 0.4827586206912124 0.4310344827584214 0 +1085 0.5172413793118601 0.4310344827584227 0 +1086 0.5517241379323563 0.4310344827584238 0 +1087 0.5862068965528521 0.4310344827584249 0 +1088 0.6206896551733484 0.4310344827584262 0 +1089 0.6551724137938442 0.4310344827584272 0 +1090 0.6896551724143403 0.4310344827584283 0 +1091 0.7241379310348364 0.4310344827584297 0 +1092 0.758620689655332 0.4310344827584308 0 +1093 0.7931034482758279 0.4310344827584319 0 +1094 0.827586206896324 0.431034482758433 0 +1095 0.8620689655168199 0.4310344827584342 0 +1096 0.896551724137522 0.4310344827584354 0 +1097 0.9310344827583479 0.4310344827584365 0 +1098 0.9655172413791742 0.4310344827584376 0 +1099 0.03448275862079705 0.4137931034481755 0 +1100 0.06896551724159301 0.4137931034481711 0 +1101 0.1034482758623924 0.4137931034481666 0 +1102 0.1379310344831886 0.413793103448162 0 +1103 0.1724137931039797 0.4137931034481574 0 +1104 0.2068965517247708 0.413793103448153 0 +1105 0.2413793103455619 0.4137931034481484 0 +1106 0.275862068966353 0.4137931034481438 0 +1107 0.310344827587144 0.4137931034481393 0 +1108 0.344827586207935 0.4137931034481347 0 +1109 0.3793103448287263 0.4137931034481302 0 +1110 0.4137931034495171 0.4137931034481256 0 +1111 0.4482758620703083 0.4137931034481211 0 +1112 0.4827586206910994 0.4137931034481165 0 +1113 0.5172413793117486 0.4137931034481121 0 +1114 0.5517241379322559 0.4137931034481075 0 +1115 0.5862068965527633 0.413793103448103 0 +1116 0.6206896551732707 0.4137931034480983 0 +1117 0.655172413793778 0.4137931034480938 0 +1118 0.6896551724142856 0.4137931034480892 0 +1119 0.724137931034793 0.4137931034480848 0 +1120 0.7586206896553003 0.4137931034480802 0 +1121 0.7931034482758075 0.4137931034480757 0 +1122 0.8275862068963148 0.4137931034480712 0 +1123 0.8620689655168221 0.4137931034480667 0 +1124 0.8965517241375276 0.4137931034480621 0 +1125 0.9310344827583515 0.4137931034480575 0 +1126 0.9655172413791759 0.413793103448053 0 +1127 0.03448275862078981 0.3965517241379448 0 +1128 0.06896551724157836 0.3965517241379345 0 +1129 0.103448275862371 0.3965517241379242 0 +1130 0.1379310344831598 0.3965517241379141 0 +1131 0.1724137931039424 0.3965517241379038 0 +1132 0.2068965517247251 0.3965517241378936 0 +1133 0.2413793103455079 0.3965517241378833 0 +1134 0.2758620689662906 0.3965517241378731 0 +1135 0.310344827587073 0.3965517241378628 0 +1136 0.3448275862078556 0.3965517241378527 0 +1137 0.3793103448286383 0.3965517241378424 0 +1138 0.4137931034494211 0.3965517241378321 0 +1139 0.4482758620702038 0.3965517241378219 0 +1140 0.4827586206909864 0.3965517241378116 0 +1141 0.5172413793116372 0.3965517241378014 0 +1142 0.551724137932156 0.3965517241377912 0 +1143 0.5862068965526744 0.3965517241377809 0 +1144 0.6206896551731934 0.3965517241377707 0 +1145 0.6551724137937123 0.3965517241377605 0 +1146 0.689655172414231 0.3965517241377501 0 +1147 0.7241379310347498 0.39655172413774 0 +1148 0.7586206896552685 0.3965517241377298 0 +1149 0.793103448275787 0.3965517241377195 0 +1150 0.8275862068963059 0.3965517241377093 0 +1151 0.8620689655168245 0.3965517241376991 0 +1152 0.8965517241375329 0.3965517241376889 0 +1153 0.9310344827583553 0.3965517241376786 0 +1154 0.9655172413791777 0.3965517241376684 0 +1155 0.03448275862078257 0.3793103448277139 0 +1156 0.0689655172415637 0.3793103448276979 0 +1157 0.1034482758623495 0.3793103448276819 0 +1158 0.137931034483131 0.3793103448276662 0 +1159 0.1724137931039052 0.3793103448276502 0 +1160 0.2068965517246794 0.3793103448276342 0 +1161 0.2413793103454537 0.3793103448276183 0 +1162 0.2758620689662279 0.3793103448276023 0 +1163 0.3103448275870021 0.3793103448275865 0 +1164 0.3448275862077763 0.3793103448275706 0 +1165 0.3793103448285506 0.3793103448275546 0 +1166 0.4137931034493249 0.3793103448275386 0 +1167 0.4482758620700991 0.3793103448275227 0 +1168 0.4827586206908733 0.3793103448275068 0 +1169 0.5172413793115257 0.3793103448274909 0 +1170 0.5517241379320557 0.379310344827475 0 +1171 0.5862068965525858 0.379310344827459 0 +1172 0.6206896551731161 0.379310344827443 0 +1173 0.6551724137936461 0.3793103448274273 0 +1174 0.6896551724141764 0.3793103448274113 0 +1175 0.7241379310347066 0.3793103448273953 0 +1176 0.7586206896552365 0.3793103448273793 0 +1177 0.7931034482757666 0.3793103448273635 0 +1178 0.8275862068962966 0.3793103448273475 0 +1179 0.8620689655168268 0.3793103448273316 0 +1180 0.8965517241375383 0.3793103448273157 0 +1181 0.9310344827583591 0.3793103448272998 0 +1182 0.9655172413791795 0.3793103448272838 0 +1183 0.03448275862077532 0.3620689655174829 0 +1184 0.06896551724154905 0.3620689655174613 0 +1185 0.1034482758623281 0.3620689655174397 0 +1186 0.1379310344831021 0.362068965517418 0 +1187 0.172413793103868 0.3620689655173964 0 +1188 0.2068965517246337 0.3620689655173749 0 +1189 0.2413793103453997 0.3620689655173532 0 +1190 0.2758620689661654 0.3620689655173316 0 +1191 0.3103448275869312 0.3620689655173099 0 +1192 0.344827586207697 0.3620689655172884 0 +1193 0.3793103448284629 0.3620689655172667 0 +1194 0.4137931034492288 0.3620689655172452 0 +1195 0.4482758620699945 0.3620689655172235 0 +1196 0.4827586206907603 0.3620689655172019 0 +1197 0.517241379311414 0.3620689655171802 0 +1198 0.5517241379319555 0.3620689655171586 0 +1199 0.586206896552497 0.362068965517137 0 +1200 0.6206896551730386 0.3620689655171154 0 +1201 0.6551724137935802 0.3620689655170938 0 +1202 0.6896551724141218 0.3620689655170721 0 +1203 0.7241379310346631 0.3620689655170505 0 +1204 0.7586206896552048 0.3620689655170289 0 +1205 0.7931034482757462 0.3620689655170072 0 +1206 0.8275862068962877 0.3620689655169856 0 +1207 0.8620689655168292 0.3620689655169641 0 +1208 0.8965517241375438 0.3620689655169423 0 +1209 0.9310344827583626 0.3620689655169208 0 +1210 0.9655172413791813 0.3620689655168993 0 +1211 0.03448275862076808 0.3448275862072521 0 +1212 0.06896551724153439 0.3448275862072248 0 +1213 0.1034482758623066 0.3448275862071974 0 +1214 0.1379310344830733 0.34482758620717 0 +1215 0.1724137931038306 0.3448275862071428 0 +1216 0.2068965517245881 0.3448275862071155 0 +1217 0.2413793103453455 0.3448275862070881 0 +1218 0.2758620689661029 0.3448275862070609 0 +1219 0.3103448275868602 0.3448275862070336 0 +1220 0.3448275862076177 0.3448275862070063 0 +1221 0.3793103448283751 0.344827586206979 0 +1222 0.4137931034491323 0.3448275862069516 0 +1223 0.4482758620698899 0.3448275862069243 0 +1224 0.4827586206906473 0.3448275862068969 0 +1225 0.5172413793113023 0.3448275862068696 0 +1226 0.5517241379318554 0.3448275862068423 0 +1227 0.5862068965524084 0.3448275862068151 0 +1228 0.6206896551729612 0.3448275862067877 0 +1229 0.6551724137935142 0.3448275862067605 0 +1230 0.6896551724140672 0.3448275862067331 0 +1231 0.72413793103462 0.3448275862067057 0 +1232 0.758620689655173 0.3448275862066784 0 +1233 0.7931034482757258 0.3448275862066511 0 +1234 0.8275862068962787 0.3448275862066238 0 +1235 0.8620689655168314 0.3448275862065966 0 +1236 0.8965517241375494 0.3448275862065692 0 +1237 0.9310344827583662 0.3448275862065419 0 +1238 0.965517241379183 0.3448275862065145 0 +1239 0.03448275862076083 0.3275862068970211 0 +1240 0.06896551724151974 0.327586206896988 0 +1241 0.1034482758622852 0.3275862068969551 0 +1242 0.1379310344830445 0.327586206896922 0 +1243 0.1724137931037935 0.3275862068968891 0 +1244 0.2068965517245424 0.3275862068968561 0 +1245 0.2413793103452915 0.3275862068968231 0 +1246 0.2758620689660404 0.32758620689679 0 +1247 0.3103448275867893 0.3275862068967571 0 +1248 0.3448275862075382 0.3275862068967241 0 +1249 0.3793103448282873 0.327586206896691 0 +1250 0.4137931034490363 0.327586206896658 0 +1251 0.4482758620697852 0.3275862068966251 0 +1252 0.4827586206905343 0.327586206896592 0 +1253 0.5172413793111909 0.327586206896559 0 +1254 0.5517241379317552 0.3275862068965261 0 +1255 0.5862068965523196 0.327586206896493 0 +1256 0.6206896551728839 0.32758620689646 0 +1257 0.655172413793448 0.327586206896427 0 +1258 0.6896551724140125 0.3275862068963939 0 +1259 0.7241379310345767 0.327586206896361 0 +1260 0.7586206896551411 0.327586206896328 0 +1261 0.7931034482757053 0.3275862068962949 0 +1262 0.8275862068962695 0.3275862068962621 0 +1263 0.8620689655168337 0.327586206896229 0 +1264 0.8965517241375547 0.327586206896196 0 +1265 0.9310344827583699 0.327586206896163 0 +1266 0.9655172413791848 0.3275862068961299 0 +1267 0.03448275862075359 0.3103448275867903 0 +1268 0.06896551724150508 0.3103448275867515 0 +1269 0.1034482758622638 0.3103448275867128 0 +1270 0.1379310344830156 0.310344827586674 0 +1271 0.1724137931037562 0.3103448275866354 0 +1272 0.2068965517244967 0.3103448275865968 0 +1273 0.2413793103452374 0.310344827586558 0 +1274 0.2758620689659779 0.3103448275865193 0 +1275 0.3103448275867184 0.3103448275864806 0 +1276 0.344827586207459 0.310344827586442 0 +1277 0.3793103448281996 0.3103448275864032 0 +1278 0.4137931034489401 0.3103448275863646 0 +1279 0.4482758620696806 0.3103448275863259 0 +1280 0.4827586206904212 0.3103448275862871 0 +1281 0.5172413793110794 0.3103448275862484 0 +1282 0.5517241379316551 0.3103448275862097 0 +1283 0.5862068965522308 0.310344827586171 0 +1284 0.6206896551728064 0.3103448275861324 0 +1285 0.6551724137933821 0.3103448275860936 0 +1286 0.6896551724139579 0.310344827586055 0 +1287 0.7241379310345334 0.3103448275860162 0 +1288 0.7586206896551091 0.3103448275859776 0 +1289 0.7931034482756849 0.3103448275859388 0 +1290 0.8275862068962605 0.3103448275859001 0 +1291 0.8620689655168361 0.3103448275858615 0 +1292 0.89655172413756 0.3103448275858227 0 +1293 0.9310344827583732 0.310344827585784 0 +1294 0.9655172413791866 0.3103448275857453 0 +1295 0.03448275862074635 0.2931034482765592 0 +1296 0.06896551724149043 0.2931034482765148 0 +1297 0.1034482758622423 0.2931034482764705 0 +1298 0.1379310344829868 0.293103448276426 0 +1299 0.172413793103719 0.2931034482763817 0 +1300 0.2068965517244511 0.2931034482763374 0 +1301 0.2413793103451833 0.2931034482762929 0 +1302 0.2758620689659154 0.2931034482762485 0 +1303 0.3103448275866475 0.293103448276204 0 +1304 0.3448275862073796 0.2931034482761598 0 +1305 0.3793103448281119 0.2931034482761153 0 +1306 0.413793103448844 0.2931034482760709 0 +1307 0.448275862069576 0.2931034482760265 0 +1308 0.4827586206903082 0.2931034482759822 0 +1309 0.5172413793109679 0.2931034482759378 0 +1310 0.5517241379315549 0.2931034482758934 0 +1311 0.586206896552142 0.2931034482758491 0 +1312 0.6206896551727289 0.2931034482758046 0 +1313 0.6551724137933161 0.2931034482757602 0 +1314 0.6896551724139031 0.2931034482757159 0 +1315 0.7241379310344903 0.2931034482756715 0 +1316 0.7586206896550773 0.2931034482756271 0 +1317 0.7931034482756643 0.2931034482755827 0 +1318 0.8275862068962513 0.2931034482755382 0 +1319 0.8620689655168383 0.2931034482754938 0 +1320 0.8965517241375656 0.2931034482754495 0 +1321 0.9310344827583771 0.2931034482754051 0 +1322 0.9655172413791886 0.2931034482753607 0 +1323 0.0344827586207391 0.2758620689663283 0 +1324 0.06896551724147577 0.2758620689662783 0 +1325 0.1034482758622209 0.2758620689662282 0 +1326 0.137931034482958 0.2758620689661782 0 +1327 0.1724137931036817 0.275862068966128 0 +1328 0.2068965517244054 0.275862068966078 0 +1329 0.2413793103451292 0.2758620689660278 0 +1330 0.2758620689658529 0.2758620689659778 0 +1331 0.3103448275865766 0.2758620689659277 0 +1332 0.3448275862073002 0.2758620689658776 0 +1333 0.3793103448280241 0.2758620689658275 0 +1334 0.4137931034487478 0.2758620689657775 0 +1335 0.4482758620694715 0.2758620689657274 0 +1336 0.4827586206901952 0.2758620689656772 0 +1337 0.5172413793108562 0.2758620689656273 0 +1338 0.5517241379314548 0.2758620689655771 0 +1339 0.5862068965520532 0.275862068965527 0 +1340 0.6206896551726516 0.2758620689654769 0 +1341 0.65517241379325 0.2758620689654269 0 +1342 0.6896551724138484 0.2758620689653768 0 +1343 0.724137931034447 0.2758620689653267 0 +1344 0.7586206896550456 0.2758620689652767 0 +1345 0.7931034482756438 0.2758620689652266 0 +1346 0.8275862068962424 0.2758620689651764 0 +1347 0.8620689655168408 0.2758620689651263 0 +1348 0.8965517241375711 0.2758620689650763 0 +1349 0.9310344827583809 0.2758620689650262 0 +1350 0.9655172413791904 0.2758620689649761 0 +1351 0.03448275862073186 0.2586206896560975 0 +1352 0.06896551724146112 0.2586206896560416 0 +1353 0.1034482758621994 0.2586206896559859 0 +1354 0.1379310344829291 0.2586206896559302 0 +1355 0.1724137931036445 0.2586206896558743 0 +1356 0.2068965517243597 0.2586206896558186 0 +1357 0.2413793103450751 0.2586206896557627 0 +1358 0.2758620689657904 0.2586206896557071 0 +1359 0.3103448275865056 0.2586206896556513 0 +1360 0.3448275862072209 0.2586206896555955 0 +1361 0.3793103448279362 0.2586206896555397 0 +1362 0.4137931034486516 0.258620689655484 0 +1363 0.4482758620693669 0.2586206896554281 0 +1364 0.4827586206900822 0.2586206896553724 0 +1365 0.5172413793107445 0.2586206896553165 0 +1366 0.5517241379313544 0.2586206896552608 0 +1367 0.5862068965519643 0.2586206896552051 0 +1368 0.6206896551725744 0.2586206896551492 0 +1369 0.655172413793184 0.2586206896550935 0 +1370 0.689655172413794 0.2586206896550378 0 +1371 0.7241379310344037 0.2586206896549819 0 +1372 0.7586206896550136 0.2586206896549261 0 +1373 0.7931034482756234 0.2586206896548703 0 +1374 0.8275862068962331 0.2586206896548146 0 +1375 0.862068965516843 0.2586206896547589 0 +1376 0.8965517241375764 0.258620689654703 0 +1377 0.9310344827583844 0.2586206896546473 0 +1378 0.9655172413791921 0.2586206896545915 0 +1379 0.03448275862072461 0.2413793103457758 0 +1380 0.06896551724144646 0.2413793103457192 0 +1381 0.103448275862178 0.2413793103456627 0 +1382 0.1379310344829003 0.2413793103456062 0 +1383 0.1724137931036072 0.2413793103455497 0 +1384 0.2068965517243141 0.2413793103454931 0 +1385 0.241379310345021 0.2413793103454367 0 +1386 0.2758620689657279 0.2413793103453802 0 +1387 0.3103448275864347 0.2413793103453236 0 +1388 0.3448275862071415 0.2413793103452671 0 +1389 0.3793103448278485 0.2413793103452107 0 +1390 0.4137931034485553 0.2413793103451541 0 +1391 0.4482758620692622 0.2413793103450976 0 +1392 0.4827586206899692 0.2413793103450411 0 +1393 0.5172413793106331 0.2413793103449845 0 +1394 0.5517241379312545 0.241379310344928 0 +1395 0.5862068965518755 0.2413793103448715 0 +1396 0.6206896551724969 0.241379310344815 0 +1397 0.6551724137931181 0.2413793103447585 0 +1398 0.6896551724137392 0.2413793103447019 0 +1399 0.7241379310343606 0.2413793103446455 0 +1400 0.7586206896549816 0.241379310344589 0 +1401 0.793103448275603 0.2413793103445325 0 +1402 0.8275862068962242 0.2413793103444759 0 +1403 0.8620689655168452 0.2413793103444195 0 +1404 0.896551724137582 0.2413793103443629 0 +1405 0.931034482758388 0.2413793103443064 0 +1406 0.9655172413791939 0.2413793103442499 0 +1407 0.03448275862071737 0.2241379310353634 0 +1408 0.06896551724143178 0.224137931035311 0 +1409 0.1034482758621565 0.2241379310352588 0 +1410 0.1379310344828715 0.2241379310352065 0 +1411 0.17241379310357 0.2241379310351542 0 +1412 0.2068965517242684 0.2241379310351019 0 +1413 0.2413793103449669 0.2241379310350496 0 +1414 0.2758620689656653 0.2241379310349972 0 +1415 0.3103448275863637 0.2241379310349449 0 +1416 0.3448275862070622 0.2241379310348927 0 +1417 0.3793103448277607 0.2241379310348403 0 +1418 0.4137931034484592 0.224137931034788 0 +1419 0.4482758620691576 0.2241379310347357 0 +1420 0.4827586206898561 0.2241379310346834 0 +1421 0.5172413793105216 0.2241379310346311 0 +1422 0.5517241379311542 0.2241379310345788 0 +1423 0.5862068965517867 0.2241379310345265 0 +1424 0.6206896551724194 0.2241379310344742 0 +1425 0.6551724137930519 0.2241379310344219 0 +1426 0.6896551724136846 0.2241379310343696 0 +1427 0.7241379310343171 0.2241379310343173 0 +1428 0.7586206896549499 0.224137931034265 0 +1429 0.7931034482755823 0.2241379310342126 0 +1430 0.8275862068962149 0.2241379310341604 0 +1431 0.8620689655168476 0.2241379310341081 0 +1432 0.8965517241375873 0.2241379310340558 0 +1433 0.9310344827583915 0.2241379310340035 0 +1434 0.9655172413791959 0.2241379310339511 0 +1435 0.03448275862071012 0.206896551724951 0 +1436 0.06896551724141713 0.206896551724903 0 +1437 0.1034482758621351 0.2068965517248548 0 +1438 0.1379310344828427 0.2068965517248067 0 +1439 0.1724137931035327 0.2068965517247586 0 +1440 0.2068965517242227 0.2068965517247106 0 +1441 0.2413793103449128 0.2068965517246625 0 +1442 0.2758620689656029 0.2068965517246143 0 +1443 0.3103448275862928 0.2068965517245662 0 +1444 0.3448275862069829 0.2068965517245182 0 +1445 0.3793103448276729 0.2068965517244701 0 +1446 0.413793103448363 0.206896551724422 0 +1447 0.448275862069053 0.2068965517243739 0 +1448 0.4827586206897431 0.2068965517243258 0 +1449 0.5172413793104101 0.2068965517242777 0 +1450 0.551724137931054 0.2068965517242296 0 +1451 0.5862068965516979 0.2068965517241815 0 +1452 0.6206896551723421 0.2068965517241334 0 +1453 0.655172413792986 0.2068965517240853 0 +1454 0.6896551724136299 0.2068965517240372 0 +1455 0.724137931034274 0.2068965517239891 0 +1456 0.7586206896549181 0.2068965517239411 0 +1457 0.7931034482755619 0.2068965517238929 0 +1458 0.827586206896206 0.2068965517238449 0 +1459 0.8620689655168499 0.2068965517237967 0 +1460 0.8965517241375929 0.2068965517237487 0 +1461 0.9310344827583951 0.2068965517237006 0 +1462 0.9655172413791977 0.2068965517236525 0 +1463 0.03448275862070288 0.1896551724145386 0 +1464 0.06896551724140244 0.1896551724144948 0 +1465 0.1034482758621137 0.1896551724144508 0 +1466 0.1379310344828139 0.189655172414407 0 +1467 0.1724137931034955 0.1896551724143631 0 +1468 0.2068965517241771 0.1896551724143192 0 +1469 0.2413793103448587 0.1896551724142753 0 +1470 0.2758620689655403 0.1896551724142315 0 +1471 0.3103448275862219 0.1896551724141876 0 +1472 0.3448275862069034 0.1896551724141436 0 +1473 0.3793103448275852 0.1896551724140998 0 +1474 0.4137931034482668 0.1896551724140559 0 +1475 0.4482758620689484 0.189655172414012 0 +1476 0.4827586206896302 0.1896551724139681 0 +1477 0.5172413793102987 0.1896551724139243 0 +1478 0.5517241379309539 0.1896551724138804 0 +1479 0.5862068965516093 0.1896551724138365 0 +1480 0.6206896551722648 0.1896551724137926 0 +1481 0.65517241379292 0.1896551724137487 0 +1482 0.6896551724135753 0.1896551724137048 0 +1483 0.7241379310342307 0.1896551724136609 0 +1484 0.7586206896548862 0.1896551724136171 0 +1485 0.7931034482755415 0.1896551724135732 0 +1486 0.8275862068961968 0.1896551724135293 0 +1487 0.8620689655168523 0.1896551724134854 0 +1488 0.8965517241375982 0.1896551724134415 0 +1489 0.9310344827583991 0.1896551724133976 0 +1490 0.9655172413791995 0.1896551724133537 0 +1491 0.03448275862069564 0.1724137931041262 0 +1492 0.06896551724138779 0.1724137931040865 0 +1493 0.1034482758620922 0.1724137931040469 0 +1494 0.137931034482785 0.1724137931040072 0 +1495 0.1724137931034582 0.1724137931039675 0 +1496 0.2068965517241314 0.1724137931039278 0 +1497 0.2413793103448046 0.1724137931038881 0 +1498 0.2758620689654779 0.1724137931038485 0 +1499 0.3103448275861509 0.1724137931038088 0 +1500 0.3448275862068241 0.1724137931037691 0 +1501 0.3793103448274975 0.1724137931037295 0 +1502 0.4137931034481707 0.1724137931036898 0 +1503 0.4482758620688437 0.1724137931036501 0 +1504 0.4827586206895171 0.1724137931036104 0 +1505 0.5172413793101868 0.1724137931035708 0 +1506 0.5517241379308537 0.1724137931035311 0 +1507 0.5862068965515205 0.1724137931034914 0 +1508 0.6206896551721871 0.1724137931034518 0 +1509 0.6551724137928541 0.1724137931034121 0 +1510 0.6896551724135207 0.1724137931033724 0 +1511 0.7241379310341874 0.1724137931033327 0 +1512 0.7586206896548542 0.172413793103293 0 +1513 0.793103448275521 0.1724137931032534 0 +1514 0.8275862068961878 0.1724137931032137 0 +1515 0.8620689655168545 0.172413793103174 0 +1516 0.8965517241376038 0.1724137931031344 0 +1517 0.9310344827584026 0.1724137931030947 0 +1518 0.9655172413792013 0.172413793103055 0 +1519 0.03448275862068839 0.1551724137937138 0 +1520 0.06896551724137313 0.1551724137936784 0 +1521 0.1034482758620708 0.1551724137936429 0 +1522 0.1379310344827562 0.1551724137936074 0 +1523 0.172413793103421 0.155172413793572 0 +1524 0.2068965517240857 0.1551724137935365 0 +1525 0.2413793103447506 0.1551724137935011 0 +1526 0.2758620689654153 0.1551724137934656 0 +1527 0.3103448275860801 0.1551724137934301 0 +1528 0.3448275862067449 0.1551724137933947 0 +1529 0.3793103448274097 0.1551724137933592 0 +1530 0.4137931034480743 0.1551724137933237 0 +1531 0.4482758620687392 0.1551724137932883 0 +1532 0.4827586206894041 0.1551724137932528 0 +1533 0.5172413793100753 0.1551724137932173 0 +1534 0.5517241379307536 0.1551724137931819 0 +1535 0.5862068965514319 0.1551724137931464 0 +1536 0.6206896551721098 0.1551724137931109 0 +1537 0.6551724137927881 0.1551724137930755 0 +1538 0.6896551724134661 0.15517241379304 0 +1539 0.7241379310341444 0.1551724137930046 0 +1540 0.7586206896548224 0.1551724137929691 0 +1541 0.7931034482755006 0.1551724137929336 0 +1542 0.8275862068961788 0.1551724137928981 0 +1543 0.8620689655168567 0.1551724137928627 0 +1544 0.8965517241376091 0.1551724137928273 0 +1545 0.9310344827584062 0.1551724137927917 0 +1546 0.965517241379203 0.1551724137927563 0 +1547 0.03448275862068115 0.1379310344833016 0 +1548 0.06896551724135848 0.1379310344832703 0 +1549 0.1034482758620494 0.137931034483239 0 +1550 0.1379310344827274 0.1379310344832078 0 +1551 0.1724137931033837 0.1379310344831765 0 +1552 0.2068965517240401 0.1379310344831453 0 +1553 0.2413793103446965 0.137931034483114 0 +1554 0.2758620689653529 0.1379310344830827 0 +1555 0.3103448275860091 0.1379310344830515 0 +1556 0.3448275862066654 0.1379310344830202 0 +1557 0.3793103448273218 0.1379310344829889 0 +1558 0.4137931034479782 0.1379310344829577 0 +1559 0.4482758620686346 0.1379310344829264 0 +1560 0.482758620689291 0.1379310344828952 0 +1561 0.5172413793099638 0.1379310344828639 0 +1562 0.5517241379306534 0.1379310344828327 0 +1563 0.5862068965513431 0.1379310344828014 0 +1564 0.6206896551720326 0.1379310344827702 0 +1565 0.655172413792722 0.1379310344827389 0 +1566 0.6896551724134115 0.1379310344827077 0 +1567 0.7241379310341011 0.1379310344826764 0 +1568 0.7586206896547907 0.1379310344826452 0 +1569 0.7931034482754802 0.1379310344826139 0 +1570 0.8275862068961695 0.1379310344825826 0 +1571 0.8620689655168592 0.1379310344825514 0 +1572 0.8965517241376146 0.1379310344825201 0 +1573 0.9310344827584098 0.1379310344824889 0 +1574 0.965517241379205 0.1379310344824576 0 +1575 0.0344827586206739 0.1206896551728892 0 +1576 0.06896551724134382 0.1206896551728621 0 +1577 0.1034482758620279 0.120689655172835 0 +1578 0.1379310344826986 0.120689655172808 0 +1579 0.1724137931033464 0.120689655172781 0 +1580 0.2068965517239944 0.1206896551727539 0 +1581 0.2413793103446424 0.1206896551727269 0 +1582 0.2758620689652903 0.1206896551726998 0 +1583 0.3103448275859382 0.1206896551726728 0 +1584 0.3448275862065861 0.1206896551726457 0 +1585 0.3793103448272341 0.1206896551726187 0 +1586 0.4137931034478821 0.1206896551725916 0 +1587 0.44827586206853 0.1206896551725646 0 +1588 0.482758620689178 0.1206896551725375 0 +1589 0.5172413793098524 0.1206896551725105 0 +1590 0.5517241379305533 0.1206896551724835 0 +1591 0.5862068965512542 0.1206896551724564 0 +1592 0.6206896551719551 0.1206896551724294 0 +1593 0.655172413792656 0.1206896551724023 0 +1594 0.6896551724133568 0.1206896551723753 0 +1595 0.7241379310340578 0.1206896551723482 0 +1596 0.7586206896547587 0.1206896551723212 0 +1597 0.7931034482754598 0.1206896551722941 0 +1598 0.8275862068961605 0.1206896551722671 0 +1599 0.8620689655168614 0.1206896551722401 0 +1600 0.89655172413762 0.120689655172213 0 +1601 0.9310344827584134 0.120689655172186 0 +1602 0.9655172413792066 0.1206896551721589 0 +1603 0.03448275862066666 0.1034482758624767 0 +1604 0.06896551724132917 0.1034482758624539 0 +1605 0.1034482758620065 0.103448275862431 0 +1606 0.1379310344826697 0.1034482758624082 0 +1607 0.1724137931033092 0.1034482758623854 0 +1608 0.2068965517239487 0.1034482758623625 0 +1609 0.2413793103445883 0.1034482758623397 0 +1610 0.2758620689652279 0.1034482758623169 0 +1611 0.3103448275858672 0.103448275862294 0 +1612 0.3448275862065068 0.1034482758622712 0 +1613 0.3793103448271463 0.1034482758622484 0 +1614 0.4137931034477859 0.1034482758622255 0 +1615 0.4482758620684253 0.1034482758622027 0 +1616 0.482758620689065 0.1034482758621799 0 +1617 0.5172413793097409 0.103448275862157 0 +1618 0.5517241379304529 0.1034482758621342 0 +1619 0.5862068965511654 0.1034482758621114 0 +1620 0.6206896551718776 0.1034482758620885 0 +1621 0.6551724137925901 0.1034482758620657 0 +1622 0.6896551724133022 0.1034482758620429 0 +1623 0.7241379310340147 0.10344827586202 0 +1624 0.7586206896547267 0.1034482758619972 0 +1625 0.7931034482754391 0.1034482758619744 0 +1626 0.8275862068961514 0.1034482758619515 0 +1627 0.8620689655168638 0.1034482758619287 0 +1628 0.8965517241376255 0.1034482758619059 0 +1629 0.9310344827584169 0.103448275861883 0 +1630 0.9655172413792086 0.1034482758618602 0 +1631 0.03448275862065941 0.08620689655206436 0 +1632 0.06896551724131451 0.08620689655204569 0 +1633 0.103448275861985 0.08620689655202712 0 +1634 0.1379310344826409 0.08620689655200847 0 +1635 0.1724137931032719 0.08620689655198985 0 +1636 0.2068965517239031 0.08620689655197122 0 +1637 0.2413793103445342 0.08620689655195257 0 +1638 0.2758620689651652 0.08620689655193398 0 +1639 0.3103448275857963 0.08620689655191535 0 +1640 0.3448275862064273 0.08620689655189673 0 +1641 0.3793103448270585 0.08620689655187808 0 +1642 0.4137931034476897 0.08620689655185948 0 +1643 0.4482758620683207 0.08620689655184086 0 +1644 0.482758620688952 0.08620689655182223 0 +1645 0.5172413793096292 0.08620689655180358 0 +1646 0.551724137930353 0.08620689655178496 0 +1647 0.5862068965510766 0.08620689655176633 0 +1648 0.6206896551718002 0.08620689655174771 0 +1649 0.6551724137925239 0.08620689655172908 0 +1650 0.6896551724132476 0.08620689655171049 0 +1651 0.7241379310339713 0.08620689655169184 0 +1652 0.758620689654695 0.08620689655167324 0 +1653 0.7931034482754187 0.08620689655165459 0 +1654 0.8275862068961424 0.08620689655163596 0 +1655 0.8620689655168661 0.08620689655161734 0 +1656 0.8965517241376311 0.08620689655159872 0 +1657 0.9310344827584207 0.08620689655158009 0 +1658 0.9655172413792104 0.08620689655156147 0 +1659 0.03448275862065217 0.06896551724165198 0 +1660 0.06896551724129986 0.06896551724163758 0 +1661 0.1034482758619636 0.06896551724162314 0 +1662 0.137931034482612 0.06896551724160874 0 +1663 0.1724137931032347 0.0689655172415943 0 +1664 0.2068965517238573 0.0689655172415799 0 +1665 0.2413793103444801 0.06896551724156549 0 +1666 0.2758620689651028 0.06896551724155106 0 +1667 0.3103448275857255 0.06896551724153666 0 +1668 0.3448275862063481 0.06896551724152225 0 +1669 0.3793103448269708 0.06896551724150782 0 +1670 0.4137931034475934 0.06896551724149341 0 +1671 0.4482758620682161 0.06896551724147898 0 +1672 0.4827586206888389 0.0689655172414646 0 +1673 0.5172413793095175 0.06896551724145017 0 +1674 0.5517241379302527 0.06896551724143574 0 +1675 0.5862068965509878 0.06896551724142133 0 +1676 0.6206896551717229 0.06896551724140693 0 +1677 0.6551724137924582 0.06896551724139249 0 +1678 0.689655172413193 0.06896551724137809 0 +1679 0.7241379310339281 0.06896551724136368 0 +1680 0.7586206896546632 0.06896551724134925 0 +1681 0.793103448275398 0.06896551724133484 0 +1682 0.8275862068961332 0.06896551724132044 0 +1683 0.8620689655168683 0.06896551724130603 0 +1684 0.8965517241376364 0.0689655172412916 0 +1685 0.9310344827584244 0.0689655172412772 0 +1686 0.9655172413792124 0.06896551724126276 0 +1687 0.03448275862064493 0.05172413793123908 0 +1688 0.0689655172412852 0.05172413793122838 0 +1689 0.1034482758619422 0.05172413793121763 0 +1690 0.1379310344825832 0.05172413793120691 0 +1691 0.1724137931031974 0.05172413793119619 0 +1692 0.2068965517238117 0.05172413793118547 0 +1693 0.241379310344426 0.05172413793117475 0 +1694 0.2758620689650402 0.05172413793116404 0 +1695 0.3103448275856544 0.05172413793115331 0 +1696 0.3448275862062687 0.0517241379311426 0 +1697 0.3793103448268831 0.0517241379311319 0 +1698 0.4137931034474973 0.05172413793112116 0 +1699 0.4482758620681114 0.05172413793111043 0 +1700 0.4827586206887258 0.05172413793109973 0 +1701 0.5172413793094061 0.051724137931089 0 +1702 0.5517241379301525 0.05172413793107827 0 +1703 0.586206896550899 0.05172413793106756 0 +1704 0.6206896551716454 0.05172413793105685 0 +1705 0.655172413792392 0.0517241379310461 0 +1706 0.6896551724131383 0.05172413793103539 0 +1707 0.7241379310338848 0.05172413793102468 0 +1708 0.7586206896546313 0.05172413793101395 0 +1709 0.7931034482753776 0.05172413793100324 0 +1710 0.8275862068961243 0.05172413793099251 0 +1711 0.8620689655168707 0.0517241379309818 0 +1712 0.8965517241376417 0.05172413793097108 0 +1713 0.9310344827584279 0.05172413793096035 0 +1714 0.9655172413792139 0.05172413793094963 0 +1715 0.03448275862063768 0.03448275862082584 0 +1716 0.06896551724127055 0.03448275862081851 0 +1717 0.1034482758619207 0.03448275862081118 0 +1718 0.1379310344825543 0.03448275862080384 0 +1719 0.1724137931031602 0.03448275862079653 0 +1720 0.2068965517237661 0.03448275862078919 0 +1721 0.2413793103443719 0.03448275862078186 0 +1722 0.2758620689649777 0.03448275862077453 0 +1723 0.3103448275855836 0.0344827586207672 0 +1724 0.3448275862061894 0.03448275862075986 0 +1725 0.3793103448267954 0.03448275862075253 0 +1726 0.4137931034474011 0.03448275862074521 0 +1727 0.4482758620680068 0.03448275862073788 0 +1728 0.4827586206886128 0.03448275862073055 0 +1729 0.5172413793092946 0.03448275862072323 0 +1730 0.5517241379300524 0.0344827586207159 0 +1731 0.5862068965508102 0.03448275862070857 0 +1732 0.620689655171568 0.03448275862070123 0 +1733 0.6551724137923258 0.0344827586206939 0 +1734 0.6896551724130837 0.03448275862068657 0 +1735 0.7241379310338415 0.03448275862067923 0 +1736 0.7586206896545995 0.03448275862067191 0 +1737 0.7931034482753572 0.03448275862066458 0 +1738 0.8275862068961152 0.03448275862065725 0 +1739 0.8620689655168732 0.03448275862064992 0 +1740 0.8965517241376473 0.0344827586206426 0 +1741 0.9310344827584315 0.03448275862063527 0 +1742 0.9655172413792159 0.03448275862062794 0 +1743 0.03448275862063044 0.01724137931041302 0 +1744 0.06896551724125587 0.0172413793104094 0 +1745 0.1034482758618993 0.01724137931040577 0 +1746 0.1379310344825256 0.01724137931040215 0 +1747 0.1724137931031229 0.01724137931039853 0 +1748 0.2068965517237204 0.01724137931039491 0 +1749 0.2413793103443178 0.01724137931039128 0 +1750 0.2758620689649152 0.01724137931038766 0 +1751 0.3103448275855126 0.01724137931038404 0 +1752 0.34482758620611 0.01724137931038042 0 +1753 0.3793103448267074 0.01724137931037679 0 +1754 0.413793103447305 0.01724137931037317 0 +1755 0.4482758620679023 0.01724137931036955 0 +1756 0.4827586206884998 0.01724137931036593 0 +1757 0.5172413793091831 0.01724137931036231 0 +1758 0.5517241379299522 0.01724137931035868 0 +1759 0.5862068965507216 0.01724137931035506 0 +1760 0.6206896551714908 0.01724137931035144 0 +1761 0.6551724137922601 0.01724137931034782 0 +1762 0.6896551724130291 0.0172413793103442 0 +1763 0.7241379310337984 0.01724137931034057 0 +1764 0.7586206896545675 0.01724137931033695 0 +1765 0.7931034482753367 0.01724137931033333 0 +1766 0.8275862068961061 0.01724137931032971 0 +1767 0.8620689655168754 0.01724137931032609 0 +1768 0.8965517241376526 0.01724137931032246 0 +1769 0.931034482758435 0.01724137931031884 0 +1770 0.9655172413792177 0.01724137931031522 0 +$EndNodes +$Elements +1891 +1 15 2 0 1 1 +2 15 2 0 2 2 +3 15 2 0 3 3 +4 15 2 0 4 4 +5 15 2 0 5 5 +6 15 2 0 6 6 +7 1 2 0 1 5 7 +8 1 2 0 1 7 8 +9 1 2 0 1 8 9 +10 1 2 0 1 9 10 +11 1 2 0 1 10 11 +12 1 2 0 1 11 12 +13 1 2 0 1 12 13 +14 1 2 0 1 13 14 +15 1 2 0 1 14 15 +16 1 2 0 1 15 16 +17 1 2 0 1 16 17 +18 1 2 0 1 17 18 +19 1 2 0 1 18 19 +20 1 2 0 1 19 20 +21 1 2 0 1 20 21 +22 1 2 0 1 21 22 +23 1 2 0 1 22 23 +24 1 2 0 1 23 24 +25 1 2 0 1 24 25 +26 1 2 0 1 25 26 +27 1 2 0 1 26 27 +28 1 2 0 1 27 28 +29 1 2 0 1 28 29 +30 1 2 0 1 29 30 +31 1 2 0 1 30 31 +32 1 2 0 1 31 32 +33 1 2 0 1 32 33 +34 1 2 0 1 33 34 +35 1 2 0 1 34 1 +36 1 2 0 2 1 35 +37 1 2 0 2 35 36 +38 1 2 0 2 36 37 +39 1 2 0 2 37 38 +40 1 2 0 2 38 39 +41 1 2 0 2 39 40 +42 1 2 0 2 40 41 +43 1 2 0 2 41 42 +44 1 2 0 2 42 43 +45 1 2 0 2 43 44 +46 1 2 0 2 44 45 +47 1 2 0 2 45 46 +48 1 2 0 2 46 47 +49 1 2 0 2 47 48 +50 1 2 0 2 48 49 +51 1 2 0 2 49 50 +52 1 2 0 2 50 51 +53 1 2 0 2 51 52 +54 1 2 0 2 52 53 +55 1 2 0 2 53 54 +56 1 2 0 2 54 55 +57 1 2 0 2 55 56 +58 1 2 0 2 56 57 +59 1 2 0 2 57 58 +60 1 2 0 2 58 59 +61 1 2 0 2 59 60 +62 1 2 0 2 60 61 +63 1 2 0 2 61 62 +64 1 2 0 2 62 2 +65 1 2 0 3 2 63 +66 1 2 0 3 63 64 +67 1 2 0 3 64 65 +68 1 2 0 3 65 66 +69 1 2 0 3 66 67 +70 1 2 0 3 67 68 +71 1 2 0 3 68 69 +72 1 2 0 3 69 70 +73 1 2 0 3 70 71 +74 1 2 0 3 71 72 +75 1 2 0 3 72 73 +76 1 2 0 3 73 74 +77 1 2 0 3 74 75 +78 1 2 0 3 75 76 +79 1 2 0 3 76 77 +80 1 2 0 3 77 78 +81 1 2 0 3 78 79 +82 1 2 0 3 79 80 +83 1 2 0 3 80 81 +84 1 2 0 3 81 82 +85 1 2 0 3 82 83 +86 1 2 0 3 83 84 +87 1 2 0 3 84 85 +88 1 2 0 3 85 86 +89 1 2 0 3 86 87 +90 1 2 0 3 87 88 +91 1 2 0 3 88 89 +92 1 2 0 3 89 90 +93 1 2 0 3 90 6 +94 1 2 0 4 6 91 +95 1 2 0 4 91 92 +96 1 2 0 4 92 93 +97 1 2 0 4 93 94 +98 1 2 0 4 94 95 +99 1 2 0 4 95 96 +100 1 2 0 4 96 97 +101 1 2 0 4 97 98 +102 1 2 0 4 98 99 +103 1 2 0 4 99 100 +104 1 2 0 4 100 101 +105 1 2 0 4 101 102 +106 1 2 0 4 102 103 +107 1 2 0 4 103 104 +108 1 2 0 4 104 105 +109 1 2 0 4 105 106 +110 1 2 0 4 106 107 +111 1 2 0 4 107 108 +112 1 2 0 4 108 109 +113 1 2 0 4 109 110 +114 1 2 0 4 110 111 +115 1 2 0 4 111 112 +116 1 2 0 4 112 113 +117 1 2 0 4 113 114 +118 1 2 0 4 114 115 +119 1 2 0 4 115 116 +120 1 2 0 4 116 117 +121 1 2 0 4 117 118 +122 1 2 0 4 118 5 +123 1 2 0 5 5 119 +124 1 2 0 5 119 120 +125 1 2 0 5 120 121 +126 1 2 0 5 121 122 +127 1 2 0 5 122 123 +128 1 2 0 5 123 124 +129 1 2 0 5 124 125 +130 1 2 0 5 125 126 +131 1 2 0 5 126 127 +132 1 2 0 5 127 128 +133 1 2 0 5 128 129 +134 1 2 0 5 129 130 +135 1 2 0 5 130 131 +136 1 2 0 5 131 132 +137 1 2 0 5 132 133 +138 1 2 0 5 133 134 +139 1 2 0 5 134 135 +140 1 2 0 5 135 136 +141 1 2 0 5 136 137 +142 1 2 0 5 137 138 +143 1 2 0 5 138 139 +144 1 2 0 5 139 140 +145 1 2 0 5 140 141 +146 1 2 0 5 141 142 +147 1 2 0 5 142 143 +148 1 2 0 5 143 144 +149 1 2 0 5 144 145 +150 1 2 0 5 145 146 +151 1 2 0 5 146 4 +152 1 2 0 6 4 147 +153 1 2 0 6 147 148 +154 1 2 0 6 148 149 +155 1 2 0 6 149 150 +156 1 2 0 6 150 151 +157 1 2 0 6 151 152 +158 1 2 0 6 152 153 +159 1 2 0 6 153 154 +160 1 2 0 6 154 155 +161 1 2 0 6 155 156 +162 1 2 0 6 156 157 +163 1 2 0 6 157 158 +164 1 2 0 6 158 159 +165 1 2 0 6 159 160 +166 1 2 0 6 160 161 +167 1 2 0 6 161 162 +168 1 2 0 6 162 163 +169 1 2 0 6 163 164 +170 1 2 0 6 164 165 +171 1 2 0 6 165 166 +172 1 2 0 6 166 167 +173 1 2 0 6 167 168 +174 1 2 0 6 168 169 +175 1 2 0 6 169 170 +176 1 2 0 6 170 171 +177 1 2 0 6 171 172 +178 1 2 0 6 172 173 +179 1 2 0 6 173 174 +180 1 2 0 6 174 3 +181 1 2 0 7 3 175 +182 1 2 0 7 175 176 +183 1 2 0 7 176 177 +184 1 2 0 7 177 178 +185 1 2 0 7 178 179 +186 1 2 0 7 179 180 +187 1 2 0 7 180 181 +188 1 2 0 7 181 182 +189 1 2 0 7 182 183 +190 1 2 0 7 183 184 +191 1 2 0 7 184 185 +192 1 2 0 7 185 186 +193 1 2 0 7 186 187 +194 1 2 0 7 187 188 +195 1 2 0 7 188 189 +196 1 2 0 7 189 190 +197 1 2 0 7 190 191 +198 1 2 0 7 191 192 +199 1 2 0 7 192 193 +200 1 2 0 7 193 194 +201 1 2 0 7 194 195 +202 1 2 0 7 195 196 +203 1 2 0 7 196 197 +204 1 2 0 7 197 198 +205 1 2 0 7 198 199 +206 1 2 0 7 199 200 +207 1 2 0 7 200 201 +208 1 2 0 7 201 202 +209 1 2 0 7 202 6 +210 3 2 0 9 6 91 203 202 +211 3 2 0 9 202 203 204 201 +212 3 2 0 9 201 204 205 200 +213 3 2 0 9 200 205 206 199 +214 3 2 0 9 199 206 207 198 +215 3 2 0 9 198 207 208 197 +216 3 2 0 9 197 208 209 196 +217 3 2 0 9 196 209 210 195 +218 3 2 0 9 195 210 211 194 +219 3 2 0 9 194 211 212 193 +220 3 2 0 9 193 212 213 192 +221 3 2 0 9 192 213 214 191 +222 3 2 0 9 191 214 215 190 +223 3 2 0 9 190 215 216 189 +224 3 2 0 9 189 216 217 188 +225 3 2 0 9 188 217 218 187 +226 3 2 0 9 187 218 219 186 +227 3 2 0 9 186 219 220 185 +228 3 2 0 9 185 220 221 184 +229 3 2 0 9 184 221 222 183 +230 3 2 0 9 183 222 223 182 +231 3 2 0 9 182 223 224 181 +232 3 2 0 9 181 224 225 180 +233 3 2 0 9 180 225 226 179 +234 3 2 0 9 179 226 227 178 +235 3 2 0 9 178 227 228 177 +236 3 2 0 9 177 228 229 176 +237 3 2 0 9 176 229 230 175 +238 3 2 0 9 175 230 174 3 +239 3 2 0 9 91 92 231 203 +240 3 2 0 9 203 231 232 204 +241 3 2 0 9 204 232 233 205 +242 3 2 0 9 205 233 234 206 +243 3 2 0 9 206 234 235 207 +244 3 2 0 9 207 235 236 208 +245 3 2 0 9 208 236 237 209 +246 3 2 0 9 209 237 238 210 +247 3 2 0 9 210 238 239 211 +248 3 2 0 9 211 239 240 212 +249 3 2 0 9 212 240 241 213 +250 3 2 0 9 213 241 242 214 +251 3 2 0 9 214 242 243 215 +252 3 2 0 9 215 243 244 216 +253 3 2 0 9 216 244 245 217 +254 3 2 0 9 217 245 246 218 +255 3 2 0 9 218 246 247 219 +256 3 2 0 9 219 247 248 220 +257 3 2 0 9 220 248 249 221 +258 3 2 0 9 221 249 250 222 +259 3 2 0 9 222 250 251 223 +260 3 2 0 9 223 251 252 224 +261 3 2 0 9 224 252 253 225 +262 3 2 0 9 225 253 254 226 +263 3 2 0 9 226 254 255 227 +264 3 2 0 9 227 255 256 228 +265 3 2 0 9 228 256 257 229 +266 3 2 0 9 229 257 258 230 +267 3 2 0 9 230 258 173 174 +268 3 2 0 9 92 93 259 231 +269 3 2 0 9 231 259 260 232 +270 3 2 0 9 232 260 261 233 +271 3 2 0 9 233 261 262 234 +272 3 2 0 9 234 262 263 235 +273 3 2 0 9 235 263 264 236 +274 3 2 0 9 236 264 265 237 +275 3 2 0 9 237 265 266 238 +276 3 2 0 9 238 266 267 239 +277 3 2 0 9 239 267 268 240 +278 3 2 0 9 240 268 269 241 +279 3 2 0 9 241 269 270 242 +280 3 2 0 9 242 270 271 243 +281 3 2 0 9 243 271 272 244 +282 3 2 0 9 244 272 273 245 +283 3 2 0 9 245 273 274 246 +284 3 2 0 9 246 274 275 247 +285 3 2 0 9 247 275 276 248 +286 3 2 0 9 248 276 277 249 +287 3 2 0 9 249 277 278 250 +288 3 2 0 9 250 278 279 251 +289 3 2 0 9 251 279 280 252 +290 3 2 0 9 252 280 281 253 +291 3 2 0 9 253 281 282 254 +292 3 2 0 9 254 282 283 255 +293 3 2 0 9 255 283 284 256 +294 3 2 0 9 256 284 285 257 +295 3 2 0 9 257 285 286 258 +296 3 2 0 9 258 286 172 173 +297 3 2 0 9 93 94 287 259 +298 3 2 0 9 259 287 288 260 +299 3 2 0 9 260 288 289 261 +300 3 2 0 9 261 289 290 262 +301 3 2 0 9 262 290 291 263 +302 3 2 0 9 263 291 292 264 +303 3 2 0 9 264 292 293 265 +304 3 2 0 9 265 293 294 266 +305 3 2 0 9 266 294 295 267 +306 3 2 0 9 267 295 296 268 +307 3 2 0 9 268 296 297 269 +308 3 2 0 9 269 297 298 270 +309 3 2 0 9 270 298 299 271 +310 3 2 0 9 271 299 300 272 +311 3 2 0 9 272 300 301 273 +312 3 2 0 9 273 301 302 274 +313 3 2 0 9 274 302 303 275 +314 3 2 0 9 275 303 304 276 +315 3 2 0 9 276 304 305 277 +316 3 2 0 9 277 305 306 278 +317 3 2 0 9 278 306 307 279 +318 3 2 0 9 279 307 308 280 +319 3 2 0 9 280 308 309 281 +320 3 2 0 9 281 309 310 282 +321 3 2 0 9 282 310 311 283 +322 3 2 0 9 283 311 312 284 +323 3 2 0 9 284 312 313 285 +324 3 2 0 9 285 313 314 286 +325 3 2 0 9 286 314 171 172 +326 3 2 0 9 94 95 315 287 +327 3 2 0 9 287 315 316 288 +328 3 2 0 9 288 316 317 289 +329 3 2 0 9 289 317 318 290 +330 3 2 0 9 290 318 319 291 +331 3 2 0 9 291 319 320 292 +332 3 2 0 9 292 320 321 293 +333 3 2 0 9 293 321 322 294 +334 3 2 0 9 294 322 323 295 +335 3 2 0 9 295 323 324 296 +336 3 2 0 9 296 324 325 297 +337 3 2 0 9 297 325 326 298 +338 3 2 0 9 298 326 327 299 +339 3 2 0 9 299 327 328 300 +340 3 2 0 9 300 328 329 301 +341 3 2 0 9 301 329 330 302 +342 3 2 0 9 302 330 331 303 +343 3 2 0 9 303 331 332 304 +344 3 2 0 9 304 332 333 305 +345 3 2 0 9 305 333 334 306 +346 3 2 0 9 306 334 335 307 +347 3 2 0 9 307 335 336 308 +348 3 2 0 9 308 336 337 309 +349 3 2 0 9 309 337 338 310 +350 3 2 0 9 310 338 339 311 +351 3 2 0 9 311 339 340 312 +352 3 2 0 9 312 340 341 313 +353 3 2 0 9 313 341 342 314 +354 3 2 0 9 314 342 170 171 +355 3 2 0 9 95 96 343 315 +356 3 2 0 9 315 343 344 316 +357 3 2 0 9 316 344 345 317 +358 3 2 0 9 317 345 346 318 +359 3 2 0 9 318 346 347 319 +360 3 2 0 9 319 347 348 320 +361 3 2 0 9 320 348 349 321 +362 3 2 0 9 321 349 350 322 +363 3 2 0 9 322 350 351 323 +364 3 2 0 9 323 351 352 324 +365 3 2 0 9 324 352 353 325 +366 3 2 0 9 325 353 354 326 +367 3 2 0 9 326 354 355 327 +368 3 2 0 9 327 355 356 328 +369 3 2 0 9 328 356 357 329 +370 3 2 0 9 329 357 358 330 +371 3 2 0 9 330 358 359 331 +372 3 2 0 9 331 359 360 332 +373 3 2 0 9 332 360 361 333 +374 3 2 0 9 333 361 362 334 +375 3 2 0 9 334 362 363 335 +376 3 2 0 9 335 363 364 336 +377 3 2 0 9 336 364 365 337 +378 3 2 0 9 337 365 366 338 +379 3 2 0 9 338 366 367 339 +380 3 2 0 9 339 367 368 340 +381 3 2 0 9 340 368 369 341 +382 3 2 0 9 341 369 370 342 +383 3 2 0 9 342 370 169 170 +384 3 2 0 9 96 97 371 343 +385 3 2 0 9 343 371 372 344 +386 3 2 0 9 344 372 373 345 +387 3 2 0 9 345 373 374 346 +388 3 2 0 9 346 374 375 347 +389 3 2 0 9 347 375 376 348 +390 3 2 0 9 348 376 377 349 +391 3 2 0 9 349 377 378 350 +392 3 2 0 9 350 378 379 351 +393 3 2 0 9 351 379 380 352 +394 3 2 0 9 352 380 381 353 +395 3 2 0 9 353 381 382 354 +396 3 2 0 9 354 382 383 355 +397 3 2 0 9 355 383 384 356 +398 3 2 0 9 356 384 385 357 +399 3 2 0 9 357 385 386 358 +400 3 2 0 9 358 386 387 359 +401 3 2 0 9 359 387 388 360 +402 3 2 0 9 360 388 389 361 +403 3 2 0 9 361 389 390 362 +404 3 2 0 9 362 390 391 363 +405 3 2 0 9 363 391 392 364 +406 3 2 0 9 364 392 393 365 +407 3 2 0 9 365 393 394 366 +408 3 2 0 9 366 394 395 367 +409 3 2 0 9 367 395 396 368 +410 3 2 0 9 368 396 397 369 +411 3 2 0 9 369 397 398 370 +412 3 2 0 9 370 398 168 169 +413 3 2 0 9 97 98 399 371 +414 3 2 0 9 371 399 400 372 +415 3 2 0 9 372 400 401 373 +416 3 2 0 9 373 401 402 374 +417 3 2 0 9 374 402 403 375 +418 3 2 0 9 375 403 404 376 +419 3 2 0 9 376 404 405 377 +420 3 2 0 9 377 405 406 378 +421 3 2 0 9 378 406 407 379 +422 3 2 0 9 379 407 408 380 +423 3 2 0 9 380 408 409 381 +424 3 2 0 9 381 409 410 382 +425 3 2 0 9 382 410 411 383 +426 3 2 0 9 383 411 412 384 +427 3 2 0 9 384 412 413 385 +428 3 2 0 9 385 413 414 386 +429 3 2 0 9 386 414 415 387 +430 3 2 0 9 387 415 416 388 +431 3 2 0 9 388 416 417 389 +432 3 2 0 9 389 417 418 390 +433 3 2 0 9 390 418 419 391 +434 3 2 0 9 391 419 420 392 +435 3 2 0 9 392 420 421 393 +436 3 2 0 9 393 421 422 394 +437 3 2 0 9 394 422 423 395 +438 3 2 0 9 395 423 424 396 +439 3 2 0 9 396 424 425 397 +440 3 2 0 9 397 425 426 398 +441 3 2 0 9 398 426 167 168 +442 3 2 0 9 98 99 427 399 +443 3 2 0 9 399 427 428 400 +444 3 2 0 9 400 428 429 401 +445 3 2 0 9 401 429 430 402 +446 3 2 0 9 402 430 431 403 +447 3 2 0 9 403 431 432 404 +448 3 2 0 9 404 432 433 405 +449 3 2 0 9 405 433 434 406 +450 3 2 0 9 406 434 435 407 +451 3 2 0 9 407 435 436 408 +452 3 2 0 9 408 436 437 409 +453 3 2 0 9 409 437 438 410 +454 3 2 0 9 410 438 439 411 +455 3 2 0 9 411 439 440 412 +456 3 2 0 9 412 440 441 413 +457 3 2 0 9 413 441 442 414 +458 3 2 0 9 414 442 443 415 +459 3 2 0 9 415 443 444 416 +460 3 2 0 9 416 444 445 417 +461 3 2 0 9 417 445 446 418 +462 3 2 0 9 418 446 447 419 +463 3 2 0 9 419 447 448 420 +464 3 2 0 9 420 448 449 421 +465 3 2 0 9 421 449 450 422 +466 3 2 0 9 422 450 451 423 +467 3 2 0 9 423 451 452 424 +468 3 2 0 9 424 452 453 425 +469 3 2 0 9 425 453 454 426 +470 3 2 0 9 426 454 166 167 +471 3 2 0 9 99 100 455 427 +472 3 2 0 9 427 455 456 428 +473 3 2 0 9 428 456 457 429 +474 3 2 0 9 429 457 458 430 +475 3 2 0 9 430 458 459 431 +476 3 2 0 9 431 459 460 432 +477 3 2 0 9 432 460 461 433 +478 3 2 0 9 433 461 462 434 +479 3 2 0 9 434 462 463 435 +480 3 2 0 9 435 463 464 436 +481 3 2 0 9 436 464 465 437 +482 3 2 0 9 437 465 466 438 +483 3 2 0 9 438 466 467 439 +484 3 2 0 9 439 467 468 440 +485 3 2 0 9 440 468 469 441 +486 3 2 0 9 441 469 470 442 +487 3 2 0 9 442 470 471 443 +488 3 2 0 9 443 471 472 444 +489 3 2 0 9 444 472 473 445 +490 3 2 0 9 445 473 474 446 +491 3 2 0 9 446 474 475 447 +492 3 2 0 9 447 475 476 448 +493 3 2 0 9 448 476 477 449 +494 3 2 0 9 449 477 478 450 +495 3 2 0 9 450 478 479 451 +496 3 2 0 9 451 479 480 452 +497 3 2 0 9 452 480 481 453 +498 3 2 0 9 453 481 482 454 +499 3 2 0 9 454 482 165 166 +500 3 2 0 9 100 101 483 455 +501 3 2 0 9 455 483 484 456 +502 3 2 0 9 456 484 485 457 +503 3 2 0 9 457 485 486 458 +504 3 2 0 9 458 486 487 459 +505 3 2 0 9 459 487 488 460 +506 3 2 0 9 460 488 489 461 +507 3 2 0 9 461 489 490 462 +508 3 2 0 9 462 490 491 463 +509 3 2 0 9 463 491 492 464 +510 3 2 0 9 464 492 493 465 +511 3 2 0 9 465 493 494 466 +512 3 2 0 9 466 494 495 467 +513 3 2 0 9 467 495 496 468 +514 3 2 0 9 468 496 497 469 +515 3 2 0 9 469 497 498 470 +516 3 2 0 9 470 498 499 471 +517 3 2 0 9 471 499 500 472 +518 3 2 0 9 472 500 501 473 +519 3 2 0 9 473 501 502 474 +520 3 2 0 9 474 502 503 475 +521 3 2 0 9 475 503 504 476 +522 3 2 0 9 476 504 505 477 +523 3 2 0 9 477 505 506 478 +524 3 2 0 9 478 506 507 479 +525 3 2 0 9 479 507 508 480 +526 3 2 0 9 480 508 509 481 +527 3 2 0 9 481 509 510 482 +528 3 2 0 9 482 510 164 165 +529 3 2 0 9 101 102 511 483 +530 3 2 0 9 483 511 512 484 +531 3 2 0 9 484 512 513 485 +532 3 2 0 9 485 513 514 486 +533 3 2 0 9 486 514 515 487 +534 3 2 0 9 487 515 516 488 +535 3 2 0 9 488 516 517 489 +536 3 2 0 9 489 517 518 490 +537 3 2 0 9 490 518 519 491 +538 3 2 0 9 491 519 520 492 +539 3 2 0 9 492 520 521 493 +540 3 2 0 9 493 521 522 494 +541 3 2 0 9 494 522 523 495 +542 3 2 0 9 495 523 524 496 +543 3 2 0 9 496 524 525 497 +544 3 2 0 9 497 525 526 498 +545 3 2 0 9 498 526 527 499 +546 3 2 0 9 499 527 528 500 +547 3 2 0 9 500 528 529 501 +548 3 2 0 9 501 529 530 502 +549 3 2 0 9 502 530 531 503 +550 3 2 0 9 503 531 532 504 +551 3 2 0 9 504 532 533 505 +552 3 2 0 9 505 533 534 506 +553 3 2 0 9 506 534 535 507 +554 3 2 0 9 507 535 536 508 +555 3 2 0 9 508 536 537 509 +556 3 2 0 9 509 537 538 510 +557 3 2 0 9 510 538 163 164 +558 3 2 0 9 102 103 539 511 +559 3 2 0 9 511 539 540 512 +560 3 2 0 9 512 540 541 513 +561 3 2 0 9 513 541 542 514 +562 3 2 0 9 514 542 543 515 +563 3 2 0 9 515 543 544 516 +564 3 2 0 9 516 544 545 517 +565 3 2 0 9 517 545 546 518 +566 3 2 0 9 518 546 547 519 +567 3 2 0 9 519 547 548 520 +568 3 2 0 9 520 548 549 521 +569 3 2 0 9 521 549 550 522 +570 3 2 0 9 522 550 551 523 +571 3 2 0 9 523 551 552 524 +572 3 2 0 9 524 552 553 525 +573 3 2 0 9 525 553 554 526 +574 3 2 0 9 526 554 555 527 +575 3 2 0 9 527 555 556 528 +576 3 2 0 9 528 556 557 529 +577 3 2 0 9 529 557 558 530 +578 3 2 0 9 530 558 559 531 +579 3 2 0 9 531 559 560 532 +580 3 2 0 9 532 560 561 533 +581 3 2 0 9 533 561 562 534 +582 3 2 0 9 534 562 563 535 +583 3 2 0 9 535 563 564 536 +584 3 2 0 9 536 564 565 537 +585 3 2 0 9 537 565 566 538 +586 3 2 0 9 538 566 162 163 +587 3 2 0 9 103 104 567 539 +588 3 2 0 9 539 567 568 540 +589 3 2 0 9 540 568 569 541 +590 3 2 0 9 541 569 570 542 +591 3 2 0 9 542 570 571 543 +592 3 2 0 9 543 571 572 544 +593 3 2 0 9 544 572 573 545 +594 3 2 0 9 545 573 574 546 +595 3 2 0 9 546 574 575 547 +596 3 2 0 9 547 575 576 548 +597 3 2 0 9 548 576 577 549 +598 3 2 0 9 549 577 578 550 +599 3 2 0 9 550 578 579 551 +600 3 2 0 9 551 579 580 552 +601 3 2 0 9 552 580 581 553 +602 3 2 0 9 553 581 582 554 +603 3 2 0 9 554 582 583 555 +604 3 2 0 9 555 583 584 556 +605 3 2 0 9 556 584 585 557 +606 3 2 0 9 557 585 586 558 +607 3 2 0 9 558 586 587 559 +608 3 2 0 9 559 587 588 560 +609 3 2 0 9 560 588 589 561 +610 3 2 0 9 561 589 590 562 +611 3 2 0 9 562 590 591 563 +612 3 2 0 9 563 591 592 564 +613 3 2 0 9 564 592 593 565 +614 3 2 0 9 565 593 594 566 +615 3 2 0 9 566 594 161 162 +616 3 2 0 9 104 105 595 567 +617 3 2 0 9 567 595 596 568 +618 3 2 0 9 568 596 597 569 +619 3 2 0 9 569 597 598 570 +620 3 2 0 9 570 598 599 571 +621 3 2 0 9 571 599 600 572 +622 3 2 0 9 572 600 601 573 +623 3 2 0 9 573 601 602 574 +624 3 2 0 9 574 602 603 575 +625 3 2 0 9 575 603 604 576 +626 3 2 0 9 576 604 605 577 +627 3 2 0 9 577 605 606 578 +628 3 2 0 9 578 606 607 579 +629 3 2 0 9 579 607 608 580 +630 3 2 0 9 580 608 609 581 +631 3 2 0 9 581 609 610 582 +632 3 2 0 9 582 610 611 583 +633 3 2 0 9 583 611 612 584 +634 3 2 0 9 584 612 613 585 +635 3 2 0 9 585 613 614 586 +636 3 2 0 9 586 614 615 587 +637 3 2 0 9 587 615 616 588 +638 3 2 0 9 588 616 617 589 +639 3 2 0 9 589 617 618 590 +640 3 2 0 9 590 618 619 591 +641 3 2 0 9 591 619 620 592 +642 3 2 0 9 592 620 621 593 +643 3 2 0 9 593 621 622 594 +644 3 2 0 9 594 622 160 161 +645 3 2 0 9 105 106 623 595 +646 3 2 0 9 595 623 624 596 +647 3 2 0 9 596 624 625 597 +648 3 2 0 9 597 625 626 598 +649 3 2 0 9 598 626 627 599 +650 3 2 0 9 599 627 628 600 +651 3 2 0 9 600 628 629 601 +652 3 2 0 9 601 629 630 602 +653 3 2 0 9 602 630 631 603 +654 3 2 0 9 603 631 632 604 +655 3 2 0 9 604 632 633 605 +656 3 2 0 9 605 633 634 606 +657 3 2 0 9 606 634 635 607 +658 3 2 0 9 607 635 636 608 +659 3 2 0 9 608 636 637 609 +660 3 2 0 9 609 637 638 610 +661 3 2 0 9 610 638 639 611 +662 3 2 0 9 611 639 640 612 +663 3 2 0 9 612 640 641 613 +664 3 2 0 9 613 641 642 614 +665 3 2 0 9 614 642 643 615 +666 3 2 0 9 615 643 644 616 +667 3 2 0 9 616 644 645 617 +668 3 2 0 9 617 645 646 618 +669 3 2 0 9 618 646 647 619 +670 3 2 0 9 619 647 648 620 +671 3 2 0 9 620 648 649 621 +672 3 2 0 9 621 649 650 622 +673 3 2 0 9 622 650 159 160 +674 3 2 0 9 106 107 651 623 +675 3 2 0 9 623 651 652 624 +676 3 2 0 9 624 652 653 625 +677 3 2 0 9 625 653 654 626 +678 3 2 0 9 626 654 655 627 +679 3 2 0 9 627 655 656 628 +680 3 2 0 9 628 656 657 629 +681 3 2 0 9 629 657 658 630 +682 3 2 0 9 630 658 659 631 +683 3 2 0 9 631 659 660 632 +684 3 2 0 9 632 660 661 633 +685 3 2 0 9 633 661 662 634 +686 3 2 0 9 634 662 663 635 +687 3 2 0 9 635 663 664 636 +688 3 2 0 9 636 664 665 637 +689 3 2 0 9 637 665 666 638 +690 3 2 0 9 638 666 667 639 +691 3 2 0 9 639 667 668 640 +692 3 2 0 9 640 668 669 641 +693 3 2 0 9 641 669 670 642 +694 3 2 0 9 642 670 671 643 +695 3 2 0 9 643 671 672 644 +696 3 2 0 9 644 672 673 645 +697 3 2 0 9 645 673 674 646 +698 3 2 0 9 646 674 675 647 +699 3 2 0 9 647 675 676 648 +700 3 2 0 9 648 676 677 649 +701 3 2 0 9 649 677 678 650 +702 3 2 0 9 650 678 158 159 +703 3 2 0 9 107 108 679 651 +704 3 2 0 9 651 679 680 652 +705 3 2 0 9 652 680 681 653 +706 3 2 0 9 653 681 682 654 +707 3 2 0 9 654 682 683 655 +708 3 2 0 9 655 683 684 656 +709 3 2 0 9 656 684 685 657 +710 3 2 0 9 657 685 686 658 +711 3 2 0 9 658 686 687 659 +712 3 2 0 9 659 687 688 660 +713 3 2 0 9 660 688 689 661 +714 3 2 0 9 661 689 690 662 +715 3 2 0 9 662 690 691 663 +716 3 2 0 9 663 691 692 664 +717 3 2 0 9 664 692 693 665 +718 3 2 0 9 665 693 694 666 +719 3 2 0 9 666 694 695 667 +720 3 2 0 9 667 695 696 668 +721 3 2 0 9 668 696 697 669 +722 3 2 0 9 669 697 698 670 +723 3 2 0 9 670 698 699 671 +724 3 2 0 9 671 699 700 672 +725 3 2 0 9 672 700 701 673 +726 3 2 0 9 673 701 702 674 +727 3 2 0 9 674 702 703 675 +728 3 2 0 9 675 703 704 676 +729 3 2 0 9 676 704 705 677 +730 3 2 0 9 677 705 706 678 +731 3 2 0 9 678 706 157 158 +732 3 2 0 9 108 109 707 679 +733 3 2 0 9 679 707 708 680 +734 3 2 0 9 680 708 709 681 +735 3 2 0 9 681 709 710 682 +736 3 2 0 9 682 710 711 683 +737 3 2 0 9 683 711 712 684 +738 3 2 0 9 684 712 713 685 +739 3 2 0 9 685 713 714 686 +740 3 2 0 9 686 714 715 687 +741 3 2 0 9 687 715 716 688 +742 3 2 0 9 688 716 717 689 +743 3 2 0 9 689 717 718 690 +744 3 2 0 9 690 718 719 691 +745 3 2 0 9 691 719 720 692 +746 3 2 0 9 692 720 721 693 +747 3 2 0 9 693 721 722 694 +748 3 2 0 9 694 722 723 695 +749 3 2 0 9 695 723 724 696 +750 3 2 0 9 696 724 725 697 +751 3 2 0 9 697 725 726 698 +752 3 2 0 9 698 726 727 699 +753 3 2 0 9 699 727 728 700 +754 3 2 0 9 700 728 729 701 +755 3 2 0 9 701 729 730 702 +756 3 2 0 9 702 730 731 703 +757 3 2 0 9 703 731 732 704 +758 3 2 0 9 704 732 733 705 +759 3 2 0 9 705 733 734 706 +760 3 2 0 9 706 734 156 157 +761 3 2 0 9 109 110 735 707 +762 3 2 0 9 707 735 736 708 +763 3 2 0 9 708 736 737 709 +764 3 2 0 9 709 737 738 710 +765 3 2 0 9 710 738 739 711 +766 3 2 0 9 711 739 740 712 +767 3 2 0 9 712 740 741 713 +768 3 2 0 9 713 741 742 714 +769 3 2 0 9 714 742 743 715 +770 3 2 0 9 715 743 744 716 +771 3 2 0 9 716 744 745 717 +772 3 2 0 9 717 745 746 718 +773 3 2 0 9 718 746 747 719 +774 3 2 0 9 719 747 748 720 +775 3 2 0 9 720 748 749 721 +776 3 2 0 9 721 749 750 722 +777 3 2 0 9 722 750 751 723 +778 3 2 0 9 723 751 752 724 +779 3 2 0 9 724 752 753 725 +780 3 2 0 9 725 753 754 726 +781 3 2 0 9 726 754 755 727 +782 3 2 0 9 727 755 756 728 +783 3 2 0 9 728 756 757 729 +784 3 2 0 9 729 757 758 730 +785 3 2 0 9 730 758 759 731 +786 3 2 0 9 731 759 760 732 +787 3 2 0 9 732 760 761 733 +788 3 2 0 9 733 761 762 734 +789 3 2 0 9 734 762 155 156 +790 3 2 0 9 110 111 763 735 +791 3 2 0 9 735 763 764 736 +792 3 2 0 9 736 764 765 737 +793 3 2 0 9 737 765 766 738 +794 3 2 0 9 738 766 767 739 +795 3 2 0 9 739 767 768 740 +796 3 2 0 9 740 768 769 741 +797 3 2 0 9 741 769 770 742 +798 3 2 0 9 742 770 771 743 +799 3 2 0 9 743 771 772 744 +800 3 2 0 9 744 772 773 745 +801 3 2 0 9 745 773 774 746 +802 3 2 0 9 746 774 775 747 +803 3 2 0 9 747 775 776 748 +804 3 2 0 9 748 776 777 749 +805 3 2 0 9 749 777 778 750 +806 3 2 0 9 750 778 779 751 +807 3 2 0 9 751 779 780 752 +808 3 2 0 9 752 780 781 753 +809 3 2 0 9 753 781 782 754 +810 3 2 0 9 754 782 783 755 +811 3 2 0 9 755 783 784 756 +812 3 2 0 9 756 784 785 757 +813 3 2 0 9 757 785 786 758 +814 3 2 0 9 758 786 787 759 +815 3 2 0 9 759 787 788 760 +816 3 2 0 9 760 788 789 761 +817 3 2 0 9 761 789 790 762 +818 3 2 0 9 762 790 154 155 +819 3 2 0 9 111 112 791 763 +820 3 2 0 9 763 791 792 764 +821 3 2 0 9 764 792 793 765 +822 3 2 0 9 765 793 794 766 +823 3 2 0 9 766 794 795 767 +824 3 2 0 9 767 795 796 768 +825 3 2 0 9 768 796 797 769 +826 3 2 0 9 769 797 798 770 +827 3 2 0 9 770 798 799 771 +828 3 2 0 9 771 799 800 772 +829 3 2 0 9 772 800 801 773 +830 3 2 0 9 773 801 802 774 +831 3 2 0 9 774 802 803 775 +832 3 2 0 9 775 803 804 776 +833 3 2 0 9 776 804 805 777 +834 3 2 0 9 777 805 806 778 +835 3 2 0 9 778 806 807 779 +836 3 2 0 9 779 807 808 780 +837 3 2 0 9 780 808 809 781 +838 3 2 0 9 781 809 810 782 +839 3 2 0 9 782 810 811 783 +840 3 2 0 9 783 811 812 784 +841 3 2 0 9 784 812 813 785 +842 3 2 0 9 785 813 814 786 +843 3 2 0 9 786 814 815 787 +844 3 2 0 9 787 815 816 788 +845 3 2 0 9 788 816 817 789 +846 3 2 0 9 789 817 818 790 +847 3 2 0 9 790 818 153 154 +848 3 2 0 9 112 113 819 791 +849 3 2 0 9 791 819 820 792 +850 3 2 0 9 792 820 821 793 +851 3 2 0 9 793 821 822 794 +852 3 2 0 9 794 822 823 795 +853 3 2 0 9 795 823 824 796 +854 3 2 0 9 796 824 825 797 +855 3 2 0 9 797 825 826 798 +856 3 2 0 9 798 826 827 799 +857 3 2 0 9 799 827 828 800 +858 3 2 0 9 800 828 829 801 +859 3 2 0 9 801 829 830 802 +860 3 2 0 9 802 830 831 803 +861 3 2 0 9 803 831 832 804 +862 3 2 0 9 804 832 833 805 +863 3 2 0 9 805 833 834 806 +864 3 2 0 9 806 834 835 807 +865 3 2 0 9 807 835 836 808 +866 3 2 0 9 808 836 837 809 +867 3 2 0 9 809 837 838 810 +868 3 2 0 9 810 838 839 811 +869 3 2 0 9 811 839 840 812 +870 3 2 0 9 812 840 841 813 +871 3 2 0 9 813 841 842 814 +872 3 2 0 9 814 842 843 815 +873 3 2 0 9 815 843 844 816 +874 3 2 0 9 816 844 845 817 +875 3 2 0 9 817 845 846 818 +876 3 2 0 9 818 846 152 153 +877 3 2 0 9 113 114 847 819 +878 3 2 0 9 819 847 848 820 +879 3 2 0 9 820 848 849 821 +880 3 2 0 9 821 849 850 822 +881 3 2 0 9 822 850 851 823 +882 3 2 0 9 823 851 852 824 +883 3 2 0 9 824 852 853 825 +884 3 2 0 9 825 853 854 826 +885 3 2 0 9 826 854 855 827 +886 3 2 0 9 827 855 856 828 +887 3 2 0 9 828 856 857 829 +888 3 2 0 9 829 857 858 830 +889 3 2 0 9 830 858 859 831 +890 3 2 0 9 831 859 860 832 +891 3 2 0 9 832 860 861 833 +892 3 2 0 9 833 861 862 834 +893 3 2 0 9 834 862 863 835 +894 3 2 0 9 835 863 864 836 +895 3 2 0 9 836 864 865 837 +896 3 2 0 9 837 865 866 838 +897 3 2 0 9 838 866 867 839 +898 3 2 0 9 839 867 868 840 +899 3 2 0 9 840 868 869 841 +900 3 2 0 9 841 869 870 842 +901 3 2 0 9 842 870 871 843 +902 3 2 0 9 843 871 872 844 +903 3 2 0 9 844 872 873 845 +904 3 2 0 9 845 873 874 846 +905 3 2 0 9 846 874 151 152 +906 3 2 0 9 114 115 875 847 +907 3 2 0 9 847 875 876 848 +908 3 2 0 9 848 876 877 849 +909 3 2 0 9 849 877 878 850 +910 3 2 0 9 850 878 879 851 +911 3 2 0 9 851 879 880 852 +912 3 2 0 9 852 880 881 853 +913 3 2 0 9 853 881 882 854 +914 3 2 0 9 854 882 883 855 +915 3 2 0 9 855 883 884 856 +916 3 2 0 9 856 884 885 857 +917 3 2 0 9 857 885 886 858 +918 3 2 0 9 858 886 887 859 +919 3 2 0 9 859 887 888 860 +920 3 2 0 9 860 888 889 861 +921 3 2 0 9 861 889 890 862 +922 3 2 0 9 862 890 891 863 +923 3 2 0 9 863 891 892 864 +924 3 2 0 9 864 892 893 865 +925 3 2 0 9 865 893 894 866 +926 3 2 0 9 866 894 895 867 +927 3 2 0 9 867 895 896 868 +928 3 2 0 9 868 896 897 869 +929 3 2 0 9 869 897 898 870 +930 3 2 0 9 870 898 899 871 +931 3 2 0 9 871 899 900 872 +932 3 2 0 9 872 900 901 873 +933 3 2 0 9 873 901 902 874 +934 3 2 0 9 874 902 150 151 +935 3 2 0 9 115 116 903 875 +936 3 2 0 9 875 903 904 876 +937 3 2 0 9 876 904 905 877 +938 3 2 0 9 877 905 906 878 +939 3 2 0 9 878 906 907 879 +940 3 2 0 9 879 907 908 880 +941 3 2 0 9 880 908 909 881 +942 3 2 0 9 881 909 910 882 +943 3 2 0 9 882 910 911 883 +944 3 2 0 9 883 911 912 884 +945 3 2 0 9 884 912 913 885 +946 3 2 0 9 885 913 914 886 +947 3 2 0 9 886 914 915 887 +948 3 2 0 9 887 915 916 888 +949 3 2 0 9 888 916 917 889 +950 3 2 0 9 889 917 918 890 +951 3 2 0 9 890 918 919 891 +952 3 2 0 9 891 919 920 892 +953 3 2 0 9 892 920 921 893 +954 3 2 0 9 893 921 922 894 +955 3 2 0 9 894 922 923 895 +956 3 2 0 9 895 923 924 896 +957 3 2 0 9 896 924 925 897 +958 3 2 0 9 897 925 926 898 +959 3 2 0 9 898 926 927 899 +960 3 2 0 9 899 927 928 900 +961 3 2 0 9 900 928 929 901 +962 3 2 0 9 901 929 930 902 +963 3 2 0 9 902 930 149 150 +964 3 2 0 9 116 117 931 903 +965 3 2 0 9 903 931 932 904 +966 3 2 0 9 904 932 933 905 +967 3 2 0 9 905 933 934 906 +968 3 2 0 9 906 934 935 907 +969 3 2 0 9 907 935 936 908 +970 3 2 0 9 908 936 937 909 +971 3 2 0 9 909 937 938 910 +972 3 2 0 9 910 938 939 911 +973 3 2 0 9 911 939 940 912 +974 3 2 0 9 912 940 941 913 +975 3 2 0 9 913 941 942 914 +976 3 2 0 9 914 942 943 915 +977 3 2 0 9 915 943 944 916 +978 3 2 0 9 916 944 945 917 +979 3 2 0 9 917 945 946 918 +980 3 2 0 9 918 946 947 919 +981 3 2 0 9 919 947 948 920 +982 3 2 0 9 920 948 949 921 +983 3 2 0 9 921 949 950 922 +984 3 2 0 9 922 950 951 923 +985 3 2 0 9 923 951 952 924 +986 3 2 0 9 924 952 953 925 +987 3 2 0 9 925 953 954 926 +988 3 2 0 9 926 954 955 927 +989 3 2 0 9 927 955 956 928 +990 3 2 0 9 928 956 957 929 +991 3 2 0 9 929 957 958 930 +992 3 2 0 9 930 958 148 149 +993 3 2 0 9 117 118 959 931 +994 3 2 0 9 931 959 960 932 +995 3 2 0 9 932 960 961 933 +996 3 2 0 9 933 961 962 934 +997 3 2 0 9 934 962 963 935 +998 3 2 0 9 935 963 964 936 +999 3 2 0 9 936 964 965 937 +1000 3 2 0 9 937 965 966 938 +1001 3 2 0 9 938 966 967 939 +1002 3 2 0 9 939 967 968 940 +1003 3 2 0 9 940 968 969 941 +1004 3 2 0 9 941 969 970 942 +1005 3 2 0 9 942 970 971 943 +1006 3 2 0 9 943 971 972 944 +1007 3 2 0 9 944 972 973 945 +1008 3 2 0 9 945 973 974 946 +1009 3 2 0 9 946 974 975 947 +1010 3 2 0 9 947 975 976 948 +1011 3 2 0 9 948 976 977 949 +1012 3 2 0 9 949 977 978 950 +1013 3 2 0 9 950 978 979 951 +1014 3 2 0 9 951 979 980 952 +1015 3 2 0 9 952 980 981 953 +1016 3 2 0 9 953 981 982 954 +1017 3 2 0 9 954 982 983 955 +1018 3 2 0 9 955 983 984 956 +1019 3 2 0 9 956 984 985 957 +1020 3 2 0 9 957 985 986 958 +1021 3 2 0 9 958 986 147 148 +1022 3 2 0 9 118 5 119 959 +1023 3 2 0 9 959 119 120 960 +1024 3 2 0 9 960 120 121 961 +1025 3 2 0 9 961 121 122 962 +1026 3 2 0 9 962 122 123 963 +1027 3 2 0 9 963 123 124 964 +1028 3 2 0 9 964 124 125 965 +1029 3 2 0 9 965 125 126 966 +1030 3 2 0 9 966 126 127 967 +1031 3 2 0 9 967 127 128 968 +1032 3 2 0 9 968 128 129 969 +1033 3 2 0 9 969 129 130 970 +1034 3 2 0 9 970 130 131 971 +1035 3 2 0 9 971 131 132 972 +1036 3 2 0 9 972 132 133 973 +1037 3 2 0 9 973 133 134 974 +1038 3 2 0 9 974 134 135 975 +1039 3 2 0 9 975 135 136 976 +1040 3 2 0 9 976 136 137 977 +1041 3 2 0 9 977 137 138 978 +1042 3 2 0 9 978 138 139 979 +1043 3 2 0 9 979 139 140 980 +1044 3 2 0 9 980 140 141 981 +1045 3 2 0 9 981 141 142 982 +1046 3 2 0 9 982 142 143 983 +1047 3 2 0 9 983 143 144 984 +1048 3 2 0 9 984 144 145 985 +1049 3 2 0 9 985 145 146 986 +1050 3 2 0 9 986 146 4 147 +1051 3 2 0 11 5 7 987 118 +1052 3 2 0 11 118 987 988 117 +1053 3 2 0 11 117 988 989 116 +1054 3 2 0 11 116 989 990 115 +1055 3 2 0 11 115 990 991 114 +1056 3 2 0 11 114 991 992 113 +1057 3 2 0 11 113 992 993 112 +1058 3 2 0 11 112 993 994 111 +1059 3 2 0 11 111 994 995 110 +1060 3 2 0 11 110 995 996 109 +1061 3 2 0 11 109 996 997 108 +1062 3 2 0 11 108 997 998 107 +1063 3 2 0 11 107 998 999 106 +1064 3 2 0 11 106 999 1000 105 +1065 3 2 0 11 105 1000 1001 104 +1066 3 2 0 11 104 1001 1002 103 +1067 3 2 0 11 103 1002 1003 102 +1068 3 2 0 11 102 1003 1004 101 +1069 3 2 0 11 101 1004 1005 100 +1070 3 2 0 11 100 1005 1006 99 +1071 3 2 0 11 99 1006 1007 98 +1072 3 2 0 11 98 1007 1008 97 +1073 3 2 0 11 97 1008 1009 96 +1074 3 2 0 11 96 1009 1010 95 +1075 3 2 0 11 95 1010 1011 94 +1076 3 2 0 11 94 1011 1012 93 +1077 3 2 0 11 93 1012 1013 92 +1078 3 2 0 11 92 1013 1014 91 +1079 3 2 0 11 91 1014 90 6 +1080 3 2 0 11 7 8 1015 987 +1081 3 2 0 11 987 1015 1016 988 +1082 3 2 0 11 988 1016 1017 989 +1083 3 2 0 11 989 1017 1018 990 +1084 3 2 0 11 990 1018 1019 991 +1085 3 2 0 11 991 1019 1020 992 +1086 3 2 0 11 992 1020 1021 993 +1087 3 2 0 11 993 1021 1022 994 +1088 3 2 0 11 994 1022 1023 995 +1089 3 2 0 11 995 1023 1024 996 +1090 3 2 0 11 996 1024 1025 997 +1091 3 2 0 11 997 1025 1026 998 +1092 3 2 0 11 998 1026 1027 999 +1093 3 2 0 11 999 1027 1028 1000 +1094 3 2 0 11 1000 1028 1029 1001 +1095 3 2 0 11 1001 1029 1030 1002 +1096 3 2 0 11 1002 1030 1031 1003 +1097 3 2 0 11 1003 1031 1032 1004 +1098 3 2 0 11 1004 1032 1033 1005 +1099 3 2 0 11 1005 1033 1034 1006 +1100 3 2 0 11 1006 1034 1035 1007 +1101 3 2 0 11 1007 1035 1036 1008 +1102 3 2 0 11 1008 1036 1037 1009 +1103 3 2 0 11 1009 1037 1038 1010 +1104 3 2 0 11 1010 1038 1039 1011 +1105 3 2 0 11 1011 1039 1040 1012 +1106 3 2 0 11 1012 1040 1041 1013 +1107 3 2 0 11 1013 1041 1042 1014 +1108 3 2 0 11 1014 1042 89 90 +1109 3 2 0 11 8 9 1043 1015 +1110 3 2 0 11 1015 1043 1044 1016 +1111 3 2 0 11 1016 1044 1045 1017 +1112 3 2 0 11 1017 1045 1046 1018 +1113 3 2 0 11 1018 1046 1047 1019 +1114 3 2 0 11 1019 1047 1048 1020 +1115 3 2 0 11 1020 1048 1049 1021 +1116 3 2 0 11 1021 1049 1050 1022 +1117 3 2 0 11 1022 1050 1051 1023 +1118 3 2 0 11 1023 1051 1052 1024 +1119 3 2 0 11 1024 1052 1053 1025 +1120 3 2 0 11 1025 1053 1054 1026 +1121 3 2 0 11 1026 1054 1055 1027 +1122 3 2 0 11 1027 1055 1056 1028 +1123 3 2 0 11 1028 1056 1057 1029 +1124 3 2 0 11 1029 1057 1058 1030 +1125 3 2 0 11 1030 1058 1059 1031 +1126 3 2 0 11 1031 1059 1060 1032 +1127 3 2 0 11 1032 1060 1061 1033 +1128 3 2 0 11 1033 1061 1062 1034 +1129 3 2 0 11 1034 1062 1063 1035 +1130 3 2 0 11 1035 1063 1064 1036 +1131 3 2 0 11 1036 1064 1065 1037 +1132 3 2 0 11 1037 1065 1066 1038 +1133 3 2 0 11 1038 1066 1067 1039 +1134 3 2 0 11 1039 1067 1068 1040 +1135 3 2 0 11 1040 1068 1069 1041 +1136 3 2 0 11 1041 1069 1070 1042 +1137 3 2 0 11 1042 1070 88 89 +1138 3 2 0 11 9 10 1071 1043 +1139 3 2 0 11 1043 1071 1072 1044 +1140 3 2 0 11 1044 1072 1073 1045 +1141 3 2 0 11 1045 1073 1074 1046 +1142 3 2 0 11 1046 1074 1075 1047 +1143 3 2 0 11 1047 1075 1076 1048 +1144 3 2 0 11 1048 1076 1077 1049 +1145 3 2 0 11 1049 1077 1078 1050 +1146 3 2 0 11 1050 1078 1079 1051 +1147 3 2 0 11 1051 1079 1080 1052 +1148 3 2 0 11 1052 1080 1081 1053 +1149 3 2 0 11 1053 1081 1082 1054 +1150 3 2 0 11 1054 1082 1083 1055 +1151 3 2 0 11 1055 1083 1084 1056 +1152 3 2 0 11 1056 1084 1085 1057 +1153 3 2 0 11 1057 1085 1086 1058 +1154 3 2 0 11 1058 1086 1087 1059 +1155 3 2 0 11 1059 1087 1088 1060 +1156 3 2 0 11 1060 1088 1089 1061 +1157 3 2 0 11 1061 1089 1090 1062 +1158 3 2 0 11 1062 1090 1091 1063 +1159 3 2 0 11 1063 1091 1092 1064 +1160 3 2 0 11 1064 1092 1093 1065 +1161 3 2 0 11 1065 1093 1094 1066 +1162 3 2 0 11 1066 1094 1095 1067 +1163 3 2 0 11 1067 1095 1096 1068 +1164 3 2 0 11 1068 1096 1097 1069 +1165 3 2 0 11 1069 1097 1098 1070 +1166 3 2 0 11 1070 1098 87 88 +1167 3 2 0 11 10 11 1099 1071 +1168 3 2 0 11 1071 1099 1100 1072 +1169 3 2 0 11 1072 1100 1101 1073 +1170 3 2 0 11 1073 1101 1102 1074 +1171 3 2 0 11 1074 1102 1103 1075 +1172 3 2 0 11 1075 1103 1104 1076 +1173 3 2 0 11 1076 1104 1105 1077 +1174 3 2 0 11 1077 1105 1106 1078 +1175 3 2 0 11 1078 1106 1107 1079 +1176 3 2 0 11 1079 1107 1108 1080 +1177 3 2 0 11 1080 1108 1109 1081 +1178 3 2 0 11 1081 1109 1110 1082 +1179 3 2 0 11 1082 1110 1111 1083 +1180 3 2 0 11 1083 1111 1112 1084 +1181 3 2 0 11 1084 1112 1113 1085 +1182 3 2 0 11 1085 1113 1114 1086 +1183 3 2 0 11 1086 1114 1115 1087 +1184 3 2 0 11 1087 1115 1116 1088 +1185 3 2 0 11 1088 1116 1117 1089 +1186 3 2 0 11 1089 1117 1118 1090 +1187 3 2 0 11 1090 1118 1119 1091 +1188 3 2 0 11 1091 1119 1120 1092 +1189 3 2 0 11 1092 1120 1121 1093 +1190 3 2 0 11 1093 1121 1122 1094 +1191 3 2 0 11 1094 1122 1123 1095 +1192 3 2 0 11 1095 1123 1124 1096 +1193 3 2 0 11 1096 1124 1125 1097 +1194 3 2 0 11 1097 1125 1126 1098 +1195 3 2 0 11 1098 1126 86 87 +1196 3 2 0 11 11 12 1127 1099 +1197 3 2 0 11 1099 1127 1128 1100 +1198 3 2 0 11 1100 1128 1129 1101 +1199 3 2 0 11 1101 1129 1130 1102 +1200 3 2 0 11 1102 1130 1131 1103 +1201 3 2 0 11 1103 1131 1132 1104 +1202 3 2 0 11 1104 1132 1133 1105 +1203 3 2 0 11 1105 1133 1134 1106 +1204 3 2 0 11 1106 1134 1135 1107 +1205 3 2 0 11 1107 1135 1136 1108 +1206 3 2 0 11 1108 1136 1137 1109 +1207 3 2 0 11 1109 1137 1138 1110 +1208 3 2 0 11 1110 1138 1139 1111 +1209 3 2 0 11 1111 1139 1140 1112 +1210 3 2 0 11 1112 1140 1141 1113 +1211 3 2 0 11 1113 1141 1142 1114 +1212 3 2 0 11 1114 1142 1143 1115 +1213 3 2 0 11 1115 1143 1144 1116 +1214 3 2 0 11 1116 1144 1145 1117 +1215 3 2 0 11 1117 1145 1146 1118 +1216 3 2 0 11 1118 1146 1147 1119 +1217 3 2 0 11 1119 1147 1148 1120 +1218 3 2 0 11 1120 1148 1149 1121 +1219 3 2 0 11 1121 1149 1150 1122 +1220 3 2 0 11 1122 1150 1151 1123 +1221 3 2 0 11 1123 1151 1152 1124 +1222 3 2 0 11 1124 1152 1153 1125 +1223 3 2 0 11 1125 1153 1154 1126 +1224 3 2 0 11 1126 1154 85 86 +1225 3 2 0 11 12 13 1155 1127 +1226 3 2 0 11 1127 1155 1156 1128 +1227 3 2 0 11 1128 1156 1157 1129 +1228 3 2 0 11 1129 1157 1158 1130 +1229 3 2 0 11 1130 1158 1159 1131 +1230 3 2 0 11 1131 1159 1160 1132 +1231 3 2 0 11 1132 1160 1161 1133 +1232 3 2 0 11 1133 1161 1162 1134 +1233 3 2 0 11 1134 1162 1163 1135 +1234 3 2 0 11 1135 1163 1164 1136 +1235 3 2 0 11 1136 1164 1165 1137 +1236 3 2 0 11 1137 1165 1166 1138 +1237 3 2 0 11 1138 1166 1167 1139 +1238 3 2 0 11 1139 1167 1168 1140 +1239 3 2 0 11 1140 1168 1169 1141 +1240 3 2 0 11 1141 1169 1170 1142 +1241 3 2 0 11 1142 1170 1171 1143 +1242 3 2 0 11 1143 1171 1172 1144 +1243 3 2 0 11 1144 1172 1173 1145 +1244 3 2 0 11 1145 1173 1174 1146 +1245 3 2 0 11 1146 1174 1175 1147 +1246 3 2 0 11 1147 1175 1176 1148 +1247 3 2 0 11 1148 1176 1177 1149 +1248 3 2 0 11 1149 1177 1178 1150 +1249 3 2 0 11 1150 1178 1179 1151 +1250 3 2 0 11 1151 1179 1180 1152 +1251 3 2 0 11 1152 1180 1181 1153 +1252 3 2 0 11 1153 1181 1182 1154 +1253 3 2 0 11 1154 1182 84 85 +1254 3 2 0 11 13 14 1183 1155 +1255 3 2 0 11 1155 1183 1184 1156 +1256 3 2 0 11 1156 1184 1185 1157 +1257 3 2 0 11 1157 1185 1186 1158 +1258 3 2 0 11 1158 1186 1187 1159 +1259 3 2 0 11 1159 1187 1188 1160 +1260 3 2 0 11 1160 1188 1189 1161 +1261 3 2 0 11 1161 1189 1190 1162 +1262 3 2 0 11 1162 1190 1191 1163 +1263 3 2 0 11 1163 1191 1192 1164 +1264 3 2 0 11 1164 1192 1193 1165 +1265 3 2 0 11 1165 1193 1194 1166 +1266 3 2 0 11 1166 1194 1195 1167 +1267 3 2 0 11 1167 1195 1196 1168 +1268 3 2 0 11 1168 1196 1197 1169 +1269 3 2 0 11 1169 1197 1198 1170 +1270 3 2 0 11 1170 1198 1199 1171 +1271 3 2 0 11 1171 1199 1200 1172 +1272 3 2 0 11 1172 1200 1201 1173 +1273 3 2 0 11 1173 1201 1202 1174 +1274 3 2 0 11 1174 1202 1203 1175 +1275 3 2 0 11 1175 1203 1204 1176 +1276 3 2 0 11 1176 1204 1205 1177 +1277 3 2 0 11 1177 1205 1206 1178 +1278 3 2 0 11 1178 1206 1207 1179 +1279 3 2 0 11 1179 1207 1208 1180 +1280 3 2 0 11 1180 1208 1209 1181 +1281 3 2 0 11 1181 1209 1210 1182 +1282 3 2 0 11 1182 1210 83 84 +1283 3 2 0 11 14 15 1211 1183 +1284 3 2 0 11 1183 1211 1212 1184 +1285 3 2 0 11 1184 1212 1213 1185 +1286 3 2 0 11 1185 1213 1214 1186 +1287 3 2 0 11 1186 1214 1215 1187 +1288 3 2 0 11 1187 1215 1216 1188 +1289 3 2 0 11 1188 1216 1217 1189 +1290 3 2 0 11 1189 1217 1218 1190 +1291 3 2 0 11 1190 1218 1219 1191 +1292 3 2 0 11 1191 1219 1220 1192 +1293 3 2 0 11 1192 1220 1221 1193 +1294 3 2 0 11 1193 1221 1222 1194 +1295 3 2 0 11 1194 1222 1223 1195 +1296 3 2 0 11 1195 1223 1224 1196 +1297 3 2 0 11 1196 1224 1225 1197 +1298 3 2 0 11 1197 1225 1226 1198 +1299 3 2 0 11 1198 1226 1227 1199 +1300 3 2 0 11 1199 1227 1228 1200 +1301 3 2 0 11 1200 1228 1229 1201 +1302 3 2 0 11 1201 1229 1230 1202 +1303 3 2 0 11 1202 1230 1231 1203 +1304 3 2 0 11 1203 1231 1232 1204 +1305 3 2 0 11 1204 1232 1233 1205 +1306 3 2 0 11 1205 1233 1234 1206 +1307 3 2 0 11 1206 1234 1235 1207 +1308 3 2 0 11 1207 1235 1236 1208 +1309 3 2 0 11 1208 1236 1237 1209 +1310 3 2 0 11 1209 1237 1238 1210 +1311 3 2 0 11 1210 1238 82 83 +1312 3 2 0 11 15 16 1239 1211 +1313 3 2 0 11 1211 1239 1240 1212 +1314 3 2 0 11 1212 1240 1241 1213 +1315 3 2 0 11 1213 1241 1242 1214 +1316 3 2 0 11 1214 1242 1243 1215 +1317 3 2 0 11 1215 1243 1244 1216 +1318 3 2 0 11 1216 1244 1245 1217 +1319 3 2 0 11 1217 1245 1246 1218 +1320 3 2 0 11 1218 1246 1247 1219 +1321 3 2 0 11 1219 1247 1248 1220 +1322 3 2 0 11 1220 1248 1249 1221 +1323 3 2 0 11 1221 1249 1250 1222 +1324 3 2 0 11 1222 1250 1251 1223 +1325 3 2 0 11 1223 1251 1252 1224 +1326 3 2 0 11 1224 1252 1253 1225 +1327 3 2 0 11 1225 1253 1254 1226 +1328 3 2 0 11 1226 1254 1255 1227 +1329 3 2 0 11 1227 1255 1256 1228 +1330 3 2 0 11 1228 1256 1257 1229 +1331 3 2 0 11 1229 1257 1258 1230 +1332 3 2 0 11 1230 1258 1259 1231 +1333 3 2 0 11 1231 1259 1260 1232 +1334 3 2 0 11 1232 1260 1261 1233 +1335 3 2 0 11 1233 1261 1262 1234 +1336 3 2 0 11 1234 1262 1263 1235 +1337 3 2 0 11 1235 1263 1264 1236 +1338 3 2 0 11 1236 1264 1265 1237 +1339 3 2 0 11 1237 1265 1266 1238 +1340 3 2 0 11 1238 1266 81 82 +1341 3 2 0 11 16 17 1267 1239 +1342 3 2 0 11 1239 1267 1268 1240 +1343 3 2 0 11 1240 1268 1269 1241 +1344 3 2 0 11 1241 1269 1270 1242 +1345 3 2 0 11 1242 1270 1271 1243 +1346 3 2 0 11 1243 1271 1272 1244 +1347 3 2 0 11 1244 1272 1273 1245 +1348 3 2 0 11 1245 1273 1274 1246 +1349 3 2 0 11 1246 1274 1275 1247 +1350 3 2 0 11 1247 1275 1276 1248 +1351 3 2 0 11 1248 1276 1277 1249 +1352 3 2 0 11 1249 1277 1278 1250 +1353 3 2 0 11 1250 1278 1279 1251 +1354 3 2 0 11 1251 1279 1280 1252 +1355 3 2 0 11 1252 1280 1281 1253 +1356 3 2 0 11 1253 1281 1282 1254 +1357 3 2 0 11 1254 1282 1283 1255 +1358 3 2 0 11 1255 1283 1284 1256 +1359 3 2 0 11 1256 1284 1285 1257 +1360 3 2 0 11 1257 1285 1286 1258 +1361 3 2 0 11 1258 1286 1287 1259 +1362 3 2 0 11 1259 1287 1288 1260 +1363 3 2 0 11 1260 1288 1289 1261 +1364 3 2 0 11 1261 1289 1290 1262 +1365 3 2 0 11 1262 1290 1291 1263 +1366 3 2 0 11 1263 1291 1292 1264 +1367 3 2 0 11 1264 1292 1293 1265 +1368 3 2 0 11 1265 1293 1294 1266 +1369 3 2 0 11 1266 1294 80 81 +1370 3 2 0 11 17 18 1295 1267 +1371 3 2 0 11 1267 1295 1296 1268 +1372 3 2 0 11 1268 1296 1297 1269 +1373 3 2 0 11 1269 1297 1298 1270 +1374 3 2 0 11 1270 1298 1299 1271 +1375 3 2 0 11 1271 1299 1300 1272 +1376 3 2 0 11 1272 1300 1301 1273 +1377 3 2 0 11 1273 1301 1302 1274 +1378 3 2 0 11 1274 1302 1303 1275 +1379 3 2 0 11 1275 1303 1304 1276 +1380 3 2 0 11 1276 1304 1305 1277 +1381 3 2 0 11 1277 1305 1306 1278 +1382 3 2 0 11 1278 1306 1307 1279 +1383 3 2 0 11 1279 1307 1308 1280 +1384 3 2 0 11 1280 1308 1309 1281 +1385 3 2 0 11 1281 1309 1310 1282 +1386 3 2 0 11 1282 1310 1311 1283 +1387 3 2 0 11 1283 1311 1312 1284 +1388 3 2 0 11 1284 1312 1313 1285 +1389 3 2 0 11 1285 1313 1314 1286 +1390 3 2 0 11 1286 1314 1315 1287 +1391 3 2 0 11 1287 1315 1316 1288 +1392 3 2 0 11 1288 1316 1317 1289 +1393 3 2 0 11 1289 1317 1318 1290 +1394 3 2 0 11 1290 1318 1319 1291 +1395 3 2 0 11 1291 1319 1320 1292 +1396 3 2 0 11 1292 1320 1321 1293 +1397 3 2 0 11 1293 1321 1322 1294 +1398 3 2 0 11 1294 1322 79 80 +1399 3 2 0 11 18 19 1323 1295 +1400 3 2 0 11 1295 1323 1324 1296 +1401 3 2 0 11 1296 1324 1325 1297 +1402 3 2 0 11 1297 1325 1326 1298 +1403 3 2 0 11 1298 1326 1327 1299 +1404 3 2 0 11 1299 1327 1328 1300 +1405 3 2 0 11 1300 1328 1329 1301 +1406 3 2 0 11 1301 1329 1330 1302 +1407 3 2 0 11 1302 1330 1331 1303 +1408 3 2 0 11 1303 1331 1332 1304 +1409 3 2 0 11 1304 1332 1333 1305 +1410 3 2 0 11 1305 1333 1334 1306 +1411 3 2 0 11 1306 1334 1335 1307 +1412 3 2 0 11 1307 1335 1336 1308 +1413 3 2 0 11 1308 1336 1337 1309 +1414 3 2 0 11 1309 1337 1338 1310 +1415 3 2 0 11 1310 1338 1339 1311 +1416 3 2 0 11 1311 1339 1340 1312 +1417 3 2 0 11 1312 1340 1341 1313 +1418 3 2 0 11 1313 1341 1342 1314 +1419 3 2 0 11 1314 1342 1343 1315 +1420 3 2 0 11 1315 1343 1344 1316 +1421 3 2 0 11 1316 1344 1345 1317 +1422 3 2 0 11 1317 1345 1346 1318 +1423 3 2 0 11 1318 1346 1347 1319 +1424 3 2 0 11 1319 1347 1348 1320 +1425 3 2 0 11 1320 1348 1349 1321 +1426 3 2 0 11 1321 1349 1350 1322 +1427 3 2 0 11 1322 1350 78 79 +1428 3 2 0 11 19 20 1351 1323 +1429 3 2 0 11 1323 1351 1352 1324 +1430 3 2 0 11 1324 1352 1353 1325 +1431 3 2 0 11 1325 1353 1354 1326 +1432 3 2 0 11 1326 1354 1355 1327 +1433 3 2 0 11 1327 1355 1356 1328 +1434 3 2 0 11 1328 1356 1357 1329 +1435 3 2 0 11 1329 1357 1358 1330 +1436 3 2 0 11 1330 1358 1359 1331 +1437 3 2 0 11 1331 1359 1360 1332 +1438 3 2 0 11 1332 1360 1361 1333 +1439 3 2 0 11 1333 1361 1362 1334 +1440 3 2 0 11 1334 1362 1363 1335 +1441 3 2 0 11 1335 1363 1364 1336 +1442 3 2 0 11 1336 1364 1365 1337 +1443 3 2 0 11 1337 1365 1366 1338 +1444 3 2 0 11 1338 1366 1367 1339 +1445 3 2 0 11 1339 1367 1368 1340 +1446 3 2 0 11 1340 1368 1369 1341 +1447 3 2 0 11 1341 1369 1370 1342 +1448 3 2 0 11 1342 1370 1371 1343 +1449 3 2 0 11 1343 1371 1372 1344 +1450 3 2 0 11 1344 1372 1373 1345 +1451 3 2 0 11 1345 1373 1374 1346 +1452 3 2 0 11 1346 1374 1375 1347 +1453 3 2 0 11 1347 1375 1376 1348 +1454 3 2 0 11 1348 1376 1377 1349 +1455 3 2 0 11 1349 1377 1378 1350 +1456 3 2 0 11 1350 1378 77 78 +1457 3 2 0 11 20 21 1379 1351 +1458 3 2 0 11 1351 1379 1380 1352 +1459 3 2 0 11 1352 1380 1381 1353 +1460 3 2 0 11 1353 1381 1382 1354 +1461 3 2 0 11 1354 1382 1383 1355 +1462 3 2 0 11 1355 1383 1384 1356 +1463 3 2 0 11 1356 1384 1385 1357 +1464 3 2 0 11 1357 1385 1386 1358 +1465 3 2 0 11 1358 1386 1387 1359 +1466 3 2 0 11 1359 1387 1388 1360 +1467 3 2 0 11 1360 1388 1389 1361 +1468 3 2 0 11 1361 1389 1390 1362 +1469 3 2 0 11 1362 1390 1391 1363 +1470 3 2 0 11 1363 1391 1392 1364 +1471 3 2 0 11 1364 1392 1393 1365 +1472 3 2 0 11 1365 1393 1394 1366 +1473 3 2 0 11 1366 1394 1395 1367 +1474 3 2 0 11 1367 1395 1396 1368 +1475 3 2 0 11 1368 1396 1397 1369 +1476 3 2 0 11 1369 1397 1398 1370 +1477 3 2 0 11 1370 1398 1399 1371 +1478 3 2 0 11 1371 1399 1400 1372 +1479 3 2 0 11 1372 1400 1401 1373 +1480 3 2 0 11 1373 1401 1402 1374 +1481 3 2 0 11 1374 1402 1403 1375 +1482 3 2 0 11 1375 1403 1404 1376 +1483 3 2 0 11 1376 1404 1405 1377 +1484 3 2 0 11 1377 1405 1406 1378 +1485 3 2 0 11 1378 1406 76 77 +1486 3 2 0 11 21 22 1407 1379 +1487 3 2 0 11 1379 1407 1408 1380 +1488 3 2 0 11 1380 1408 1409 1381 +1489 3 2 0 11 1381 1409 1410 1382 +1490 3 2 0 11 1382 1410 1411 1383 +1491 3 2 0 11 1383 1411 1412 1384 +1492 3 2 0 11 1384 1412 1413 1385 +1493 3 2 0 11 1385 1413 1414 1386 +1494 3 2 0 11 1386 1414 1415 1387 +1495 3 2 0 11 1387 1415 1416 1388 +1496 3 2 0 11 1388 1416 1417 1389 +1497 3 2 0 11 1389 1417 1418 1390 +1498 3 2 0 11 1390 1418 1419 1391 +1499 3 2 0 11 1391 1419 1420 1392 +1500 3 2 0 11 1392 1420 1421 1393 +1501 3 2 0 11 1393 1421 1422 1394 +1502 3 2 0 11 1394 1422 1423 1395 +1503 3 2 0 11 1395 1423 1424 1396 +1504 3 2 0 11 1396 1424 1425 1397 +1505 3 2 0 11 1397 1425 1426 1398 +1506 3 2 0 11 1398 1426 1427 1399 +1507 3 2 0 11 1399 1427 1428 1400 +1508 3 2 0 11 1400 1428 1429 1401 +1509 3 2 0 11 1401 1429 1430 1402 +1510 3 2 0 11 1402 1430 1431 1403 +1511 3 2 0 11 1403 1431 1432 1404 +1512 3 2 0 11 1404 1432 1433 1405 +1513 3 2 0 11 1405 1433 1434 1406 +1514 3 2 0 11 1406 1434 75 76 +1515 3 2 0 11 22 23 1435 1407 +1516 3 2 0 11 1407 1435 1436 1408 +1517 3 2 0 11 1408 1436 1437 1409 +1518 3 2 0 11 1409 1437 1438 1410 +1519 3 2 0 11 1410 1438 1439 1411 +1520 3 2 0 11 1411 1439 1440 1412 +1521 3 2 0 11 1412 1440 1441 1413 +1522 3 2 0 11 1413 1441 1442 1414 +1523 3 2 0 11 1414 1442 1443 1415 +1524 3 2 0 11 1415 1443 1444 1416 +1525 3 2 0 11 1416 1444 1445 1417 +1526 3 2 0 11 1417 1445 1446 1418 +1527 3 2 0 11 1418 1446 1447 1419 +1528 3 2 0 11 1419 1447 1448 1420 +1529 3 2 0 11 1420 1448 1449 1421 +1530 3 2 0 11 1421 1449 1450 1422 +1531 3 2 0 11 1422 1450 1451 1423 +1532 3 2 0 11 1423 1451 1452 1424 +1533 3 2 0 11 1424 1452 1453 1425 +1534 3 2 0 11 1425 1453 1454 1426 +1535 3 2 0 11 1426 1454 1455 1427 +1536 3 2 0 11 1427 1455 1456 1428 +1537 3 2 0 11 1428 1456 1457 1429 +1538 3 2 0 11 1429 1457 1458 1430 +1539 3 2 0 11 1430 1458 1459 1431 +1540 3 2 0 11 1431 1459 1460 1432 +1541 3 2 0 11 1432 1460 1461 1433 +1542 3 2 0 11 1433 1461 1462 1434 +1543 3 2 0 11 1434 1462 74 75 +1544 3 2 0 11 23 24 1463 1435 +1545 3 2 0 11 1435 1463 1464 1436 +1546 3 2 0 11 1436 1464 1465 1437 +1547 3 2 0 11 1437 1465 1466 1438 +1548 3 2 0 11 1438 1466 1467 1439 +1549 3 2 0 11 1439 1467 1468 1440 +1550 3 2 0 11 1440 1468 1469 1441 +1551 3 2 0 11 1441 1469 1470 1442 +1552 3 2 0 11 1442 1470 1471 1443 +1553 3 2 0 11 1443 1471 1472 1444 +1554 3 2 0 11 1444 1472 1473 1445 +1555 3 2 0 11 1445 1473 1474 1446 +1556 3 2 0 11 1446 1474 1475 1447 +1557 3 2 0 11 1447 1475 1476 1448 +1558 3 2 0 11 1448 1476 1477 1449 +1559 3 2 0 11 1449 1477 1478 1450 +1560 3 2 0 11 1450 1478 1479 1451 +1561 3 2 0 11 1451 1479 1480 1452 +1562 3 2 0 11 1452 1480 1481 1453 +1563 3 2 0 11 1453 1481 1482 1454 +1564 3 2 0 11 1454 1482 1483 1455 +1565 3 2 0 11 1455 1483 1484 1456 +1566 3 2 0 11 1456 1484 1485 1457 +1567 3 2 0 11 1457 1485 1486 1458 +1568 3 2 0 11 1458 1486 1487 1459 +1569 3 2 0 11 1459 1487 1488 1460 +1570 3 2 0 11 1460 1488 1489 1461 +1571 3 2 0 11 1461 1489 1490 1462 +1572 3 2 0 11 1462 1490 73 74 +1573 3 2 0 11 24 25 1491 1463 +1574 3 2 0 11 1463 1491 1492 1464 +1575 3 2 0 11 1464 1492 1493 1465 +1576 3 2 0 11 1465 1493 1494 1466 +1577 3 2 0 11 1466 1494 1495 1467 +1578 3 2 0 11 1467 1495 1496 1468 +1579 3 2 0 11 1468 1496 1497 1469 +1580 3 2 0 11 1469 1497 1498 1470 +1581 3 2 0 11 1470 1498 1499 1471 +1582 3 2 0 11 1471 1499 1500 1472 +1583 3 2 0 11 1472 1500 1501 1473 +1584 3 2 0 11 1473 1501 1502 1474 +1585 3 2 0 11 1474 1502 1503 1475 +1586 3 2 0 11 1475 1503 1504 1476 +1587 3 2 0 11 1476 1504 1505 1477 +1588 3 2 0 11 1477 1505 1506 1478 +1589 3 2 0 11 1478 1506 1507 1479 +1590 3 2 0 11 1479 1507 1508 1480 +1591 3 2 0 11 1480 1508 1509 1481 +1592 3 2 0 11 1481 1509 1510 1482 +1593 3 2 0 11 1482 1510 1511 1483 +1594 3 2 0 11 1483 1511 1512 1484 +1595 3 2 0 11 1484 1512 1513 1485 +1596 3 2 0 11 1485 1513 1514 1486 +1597 3 2 0 11 1486 1514 1515 1487 +1598 3 2 0 11 1487 1515 1516 1488 +1599 3 2 0 11 1488 1516 1517 1489 +1600 3 2 0 11 1489 1517 1518 1490 +1601 3 2 0 11 1490 1518 72 73 +1602 3 2 0 11 25 26 1519 1491 +1603 3 2 0 11 1491 1519 1520 1492 +1604 3 2 0 11 1492 1520 1521 1493 +1605 3 2 0 11 1493 1521 1522 1494 +1606 3 2 0 11 1494 1522 1523 1495 +1607 3 2 0 11 1495 1523 1524 1496 +1608 3 2 0 11 1496 1524 1525 1497 +1609 3 2 0 11 1497 1525 1526 1498 +1610 3 2 0 11 1498 1526 1527 1499 +1611 3 2 0 11 1499 1527 1528 1500 +1612 3 2 0 11 1500 1528 1529 1501 +1613 3 2 0 11 1501 1529 1530 1502 +1614 3 2 0 11 1502 1530 1531 1503 +1615 3 2 0 11 1503 1531 1532 1504 +1616 3 2 0 11 1504 1532 1533 1505 +1617 3 2 0 11 1505 1533 1534 1506 +1618 3 2 0 11 1506 1534 1535 1507 +1619 3 2 0 11 1507 1535 1536 1508 +1620 3 2 0 11 1508 1536 1537 1509 +1621 3 2 0 11 1509 1537 1538 1510 +1622 3 2 0 11 1510 1538 1539 1511 +1623 3 2 0 11 1511 1539 1540 1512 +1624 3 2 0 11 1512 1540 1541 1513 +1625 3 2 0 11 1513 1541 1542 1514 +1626 3 2 0 11 1514 1542 1543 1515 +1627 3 2 0 11 1515 1543 1544 1516 +1628 3 2 0 11 1516 1544 1545 1517 +1629 3 2 0 11 1517 1545 1546 1518 +1630 3 2 0 11 1518 1546 71 72 +1631 3 2 0 11 26 27 1547 1519 +1632 3 2 0 11 1519 1547 1548 1520 +1633 3 2 0 11 1520 1548 1549 1521 +1634 3 2 0 11 1521 1549 1550 1522 +1635 3 2 0 11 1522 1550 1551 1523 +1636 3 2 0 11 1523 1551 1552 1524 +1637 3 2 0 11 1524 1552 1553 1525 +1638 3 2 0 11 1525 1553 1554 1526 +1639 3 2 0 11 1526 1554 1555 1527 +1640 3 2 0 11 1527 1555 1556 1528 +1641 3 2 0 11 1528 1556 1557 1529 +1642 3 2 0 11 1529 1557 1558 1530 +1643 3 2 0 11 1530 1558 1559 1531 +1644 3 2 0 11 1531 1559 1560 1532 +1645 3 2 0 11 1532 1560 1561 1533 +1646 3 2 0 11 1533 1561 1562 1534 +1647 3 2 0 11 1534 1562 1563 1535 +1648 3 2 0 11 1535 1563 1564 1536 +1649 3 2 0 11 1536 1564 1565 1537 +1650 3 2 0 11 1537 1565 1566 1538 +1651 3 2 0 11 1538 1566 1567 1539 +1652 3 2 0 11 1539 1567 1568 1540 +1653 3 2 0 11 1540 1568 1569 1541 +1654 3 2 0 11 1541 1569 1570 1542 +1655 3 2 0 11 1542 1570 1571 1543 +1656 3 2 0 11 1543 1571 1572 1544 +1657 3 2 0 11 1544 1572 1573 1545 +1658 3 2 0 11 1545 1573 1574 1546 +1659 3 2 0 11 1546 1574 70 71 +1660 3 2 0 11 27 28 1575 1547 +1661 3 2 0 11 1547 1575 1576 1548 +1662 3 2 0 11 1548 1576 1577 1549 +1663 3 2 0 11 1549 1577 1578 1550 +1664 3 2 0 11 1550 1578 1579 1551 +1665 3 2 0 11 1551 1579 1580 1552 +1666 3 2 0 11 1552 1580 1581 1553 +1667 3 2 0 11 1553 1581 1582 1554 +1668 3 2 0 11 1554 1582 1583 1555 +1669 3 2 0 11 1555 1583 1584 1556 +1670 3 2 0 11 1556 1584 1585 1557 +1671 3 2 0 11 1557 1585 1586 1558 +1672 3 2 0 11 1558 1586 1587 1559 +1673 3 2 0 11 1559 1587 1588 1560 +1674 3 2 0 11 1560 1588 1589 1561 +1675 3 2 0 11 1561 1589 1590 1562 +1676 3 2 0 11 1562 1590 1591 1563 +1677 3 2 0 11 1563 1591 1592 1564 +1678 3 2 0 11 1564 1592 1593 1565 +1679 3 2 0 11 1565 1593 1594 1566 +1680 3 2 0 11 1566 1594 1595 1567 +1681 3 2 0 11 1567 1595 1596 1568 +1682 3 2 0 11 1568 1596 1597 1569 +1683 3 2 0 11 1569 1597 1598 1570 +1684 3 2 0 11 1570 1598 1599 1571 +1685 3 2 0 11 1571 1599 1600 1572 +1686 3 2 0 11 1572 1600 1601 1573 +1687 3 2 0 11 1573 1601 1602 1574 +1688 3 2 0 11 1574 1602 69 70 +1689 3 2 0 11 28 29 1603 1575 +1690 3 2 0 11 1575 1603 1604 1576 +1691 3 2 0 11 1576 1604 1605 1577 +1692 3 2 0 11 1577 1605 1606 1578 +1693 3 2 0 11 1578 1606 1607 1579 +1694 3 2 0 11 1579 1607 1608 1580 +1695 3 2 0 11 1580 1608 1609 1581 +1696 3 2 0 11 1581 1609 1610 1582 +1697 3 2 0 11 1582 1610 1611 1583 +1698 3 2 0 11 1583 1611 1612 1584 +1699 3 2 0 11 1584 1612 1613 1585 +1700 3 2 0 11 1585 1613 1614 1586 +1701 3 2 0 11 1586 1614 1615 1587 +1702 3 2 0 11 1587 1615 1616 1588 +1703 3 2 0 11 1588 1616 1617 1589 +1704 3 2 0 11 1589 1617 1618 1590 +1705 3 2 0 11 1590 1618 1619 1591 +1706 3 2 0 11 1591 1619 1620 1592 +1707 3 2 0 11 1592 1620 1621 1593 +1708 3 2 0 11 1593 1621 1622 1594 +1709 3 2 0 11 1594 1622 1623 1595 +1710 3 2 0 11 1595 1623 1624 1596 +1711 3 2 0 11 1596 1624 1625 1597 +1712 3 2 0 11 1597 1625 1626 1598 +1713 3 2 0 11 1598 1626 1627 1599 +1714 3 2 0 11 1599 1627 1628 1600 +1715 3 2 0 11 1600 1628 1629 1601 +1716 3 2 0 11 1601 1629 1630 1602 +1717 3 2 0 11 1602 1630 68 69 +1718 3 2 0 11 29 30 1631 1603 +1719 3 2 0 11 1603 1631 1632 1604 +1720 3 2 0 11 1604 1632 1633 1605 +1721 3 2 0 11 1605 1633 1634 1606 +1722 3 2 0 11 1606 1634 1635 1607 +1723 3 2 0 11 1607 1635 1636 1608 +1724 3 2 0 11 1608 1636 1637 1609 +1725 3 2 0 11 1609 1637 1638 1610 +1726 3 2 0 11 1610 1638 1639 1611 +1727 3 2 0 11 1611 1639 1640 1612 +1728 3 2 0 11 1612 1640 1641 1613 +1729 3 2 0 11 1613 1641 1642 1614 +1730 3 2 0 11 1614 1642 1643 1615 +1731 3 2 0 11 1615 1643 1644 1616 +1732 3 2 0 11 1616 1644 1645 1617 +1733 3 2 0 11 1617 1645 1646 1618 +1734 3 2 0 11 1618 1646 1647 1619 +1735 3 2 0 11 1619 1647 1648 1620 +1736 3 2 0 11 1620 1648 1649 1621 +1737 3 2 0 11 1621 1649 1650 1622 +1738 3 2 0 11 1622 1650 1651 1623 +1739 3 2 0 11 1623 1651 1652 1624 +1740 3 2 0 11 1624 1652 1653 1625 +1741 3 2 0 11 1625 1653 1654 1626 +1742 3 2 0 11 1626 1654 1655 1627 +1743 3 2 0 11 1627 1655 1656 1628 +1744 3 2 0 11 1628 1656 1657 1629 +1745 3 2 0 11 1629 1657 1658 1630 +1746 3 2 0 11 1630 1658 67 68 +1747 3 2 0 11 30 31 1659 1631 +1748 3 2 0 11 1631 1659 1660 1632 +1749 3 2 0 11 1632 1660 1661 1633 +1750 3 2 0 11 1633 1661 1662 1634 +1751 3 2 0 11 1634 1662 1663 1635 +1752 3 2 0 11 1635 1663 1664 1636 +1753 3 2 0 11 1636 1664 1665 1637 +1754 3 2 0 11 1637 1665 1666 1638 +1755 3 2 0 11 1638 1666 1667 1639 +1756 3 2 0 11 1639 1667 1668 1640 +1757 3 2 0 11 1640 1668 1669 1641 +1758 3 2 0 11 1641 1669 1670 1642 +1759 3 2 0 11 1642 1670 1671 1643 +1760 3 2 0 11 1643 1671 1672 1644 +1761 3 2 0 11 1644 1672 1673 1645 +1762 3 2 0 11 1645 1673 1674 1646 +1763 3 2 0 11 1646 1674 1675 1647 +1764 3 2 0 11 1647 1675 1676 1648 +1765 3 2 0 11 1648 1676 1677 1649 +1766 3 2 0 11 1649 1677 1678 1650 +1767 3 2 0 11 1650 1678 1679 1651 +1768 3 2 0 11 1651 1679 1680 1652 +1769 3 2 0 11 1652 1680 1681 1653 +1770 3 2 0 11 1653 1681 1682 1654 +1771 3 2 0 11 1654 1682 1683 1655 +1772 3 2 0 11 1655 1683 1684 1656 +1773 3 2 0 11 1656 1684 1685 1657 +1774 3 2 0 11 1657 1685 1686 1658 +1775 3 2 0 11 1658 1686 66 67 +1776 3 2 0 11 31 32 1687 1659 +1777 3 2 0 11 1659 1687 1688 1660 +1778 3 2 0 11 1660 1688 1689 1661 +1779 3 2 0 11 1661 1689 1690 1662 +1780 3 2 0 11 1662 1690 1691 1663 +1781 3 2 0 11 1663 1691 1692 1664 +1782 3 2 0 11 1664 1692 1693 1665 +1783 3 2 0 11 1665 1693 1694 1666 +1784 3 2 0 11 1666 1694 1695 1667 +1785 3 2 0 11 1667 1695 1696 1668 +1786 3 2 0 11 1668 1696 1697 1669 +1787 3 2 0 11 1669 1697 1698 1670 +1788 3 2 0 11 1670 1698 1699 1671 +1789 3 2 0 11 1671 1699 1700 1672 +1790 3 2 0 11 1672 1700 1701 1673 +1791 3 2 0 11 1673 1701 1702 1674 +1792 3 2 0 11 1674 1702 1703 1675 +1793 3 2 0 11 1675 1703 1704 1676 +1794 3 2 0 11 1676 1704 1705 1677 +1795 3 2 0 11 1677 1705 1706 1678 +1796 3 2 0 11 1678 1706 1707 1679 +1797 3 2 0 11 1679 1707 1708 1680 +1798 3 2 0 11 1680 1708 1709 1681 +1799 3 2 0 11 1681 1709 1710 1682 +1800 3 2 0 11 1682 1710 1711 1683 +1801 3 2 0 11 1683 1711 1712 1684 +1802 3 2 0 11 1684 1712 1713 1685 +1803 3 2 0 11 1685 1713 1714 1686 +1804 3 2 0 11 1686 1714 65 66 +1805 3 2 0 11 32 33 1715 1687 +1806 3 2 0 11 1687 1715 1716 1688 +1807 3 2 0 11 1688 1716 1717 1689 +1808 3 2 0 11 1689 1717 1718 1690 +1809 3 2 0 11 1690 1718 1719 1691 +1810 3 2 0 11 1691 1719 1720 1692 +1811 3 2 0 11 1692 1720 1721 1693 +1812 3 2 0 11 1693 1721 1722 1694 +1813 3 2 0 11 1694 1722 1723 1695 +1814 3 2 0 11 1695 1723 1724 1696 +1815 3 2 0 11 1696 1724 1725 1697 +1816 3 2 0 11 1697 1725 1726 1698 +1817 3 2 0 11 1698 1726 1727 1699 +1818 3 2 0 11 1699 1727 1728 1700 +1819 3 2 0 11 1700 1728 1729 1701 +1820 3 2 0 11 1701 1729 1730 1702 +1821 3 2 0 11 1702 1730 1731 1703 +1822 3 2 0 11 1703 1731 1732 1704 +1823 3 2 0 11 1704 1732 1733 1705 +1824 3 2 0 11 1705 1733 1734 1706 +1825 3 2 0 11 1706 1734 1735 1707 +1826 3 2 0 11 1707 1735 1736 1708 +1827 3 2 0 11 1708 1736 1737 1709 +1828 3 2 0 11 1709 1737 1738 1710 +1829 3 2 0 11 1710 1738 1739 1711 +1830 3 2 0 11 1711 1739 1740 1712 +1831 3 2 0 11 1712 1740 1741 1713 +1832 3 2 0 11 1713 1741 1742 1714 +1833 3 2 0 11 1714 1742 64 65 +1834 3 2 0 11 33 34 1743 1715 +1835 3 2 0 11 1715 1743 1744 1716 +1836 3 2 0 11 1716 1744 1745 1717 +1837 3 2 0 11 1717 1745 1746 1718 +1838 3 2 0 11 1718 1746 1747 1719 +1839 3 2 0 11 1719 1747 1748 1720 +1840 3 2 0 11 1720 1748 1749 1721 +1841 3 2 0 11 1721 1749 1750 1722 +1842 3 2 0 11 1722 1750 1751 1723 +1843 3 2 0 11 1723 1751 1752 1724 +1844 3 2 0 11 1724 1752 1753 1725 +1845 3 2 0 11 1725 1753 1754 1726 +1846 3 2 0 11 1726 1754 1755 1727 +1847 3 2 0 11 1727 1755 1756 1728 +1848 3 2 0 11 1728 1756 1757 1729 +1849 3 2 0 11 1729 1757 1758 1730 +1850 3 2 0 11 1730 1758 1759 1731 +1851 3 2 0 11 1731 1759 1760 1732 +1852 3 2 0 11 1732 1760 1761 1733 +1853 3 2 0 11 1733 1761 1762 1734 +1854 3 2 0 11 1734 1762 1763 1735 +1855 3 2 0 11 1735 1763 1764 1736 +1856 3 2 0 11 1736 1764 1765 1737 +1857 3 2 0 11 1737 1765 1766 1738 +1858 3 2 0 11 1738 1766 1767 1739 +1859 3 2 0 11 1739 1767 1768 1740 +1860 3 2 0 11 1740 1768 1769 1741 +1861 3 2 0 11 1741 1769 1770 1742 +1862 3 2 0 11 1742 1770 63 64 +1863 3 2 0 11 34 1 35 1743 +1864 3 2 0 11 1743 35 36 1744 +1865 3 2 0 11 1744 36 37 1745 +1866 3 2 0 11 1745 37 38 1746 +1867 3 2 0 11 1746 38 39 1747 +1868 3 2 0 11 1747 39 40 1748 +1869 3 2 0 11 1748 40 41 1749 +1870 3 2 0 11 1749 41 42 1750 +1871 3 2 0 11 1750 42 43 1751 +1872 3 2 0 11 1751 43 44 1752 +1873 3 2 0 11 1752 44 45 1753 +1874 3 2 0 11 1753 45 46 1754 +1875 3 2 0 11 1754 46 47 1755 +1876 3 2 0 11 1755 47 48 1756 +1877 3 2 0 11 1756 48 49 1757 +1878 3 2 0 11 1757 49 50 1758 +1879 3 2 0 11 1758 50 51 1759 +1880 3 2 0 11 1759 51 52 1760 +1881 3 2 0 11 1760 52 53 1761 +1882 3 2 0 11 1761 53 54 1762 +1883 3 2 0 11 1762 54 55 1763 +1884 3 2 0 11 1763 55 56 1764 +1885 3 2 0 11 1764 56 57 1765 +1886 3 2 0 11 1765 57 58 1766 +1887 3 2 0 11 1766 58 59 1767 +1888 3 2 0 11 1767 59 60 1768 +1889 3 2 0 11 1768 60 61 1769 +1890 3 2 0 11 1769 61 62 1770 +1891 3 2 0 11 1770 62 2 63 +$EndElements diff --git a/test/porousmediumflow/2p/implicit/boxdfm/grids/2d_trias.msh b/test/porousmediumflow/2p/implicit/boxdfm/grids/2d_trias.msh new file mode 100644 index 0000000000000000000000000000000000000000..2930fbb6407ad3ea528b05b07fb93a006a75dbb0 --- /dev/null +++ b/test/porousmediumflow/2p/implicit/boxdfm/grids/2d_trias.msh @@ -0,0 +1,135 @@ +$MeshFormat +2.2 0 8 +$EndMeshFormat +$Nodes +47 +1 0 0 0 +2 1 0 0 +3 1 1 0 +4 0 1 0 +5 0.5 0.15 0 +6 0.5 0.6 0 +7 0.25 0.25 0 +8 0.25 0.5 0 +9 0.5 0.25 0 +10 0.5 0.5 0 +11 0.75 0.25 0 +12 0.75 0.5 0 +13 0 0.7500000000003465 0 +14 0 0.5000000000020591 0 +15 0 0.2500000000010404 0 +16 0.2499999999994121 0 0 +17 0.499999999998694 0 0 +18 0.7499999999993416 0 0 +19 1 0.2499999999994121 0 +20 1 0.499999999998694 0 +21 1 0.7499999999993416 0 +22 0.7500000000003465 1 0 +23 0.5000000000020591 1 0 +24 0.2500000000010404 1 0 +25 0.711417494935904 0.7190981070920686 0 +26 0.2884548114665013 0.7080473703448205 0 +27 0.375 0.375 0 +28 0.625 0.375 0 +29 0.507496506788062 0.8187950663570192 0 +30 0.3915459609771306 0.6025613056035204 0 +31 0.6097871575237765 0.6029146214184037 0 +32 0.3766399416909452 0.1799562682216394 0 +33 0.6233600583090159 0.1799562682215093 0 +34 0.5978265380495438 0.07882095257883703 0 +35 0.4021734619503089 0.07882095257972785 0 +36 0.4307640269479863 0.7123410071193929 0 +37 0.5766600339976918 0.7100513215467172 0 +38 0.360238614305264 0.8612495775664406 0 +39 0.8525000000002459 0.8524999999998341 0 +40 0.1474999999998658 0.647500000000008 0 +41 0.1544933285512806 0.8460702549249612 0 +42 0.8524999999997666 0.6474999999999634 0 +43 0.6463282750423706 0.8618011273288519 0 +44 0.124999999999853 0.1250000000002601 0 +45 0.8749999999997061 0.124999999999706 0 +46 0.125 0.3750000000007749 0 +47 0.8750000000002941 0.3749999999990531 0 +$EndNodes +$Elements +79 +1 1 2 1 7 6 10 +2 1 2 1 8 10 9 +3 1 2 1 9 9 5 +4 2 2 1 1 16 35 32 +5 2 2 1 1 18 33 34 +6 2 2 1 1 6 37 36 +7 2 2 1 1 12 25 31 +8 2 2 1 1 8 30 26 +9 2 2 1 1 25 37 31 +10 2 2 1 1 5 9 32 +11 2 2 1 1 6 30 10 +12 2 2 1 1 6 10 31 +13 2 2 1 1 5 33 9 +14 2 2 1 1 26 30 36 +15 2 2 1 1 6 36 30 +16 2 2 1 1 7 16 32 +17 2 2 1 1 11 33 18 +18 2 2 1 1 7 27 8 +19 2 2 1 1 11 12 28 +20 2 2 1 1 6 31 37 +21 2 2 1 1 5 17 34 +22 2 2 1 1 5 35 17 +23 2 2 1 1 29 37 43 +24 2 2 1 1 42 25 12 +25 2 2 1 1 8 26 40 +26 2 2 1 1 22 23 43 +27 2 2 1 1 23 24 38 +28 2 2 1 1 20 21 42 +29 2 2 1 1 3 22 39 +30 2 2 1 1 4 41 24 +31 2 2 1 1 3 39 21 +32 2 2 1 1 4 13 41 +33 2 2 1 1 8 40 14 +34 2 2 1 1 12 20 42 +35 2 2 1 1 13 14 40 +36 2 2 1 1 29 36 37 +37 2 2 1 1 25 43 37 +38 2 2 1 1 29 38 36 +39 2 2 1 1 14 15 46 +40 2 2 1 1 1 44 15 +41 2 2 1 1 2 45 18 +42 2 2 1 1 8 14 46 +43 2 2 1 1 12 47 20 +44 2 2 1 1 7 44 16 +45 2 2 1 1 11 47 12 +46 2 2 1 1 7 15 44 +47 2 2 1 1 11 18 45 +48 2 2 1 1 7 8 46 +49 2 2 1 1 7 46 15 +50 2 2 1 1 1 16 44 +51 2 2 1 1 2 19 45 +52 2 2 1 1 19 20 47 +53 2 2 1 1 19 47 45 +54 2 2 1 1 11 45 47 +55 2 2 1 1 26 38 41 +56 2 2 1 1 5 34 33 +57 2 2 1 1 5 32 35 +58 2 2 1 1 23 29 43 +59 2 2 1 1 25 39 43 +60 2 2 1 1 24 41 38 +61 2 2 1 1 26 36 38 +62 2 2 1 1 22 43 39 +63 2 2 1 1 23 38 29 +64 2 2 1 1 25 42 39 +65 2 2 1 1 26 41 40 +66 2 2 1 1 13 40 41 +67 2 2 1 1 21 39 42 +68 2 2 1 1 7 32 9 +69 2 2 1 1 8 10 30 +70 2 2 1 1 9 33 11 +71 2 2 1 1 10 12 31 +72 2 2 1 1 16 17 35 +73 2 2 1 1 17 18 34 +74 2 2 1 1 7 9 27 +75 2 2 1 1 8 27 10 +76 2 2 1 1 9 10 27 +77 2 2 1 1 9 28 10 +78 2 2 1 1 9 11 28 +79 2 2 1 1 10 28 12 +$EndElements diff --git a/test/porousmediumflow/2p/implicit/boxdfm/grids/3d_simplex.msh b/test/porousmediumflow/2p/implicit/boxdfm/grids/3d_simplex.msh new file mode 100644 index 0000000000000000000000000000000000000000..57dfd4d2bda8aa2589d65de5fb8b2407a52f77af --- /dev/null +++ b/test/porousmediumflow/2p/implicit/boxdfm/grids/3d_simplex.msh @@ -0,0 +1,807 @@ +$MeshFormat +2.2 0 8 +$EndMeshFormat +$Nodes +172 +1 0 0 0 +2 1 0 0 +3 1 1 0 +4 0 1 0 +5 0 0 1 +6 1 0 1 +7 1 1 1 +8 0 1 1 +9 0.5 0.25 0.15 +10 0.5 0.25 0.6 +11 0.5 0.75 0.15 +12 0.5 0.75 0.6 +13 0.25 0.25 0.25 +14 0.25 0.25 0.5 +15 0.5 0.25 0.25 +16 0.5 0.25 0.5 +17 0.25 0.75 0.25 +18 0.25 0.75 0.5 +19 0.5 0.75 0.25 +20 0.5 0.75 0.5 +21 0.75 0.25 0.25 +22 0.75 0.25 0.5 +23 0.75 0.75 0.25 +24 0.75 0.75 0.5 +25 0.5 0.5000000000003469 0.25 +26 0.5 0.5000000000013765 0.5 +27 0.25 0.5000000000013765 0.5 +28 0.25 0.5000000000003469 0.25 +29 0.75 0.5000000000003469 0.25 +30 0.75 0.5000000000003469 0.5 +31 0.5 0.5000000000003469 0.15 +32 0.5 0.5000000000013765 0.6 +33 0 0 0.7500000000003465 +34 0 0 0.5000000000020591 +35 0 0 0.2500000000010404 +36 0.2499999999994121 0 0 +37 0.499999999998694 0 0 +38 0.7499999999993416 0 0 +39 1 0.2499999999994121 0 +40 1 0.499999999998694 0 +41 1 0.7499999999993416 0 +42 1 1 0.2499999999994121 +43 1 1 0.499999999998694 +44 1 1 0.7499999999993416 +45 0.7500000000003465 1 1 +46 0.5000000000020591 1 1 +47 0.2500000000010404 1 1 +48 0 0.7500000000003465 1 +49 0 0.5000000000020591 1 +50 0 0.2500000000010404 1 +51 0.2499999999994121 0 1 +52 0.499999999998694 0 1 +53 0.7499999999993416 0 1 +54 1 0 0.7500000000003465 +55 1 0 0.5000000000020591 +56 1 0 0.2500000000010404 +57 1 0.2499999999994121 1 +58 1 0.499999999998694 1 +59 1 0.7499999999993416 1 +60 0 0.2499999999994121 0 +61 0 0.499999999998694 0 +62 0 0.7499999999993416 0 +63 0 1 0.2499999999994121 +64 0 1 0.499999999998694 +65 0 1 0.7499999999993416 +66 0.2499999999994121 1 0 +67 0.499999999998694 1 0 +68 0.7499999999993416 1 0 +69 0.5000000000000463 0 0.4999999999999483 +70 0.2916666666666607 0 0.7083333333333793 +71 0.7083333333334084 0 0.7083333333332408 +72 0.2916666666668149 0 0.2916666666665436 +73 0.7083333333332542 0 0.291666666666682 +74 0.2202380952381731 0 0.499999999999935 +75 0.5000000000000583 0 0.77976190476187 +76 0.7797619047619426 0 0.499999999999935 +77 0.5000000000000583 0 0.2202380952380008 +78 0.1614583333333944 0 0.8385416666665199 +79 0.8385416666665232 0 0.8385416666668789 +80 0.1614583333329947 0 0.1614583333335714 +81 0.8385416666669228 0 0.1614583333332122 +82 1 0.5000000000000447 0.4999999999999981 +83 1 0.2916666666666607 0.7083333333333793 +84 1 0.7083333333334353 0.2916666666667725 +85 1 0.291666666666815 0.2916666666665435 +86 1 0.7083333333332966 0.7083333333332966 +87 1 0.2202380952381731 0.499999999999935 +88 1 0.4999999999999928 0.7797619047619169 +89 1 0.5000000000001644 0.2202380952380766 +90 1 0.7797619047619635 0.5000000000000582 +91 1 0.1614583333333944 0.8385416666665199 +92 1 0.8385416666664537 0.1614583333331048 +93 1 0.1614583333329947 0.1614583333335714 +94 1 0.848032069970875 0.848032069970875 +95 0.5 1 0.5000000000000001 +96 0.291666666666634 1 0.291666666666634 +97 0.7083333333332409 1 0.7083333333334085 +98 0.7083333333334351 1 0.2916666666667725 +99 0.2916666666666819 1 0.7083333333332543 +100 0.4999999999999351 1 0.7797619047619427 +101 0.5000000000000583 1 0.2202380952381522 +102 0.7797619047619169 1 0.5000000000001238 +103 0.2202380952380766 1 0.4999999999999523 +104 0.8385416666668791 1 0.8385416666665234 +105 0.1546794738304048 1 0.1546794738304048 +106 0.8385416666664538 1 0.1614583333331049 +107 0.161458333333212 1 0.8385416666669231 +108 0.5000000000000464 0.5000000000000464 0 +109 0.291666666666634 0.291666666666634 0 +110 0.7083333333334353 0.2916666666667725 0 +111 0.2916666666667725 0.7083333333334353 0 +112 0.7083333333332966 0.7083333333332966 0 +113 0.5000000000000585 0.2202380952381523 0 +114 0.2202380952381523 0.5000000000000585 0 +115 0.7797619047619635 0.5000000000000582 0 +116 0.5000000000000582 0.7797619047619635 0 +117 0.1546794738304047 0.1546794738304047 0 +118 0.8385416666664537 0.1614583333331048 0 +119 0.1614583333331048 0.8385416666664537 0 +120 0.848032069970875 0.848032069970875 0 +121 0 0.5000000000000137 0.4999999999999811 +122 0 0.7083333333332408 0.7083333333334085 +123 0 0.2916666666665703 0.7083333333331985 +124 0 0.7083333333334353 0.2916666666667725 +125 0 0.2916666666668149 0.2916666666665436 +126 0 0.4999999999998695 0.7797619047618961 +127 0 0.2202380952380974 0.4999999999998291 +128 0 0.7797619047619169 0.5000000000001239 +129 0 0.5000000000001644 0.2202380952380767 +130 0 0.838541666666879 0.8385416666665233 +131 0 0.1614583333335018 0.8385416666669894 +132 0 0.8385416666664537 0.1614583333331048 +133 0 0.1614583333329947 0.1614583333335714 +134 0.5000000000000138 0.4999999999999811 1 +135 0.708333333333241 0.7083333333334086 1 +136 0.2916666666665704 0.7083333333331984 1 +137 0.7083333333334353 0.2916666666667725 1 +138 0.2916666666668149 0.2916666666665436 1 +139 0.4999999999998698 0.779761904761896 1 +140 0.2202380952380974 0.4999999999998291 1 +141 0.7797619047619168 0.5000000000001238 1 +142 0.5000000000001644 0.2202380952380767 1 +143 0.8385416666668792 0.8385416666665235 1 +144 0.1614583333335019 0.8385416666669894 1 +145 0.8385416666664537 0.1614583333331048 1 +146 0.1614583333329947 0.1614583333335714 1 +147 0.375 0.3750000000006882 0.5 +148 0.375 0.6250000000006882 0.5 +149 0.375 0.75 0.375 +150 0.25 0.3750000000004309 0.375 +151 0.25 0.6250000000006882 0.375 +152 0.375 0.25 0.375 +153 0.375 0.3750000000001735 0.25 +154 0.3750000000000001 0.6250000000001734 0.25 +155 0.5 0.3750000000004308 0.375 +156 0.5 0.6250000000006882 0.375 +157 0.625 0.25 0.3749999999999999 +158 0.6249999999999999 0.3750000000001735 0.25 +159 0.625 0.6250000000001734 0.25 +160 0.75 0.3750000000001735 0.375 +161 0.75 0.6250000000001734 0.375 +162 0.625 0.7500000000000001 0.375 +163 0.625 0.3750000000004308 0.5 +164 0.625 0.6250000000006882 0.5 +165 0.5 0.3750000000006882 0.55 +166 0.5 0.6250000000006881 0.55 +167 0.5 0.3750000000001735 0.2 +168 0.5 0.6250000000001735 0.2 +169 0.6450000000006884 0.3750000000006882 0.7312500000017208 +170 0.6449999999993119 0.6250000000006882 0.7312499999982797 +171 0.3143922331052849 0.3309024904934595 0.7629218718931982 +172 0.3550000000006881 0.6250000000006882 0.7312499999982797 +$EndNodes +$Elements +626 +1 2 2 1 12 15 155 16 +2 2 2 1 12 15 25 155 +3 2 2 1 12 16 155 26 +4 2 2 1 12 19 20 156 +5 2 2 1 12 19 156 25 +6 2 2 1 12 20 26 156 +7 2 2 1 12 25 26 155 +8 2 2 1 12 25 156 26 +9 2 2 1 18 10 16 165 +10 2 2 1 18 10 165 32 +11 2 2 1 18 12 166 20 +12 2 2 1 18 12 32 166 +13 2 2 1 18 16 26 165 +14 2 2 1 18 20 166 26 +15 2 2 1 18 26 32 165 +16 2 2 1 18 26 166 32 +17 2 2 1 19 9 167 15 +18 2 2 1 19 9 31 167 +19 2 2 1 19 11 19 168 +20 2 2 1 19 11 168 31 +21 2 2 1 19 15 167 25 +22 2 2 1 19 19 25 168 +23 2 2 1 19 25 167 31 +24 2 2 1 19 25 31 168 +25 4 2 1 1 161 155 29 163 +26 4 2 1 1 155 153 150 154 +27 4 2 1 1 150 155 154 147 +28 4 2 1 1 29 155 160 163 +29 4 2 1 1 155 161 26 163 +30 4 2 1 1 161 156 26 164 +31 4 2 1 1 161 155 159 29 +32 4 2 1 1 161 29 160 163 +33 4 2 1 1 155 29 160 158 +34 4 2 1 1 30 161 160 163 +35 4 2 1 1 159 155 25 158 +36 4 2 1 1 155 153 154 25 +37 4 2 1 1 155 159 29 158 +38 4 2 1 1 153 150 154 28 +39 4 2 1 1 161 155 26 159 +40 4 2 1 1 150 154 27 147 +41 4 2 1 1 155 154 147 26 +42 4 2 1 1 161 30 26 163 +43 4 2 1 1 155 26 159 25 +44 4 2 1 1 150 154 28 27 +45 4 2 1 1 155 154 26 25 +46 4 2 1 1 156 161 26 159 +47 4 2 1 1 154 151 27 148 +48 4 2 1 1 148 154 156 26 +49 4 2 1 1 154 151 28 27 +50 4 2 1 1 30 161 26 164 +51 4 2 1 1 26 156 159 25 +52 4 2 1 1 154 156 26 25 +53 4 2 1 1 154 148 147 26 +54 4 2 1 1 27 154 148 147 +55 4 2 1 1 161 156 164 162 +56 4 2 1 1 155 153 152 150 +57 4 2 1 1 152 155 150 147 +58 4 2 1 1 160 155 157 163 +59 4 2 1 1 26 163 16 155 +60 4 2 1 1 161 156 162 159 +61 4 2 1 1 149 17 151 18 +62 4 2 1 1 154 149 151 148 +63 4 2 1 1 154 149 148 156 +64 4 2 1 1 164 162 20 24 +65 4 2 1 1 19 20 156 162 +66 4 2 1 1 19 20 149 156 +67 4 2 1 1 155 160 157 158 +68 4 2 1 1 152 150 13 14 +69 4 2 1 1 152 155 16 15 +70 4 2 1 1 163 16 157 22 +71 4 2 1 1 16 155 157 15 +72 4 2 1 1 26 20 164 156 +73 4 2 1 1 155 163 16 157 +74 4 2 1 1 156 164 162 20 +75 4 2 1 1 27 150 147 14 +76 4 2 1 1 16 26 155 147 +77 4 2 1 1 148 149 18 20 +78 4 2 1 1 149 154 17 19 +79 4 2 1 1 161 162 24 23 +80 4 2 1 1 162 159 19 23 +81 4 2 1 1 150 153 13 28 +82 4 2 1 1 158 25 15 155 +83 4 2 1 1 15 25 153 155 +84 4 2 1 1 160 30 163 22 +85 4 2 1 1 157 160 22 21 +86 4 2 1 1 153 152 13 15 +87 4 2 1 1 158 157 15 21 +88 4 2 1 1 17 154 151 28 +89 4 2 1 1 19 154 25 156 +90 4 2 1 1 30 161 164 24 +91 4 2 1 1 25 19 156 159 +92 4 2 1 1 152 147 14 16 +93 4 2 1 1 151 27 148 18 +94 4 2 1 1 148 20 26 156 +95 4 2 1 1 160 163 157 22 +96 4 2 1 1 155 158 157 15 +97 4 2 1 1 153 152 150 13 +98 4 2 1 1 153 155 152 15 +99 4 2 1 1 150 152 147 14 +100 4 2 1 1 152 155 147 16 +101 4 2 1 1 156 162 159 19 +102 4 2 1 1 154 149 17 151 +103 4 2 1 1 164 161 162 24 +104 4 2 1 1 154 149 156 19 +105 4 2 1 1 149 151 148 18 +106 4 2 1 1 149 148 156 20 +107 4 2 1 1 29 160 158 21 +108 4 2 1 1 159 161 29 23 +109 4 2 1 1 158 160 157 21 +110 4 2 1 1 162 161 159 23 +111 4 2 1 3 104 86 94 170 +112 4 2 1 3 79 91 71 169 +113 4 2 1 3 163 26 16 165 +114 4 2 1 3 26 20 166 164 +115 4 2 1 3 99 107 130 172 +116 4 2 1 3 78 123 131 171 +117 4 2 1 3 104 97 86 170 +118 4 2 1 3 71 91 83 169 +119 4 2 1 3 122 99 130 172 +120 4 2 1 3 78 70 123 171 +121 4 2 1 3 97 24 86 170 +122 4 2 1 3 104 135 97 170 +123 4 2 1 3 71 83 22 169 +124 4 2 1 3 16 26 147 165 +125 4 2 1 3 25 158 15 167 +126 4 2 1 3 15 25 167 153 +127 4 2 1 3 25 19 159 168 +128 4 2 1 3 154 19 25 168 +129 4 2 1 3 20 148 26 166 +130 4 2 1 3 137 83 91 169 +131 4 2 1 3 99 122 18 172 +132 4 2 1 3 123 70 14 171 +133 4 2 1 3 138 70 78 171 +134 4 2 1 3 122 130 136 172 +135 4 2 1 3 86 24 30 170 +136 4 2 1 3 30 22 83 169 +137 4 2 1 3 88 30 169 170 +138 4 2 1 3 134 169 32 170 +139 4 2 1 3 135 100 97 170 +140 4 2 1 3 142 137 71 169 +141 4 2 1 3 104 45 135 143 +142 4 2 1 3 99 65 130 107 +143 4 2 1 3 48 130 144 136 +144 4 2 1 3 79 71 91 54 +145 4 2 1 3 145 137 57 91 +146 4 2 1 3 131 78 33 123 +147 4 2 1 3 78 138 146 51 +148 4 2 1 3 27 18 122 172 +149 4 2 1 3 123 14 27 171 +150 4 2 1 3 97 12 24 170 +151 4 2 1 3 134 170 32 172 +152 4 2 1 3 71 22 10 169 +153 4 2 1 3 141 135 86 170 +154 4 2 1 3 32 169 134 171 +155 4 2 1 3 83 137 88 169 +156 4 2 1 3 94 104 44 86 +157 4 2 1 3 88 86 30 170 +158 4 2 1 3 99 139 136 172 +159 4 2 1 3 70 138 75 171 +160 4 2 1 3 83 88 30 169 +161 4 2 1 3 139 100 135 170 +162 4 2 1 3 75 142 71 169 +163 4 2 1 3 126 171 27 172 +164 4 2 1 3 18 12 99 172 +165 4 2 1 3 100 12 97 170 +166 4 2 1 3 12 170 139 172 +167 4 2 1 3 70 10 14 171 +168 4 2 1 3 122 136 126 172 +169 4 2 1 3 97 102 86 24 +170 4 2 1 3 99 122 128 18 +171 4 2 1 3 71 83 87 22 +172 4 2 1 3 74 123 70 14 +173 4 2 1 3 32 171 134 172 +174 4 2 1 3 75 71 10 169 +175 4 2 1 3 138 123 140 171 +176 4 2 1 3 142 169 10 171 +177 4 2 1 3 88 141 86 170 +178 4 2 1 3 88 137 141 169 +179 4 2 1 3 122 126 27 172 +180 4 2 1 3 19 20 95 149 +181 4 2 1 3 149 95 18 20 +182 4 2 1 3 20 19 95 162 +183 4 2 1 3 162 95 20 24 +184 4 2 1 3 151 121 27 18 +185 4 2 1 3 16 69 157 22 +186 4 2 1 3 69 16 157 15 +187 4 2 1 3 69 152 16 15 +188 4 2 1 3 151 121 28 27 +189 4 2 1 3 121 150 28 27 +190 4 2 1 3 152 14 69 16 +191 4 2 1 3 121 150 27 14 +192 4 2 1 3 27 126 123 171 +193 4 2 1 3 139 99 100 172 +194 4 2 1 3 138 142 75 171 +195 4 2 1 3 139 12 100 170 +196 4 2 1 3 44 104 97 86 +197 4 2 1 3 122 99 65 130 +198 4 2 1 3 71 83 91 54 +199 4 2 1 3 78 33 123 70 +200 4 2 1 3 45 104 135 97 +201 4 2 1 3 48 122 130 136 +202 4 2 1 3 137 83 57 91 +203 4 2 1 3 78 138 51 70 +204 4 2 1 3 75 10 142 169 +205 4 2 1 3 68 98 11 23 +206 4 2 1 3 66 96 17 11 +207 4 2 1 3 38 9 73 21 +208 4 2 1 3 72 36 13 9 +209 4 2 1 3 99 12 100 172 +210 4 2 1 3 82 83 30 22 +211 4 2 1 3 86 82 30 24 +212 4 2 1 3 121 27 123 14 +213 4 2 1 3 121 122 27 18 +214 4 2 1 3 70 75 10 171 +215 4 2 1 3 88 169 141 170 +216 4 2 1 3 30 24 164 170 +217 4 2 1 3 140 126 136 172 +218 4 2 1 3 102 90 86 24 +219 4 2 1 3 76 71 87 22 +220 4 2 1 3 103 99 128 18 +221 4 2 1 3 74 127 123 14 +222 4 2 1 3 140 123 126 171 +223 4 2 1 3 30 163 22 169 +224 4 2 1 3 111 66 17 11 +225 4 2 1 3 68 11 112 23 +226 4 2 1 3 36 109 13 9 +227 4 2 1 3 38 110 9 21 +228 4 2 1 3 95 97 12 24 +229 4 2 1 3 95 99 18 12 +230 4 2 1 3 10 71 69 22 +231 4 2 1 3 70 14 10 69 +232 4 2 1 3 139 100 12 172 +233 4 2 1 3 18 95 12 20 +234 4 2 1 3 95 12 20 24 +235 4 2 1 3 10 69 16 22 +236 4 2 1 3 14 10 69 16 +237 4 2 1 3 142 10 75 171 +238 4 2 1 3 120 92 23 41 +239 4 2 1 3 106 68 120 23 +240 4 2 1 3 66 105 119 17 +241 4 2 1 3 63 132 105 17 +242 4 2 1 3 117 80 36 13 +243 4 2 1 3 117 60 133 13 +244 4 2 1 3 102 90 24 23 +245 4 2 1 3 89 29 23 115 +246 4 2 1 3 87 76 22 21 +247 4 2 1 3 89 29 115 21 +248 4 2 1 3 132 62 119 17 +249 4 2 1 3 80 133 35 13 +250 4 2 1 3 56 81 21 93 +251 4 2 1 3 38 81 118 21 +252 4 2 1 3 42 106 92 23 +253 4 2 1 3 21 118 39 93 +254 4 2 1 3 139 170 134 172 +255 4 2 1 3 11 98 19 23 +256 4 2 1 3 96 17 11 19 +257 4 2 1 3 73 9 15 21 +258 4 2 1 3 13 72 9 15 +259 4 2 1 3 98 162 19 23 +260 4 2 1 3 17 124 151 18 +261 4 2 1 3 96 149 17 19 +262 4 2 1 3 157 73 15 21 +263 4 2 1 3 125 150 13 28 +264 4 2 1 3 152 72 13 15 +265 4 2 1 3 72 152 13 14 +266 4 2 1 3 140 138 50 123 +267 4 2 1 3 47 99 139 136 +268 4 2 1 3 137 53 142 71 +269 4 2 1 3 102 44 97 86 +270 4 2 1 3 59 141 135 86 +271 4 2 1 3 99 122 65 128 +272 4 2 1 3 71 83 54 87 +273 4 2 1 3 100 45 135 97 +274 4 2 1 3 48 122 136 126 +275 4 2 1 3 33 74 123 70 +276 4 2 1 3 83 137 57 88 +277 4 2 1 3 138 51 70 75 +278 4 2 1 3 106 120 92 23 +279 4 2 1 3 134 169 142 171 +280 4 2 1 3 105 132 119 17 +281 4 2 1 3 117 133 80 13 +282 4 2 1 3 92 84 23 41 +283 4 2 1 3 132 62 17 124 +284 4 2 1 3 62 111 119 17 +285 4 2 1 3 98 68 106 23 +286 4 2 1 3 80 35 72 13 +287 4 2 1 3 35 133 125 13 +288 4 2 1 3 110 38 118 21 +289 4 2 1 3 85 56 21 93 +290 4 2 1 3 111 66 119 17 +291 4 2 1 3 98 106 42 23 +292 4 2 1 3 63 132 17 124 +293 4 2 1 3 84 42 92 23 +294 4 2 1 3 73 56 81 21 +295 4 2 1 3 118 110 21 39 +296 4 2 1 3 38 73 81 21 +297 4 2 1 3 36 80 72 13 +298 4 2 1 3 133 60 125 13 +299 4 2 1 3 85 21 39 93 +300 4 2 1 3 141 169 134 170 +301 4 2 1 3 121 27 126 123 +302 4 2 1 3 83 88 82 30 +303 4 2 1 3 88 86 82 30 +304 4 2 1 3 122 121 27 126 +305 4 2 1 3 66 96 105 17 +306 4 2 1 3 96 63 105 17 +307 4 2 1 3 117 36 109 13 +308 4 2 1 3 60 117 109 13 +309 4 2 1 3 140 171 126 172 +310 4 2 1 3 112 120 23 41 +311 4 2 1 3 120 68 112 23 +312 4 2 1 3 102 98 42 23 +313 4 2 1 3 84 90 42 23 +314 4 2 1 3 89 85 21 39 +315 4 2 1 3 63 96 103 17 +316 4 2 1 3 110 115 21 39 +317 4 2 1 3 109 60 13 114 +318 4 2 1 3 23 112 41 115 +319 4 2 1 3 73 76 56 21 +320 4 2 1 3 84 89 23 41 +321 4 2 1 3 62 129 17 124 +322 4 2 1 3 85 56 87 21 +323 4 2 1 3 127 35 125 13 +324 4 2 1 3 81 118 21 93 +325 4 2 1 3 149 95 103 18 +326 4 2 1 3 102 95 162 24 +327 4 2 1 3 95 149 101 19 +328 4 2 1 3 162 95 101 19 +329 4 2 1 3 69 76 157 22 +330 4 2 1 3 121 151 128 18 +331 4 2 1 3 77 152 69 15 +332 4 2 1 3 77 69 157 15 +333 4 2 1 3 121 129 151 28 +334 4 2 1 3 129 121 150 28 +335 4 2 1 3 74 152 14 69 +336 4 2 1 3 121 127 150 14 +337 4 2 1 3 82 161 29 160 +338 4 2 1 3 82 30 161 160 +339 4 2 1 3 30 82 161 24 +340 4 2 1 3 82 30 160 22 +341 4 2 1 3 66 67 101 11 +342 4 2 1 3 37 36 77 9 +343 4 2 1 3 67 68 101 11 +344 4 2 1 3 38 37 77 9 +345 4 2 1 3 12 164 24 170 +346 4 2 1 3 32 30 164 170 +347 4 2 1 3 90 102 42 23 +348 4 2 1 3 56 76 87 21 +349 4 2 1 3 89 23 41 115 +350 4 2 1 3 115 89 21 39 +351 4 2 1 3 68 98 101 11 +352 4 2 1 3 96 66 101 11 +353 4 2 1 3 77 38 9 73 +354 4 2 1 3 36 72 77 9 +355 4 2 1 3 10 22 163 169 +356 4 2 1 3 32 163 30 169 +357 4 2 1 3 12 166 170 172 +358 4 2 1 3 32 170 166 172 +359 4 2 1 3 140 50 126 123 +360 4 2 1 3 99 47 139 100 +361 4 2 1 3 90 44 102 86 +362 4 2 1 3 142 53 75 71 +363 4 2 1 3 88 141 59 86 +364 4 2 1 3 103 99 65 128 +365 4 2 1 3 76 71 54 87 +366 4 2 1 3 45 139 100 135 +367 4 2 1 3 140 48 136 126 +368 4 2 1 3 74 127 33 123 +369 4 2 1 3 137 57 88 141 +370 4 2 1 3 51 138 142 75 +371 4 2 1 3 67 66 116 11 +372 4 2 1 3 68 67 116 11 +373 4 2 1 3 36 37 113 9 +374 4 2 1 3 113 37 38 9 +375 4 2 1 3 10 169 165 171 +376 4 2 1 3 165 169 32 171 +377 4 2 1 3 32 169 30 170 +378 4 2 1 3 122 121 128 18 +379 4 2 1 3 95 102 97 24 +380 4 2 1 3 103 95 99 18 +381 4 2 1 3 86 90 82 24 +382 4 2 1 3 83 82 87 22 +383 4 2 1 3 71 76 69 22 +384 4 2 1 3 70 74 14 69 +385 4 2 1 3 127 121 123 14 +386 4 2 1 3 12 166 164 170 +387 4 2 1 3 32 164 166 170 +388 4 2 1 3 140 134 171 172 +389 4 2 1 3 165 163 32 169 +390 4 2 1 3 10 163 165 169 +391 4 2 1 3 121 129 124 151 +392 4 2 1 3 76 73 69 157 +393 4 2 1 3 152 72 77 69 +394 4 2 1 3 96 149 95 103 +395 4 2 1 3 95 102 162 98 +396 4 2 1 3 74 72 152 69 +397 4 2 1 3 73 77 69 157 +398 4 2 1 3 149 96 95 101 +399 4 2 1 3 162 95 98 101 +400 4 2 1 3 124 121 151 128 +401 4 2 1 3 121 127 125 150 +402 4 2 1 3 129 121 125 150 +403 4 2 1 3 66 111 116 11 +404 4 2 1 3 116 68 11 112 +405 4 2 1 3 109 36 113 9 +406 4 2 1 3 110 113 38 9 +407 4 2 1 3 27 148 18 172 +408 4 2 1 3 27 14 147 171 +409 4 2 1 3 111 154 17 28 +410 4 2 1 3 48 140 49 126 +411 4 2 1 3 127 74 33 34 +412 4 2 1 3 139 45 100 46 +413 4 2 1 3 55 76 54 87 +414 4 2 1 3 129 60 61 114 +415 4 2 1 3 52 51 142 75 +416 4 2 1 3 89 115 40 39 +417 4 2 1 3 90 102 43 42 +418 4 2 1 3 88 57 58 141 +419 4 2 1 3 64 63 103 128 +420 4 2 1 3 64 103 65 128 +421 4 2 1 3 58 88 141 59 +422 4 2 1 3 44 90 102 43 +423 4 2 1 3 129 61 62 114 +424 4 2 1 3 53 52 142 75 +425 4 2 1 3 41 89 115 40 +426 4 2 1 3 76 55 56 87 +427 4 2 1 3 47 139 100 46 +428 4 2 1 3 74 127 35 34 +429 4 2 1 3 140 50 49 126 +430 4 2 1 3 134 139 135 170 +431 4 2 1 3 98 101 11 19 +432 4 2 1 3 101 96 11 19 +433 4 2 1 3 9 77 73 15 +434 4 2 1 3 72 77 9 15 +435 4 2 1 3 134 137 142 169 +436 4 2 1 3 82 90 161 24 +437 4 2 1 3 82 160 87 22 +438 4 2 1 3 82 29 89 160 +439 4 2 1 3 161 82 29 89 +440 4 2 1 3 141 134 135 170 +441 4 2 1 3 137 134 141 169 +442 4 2 1 3 98 162 101 19 +443 4 2 1 3 149 96 101 19 +444 4 2 1 3 73 77 157 15 +445 4 2 1 3 72 152 77 15 +446 4 2 1 3 151 124 128 18 +447 4 2 1 3 125 129 150 28 +448 4 2 1 3 72 74 152 14 +449 4 2 1 3 136 139 134 172 +450 4 2 1 3 138 134 142 171 +451 4 2 1 3 31 159 29 115 +452 4 2 1 3 29 31 115 158 +453 4 2 1 3 114 31 154 28 +454 4 2 1 3 153 31 114 28 +455 4 2 1 3 31 115 158 110 +456 4 2 1 3 31 109 153 114 +457 4 2 1 3 159 31 112 115 +458 4 2 1 3 114 31 111 154 +459 4 2 1 3 9 31 110 108 +460 4 2 1 3 31 9 109 108 +461 4 2 1 3 11 31 111 108 +462 4 2 1 3 31 11 112 108 +463 4 2 1 3 27 171 32 172 +464 4 2 1 3 140 136 134 172 +465 4 2 1 3 99 95 100 12 +466 4 2 1 3 100 95 97 12 +467 4 2 1 3 71 75 10 69 +468 4 2 1 3 75 70 10 69 +469 4 2 1 3 138 140 134 171 +470 4 2 1 3 85 82 160 87 +471 4 2 1 3 82 90 84 161 +472 4 2 1 3 84 82 161 89 +473 4 2 1 3 82 89 85 160 +474 4 2 1 3 148 12 18 172 +475 4 2 1 3 27 32 148 172 +476 4 2 1 3 147 14 10 171 +477 4 2 1 3 27 147 32 171 +478 4 2 1 3 79 145 6 91 +479 4 2 1 3 131 78 146 5 +480 4 2 1 3 81 2 118 93 +481 4 2 1 3 144 130 8 107 +482 4 2 1 3 132 4 105 119 +483 4 2 1 3 133 117 80 1 +484 4 2 1 3 3 106 120 92 +485 4 2 1 3 7 104 94 143 +486 4 2 1 3 31 108 115 110 +487 4 2 1 3 31 109 114 108 +488 4 2 1 3 112 31 108 115 +489 4 2 1 3 31 114 111 108 +490 4 2 1 3 111 114 154 28 +491 4 2 1 3 11 159 112 23 +492 4 2 1 3 154 111 17 11 +493 4 2 1 3 110 158 9 21 +494 4 2 1 3 109 153 13 9 +495 4 2 1 3 12 164 20 24 +496 4 2 1 3 32 30 26 164 +497 4 2 1 3 163 10 16 22 +498 4 2 1 3 30 32 26 163 +499 4 2 1 3 148 166 12 172 +500 4 2 1 3 148 32 166 172 +501 4 2 1 3 147 10 165 171 +502 4 2 1 3 147 165 32 171 +503 4 2 1 3 111 116 11 108 +504 4 2 1 3 11 116 112 108 +505 4 2 1 3 110 108 113 9 +506 4 2 1 3 108 109 113 9 +507 4 2 1 3 148 18 12 20 +508 4 2 1 3 17 154 11 19 +509 4 2 1 3 159 11 19 23 +510 4 2 1 3 31 153 154 28 +511 4 2 1 3 159 31 29 158 +512 4 2 1 3 31 159 25 158 +513 4 2 1 3 153 31 154 25 +514 4 2 1 3 9 158 15 21 +515 4 2 1 3 153 13 9 15 +516 4 2 1 3 148 27 147 32 +517 4 2 1 3 147 148 32 26 +518 4 2 1 3 14 147 10 16 +519 4 2 1 3 47 144 8 107 +520 4 2 1 3 56 2 81 93 +521 4 2 1 3 50 131 146 5 +522 4 2 1 3 80 133 1 35 +523 4 2 1 3 53 79 145 6 +524 4 2 1 3 132 62 4 119 +525 4 2 1 3 130 65 8 107 +526 4 2 1 3 2 38 81 118 +527 4 2 1 3 45 104 7 143 +528 4 2 1 3 6 79 91 54 +529 4 2 1 3 130 48 144 8 +530 4 2 1 3 106 3 42 92 +531 4 2 1 3 6 145 57 91 +532 4 2 1 3 131 78 5 33 +533 4 2 1 3 118 2 39 93 +534 4 2 1 3 146 78 51 5 +535 4 2 1 3 4 66 105 119 +536 4 2 1 3 63 132 4 105 +537 4 2 1 3 117 80 1 36 +538 4 2 1 3 60 117 133 1 +539 4 2 1 3 104 7 94 44 +540 4 2 1 3 120 3 92 41 +541 4 2 1 3 59 7 94 143 +542 4 2 1 3 68 3 106 120 +543 4 2 1 3 166 12 164 20 +544 4 2 1 3 32 165 26 163 +545 4 2 1 3 10 165 163 16 +546 4 2 1 3 166 32 26 164 +547 4 2 1 3 148 12 166 20 +548 4 2 1 3 11 159 19 168 +549 4 2 1 3 154 11 19 168 +550 4 2 1 3 167 153 9 15 +551 4 2 1 3 25 31 158 167 +552 4 2 1 3 153 31 25 167 +553 4 2 1 3 158 167 9 15 +554 4 2 1 3 159 31 25 168 +555 4 2 1 3 31 154 25 168 +556 4 2 1 3 165 147 32 26 +557 4 2 1 3 10 147 165 16 +558 4 2 1 3 32 148 166 26 +559 4 2 1 3 170 94 135 86 +560 4 2 1 3 59 135 94 86 +561 4 2 1 3 59 94 135 143 +562 4 2 1 3 104 135 94 143 +563 4 2 1 3 104 94 135 170 +564 4 2 1 3 169 79 137 71 +565 4 2 1 3 53 137 79 71 +566 4 2 1 3 53 79 137 145 +567 4 2 1 3 91 137 79 145 +568 4 2 1 3 91 79 137 169 +569 4 2 1 3 172 107 136 99 +570 4 2 1 3 47 136 107 99 +571 4 2 1 3 47 107 136 144 +572 4 2 1 3 130 136 107 144 +573 4 2 1 3 107 136 130 172 +574 4 2 1 3 171 131 138 123 +575 4 2 1 3 50 138 131 123 +576 4 2 1 3 50 131 138 146 +577 4 2 1 3 9 31 158 110 +578 4 2 1 3 9 158 31 167 +579 4 2 1 3 9 31 153 167 +580 4 2 1 3 9 153 31 109 +581 4 2 1 3 31 11 159 112 +582 4 2 1 3 31 159 11 168 +583 4 2 1 3 31 11 154 168 +584 4 2 1 3 31 154 11 111 +585 4 2 1 3 18 124 103 17 +586 4 2 1 3 18 103 124 128 +587 4 2 1 3 63 103 124 17 +588 4 2 1 3 63 124 103 128 +589 4 2 1 3 102 23 162 98 +590 4 2 1 3 162 23 102 24 +591 4 2 1 3 23 90 161 84 +592 4 2 1 3 23 161 90 24 +593 4 2 1 3 115 23 159 29 +594 4 2 1 3 115 159 23 112 +595 4 2 1 3 17 103 149 96 +596 4 2 1 3 17 149 103 18 +597 4 2 1 3 125 28 114 129 +598 4 2 1 3 114 28 125 13 +599 4 2 1 3 114 60 125 129 +600 4 2 1 3 125 60 114 13 +601 4 2 1 3 89 21 160 29 +602 4 2 1 3 160 21 89 85 +603 4 2 1 3 111 28 129 114 +604 4 2 1 3 129 28 111 17 +605 4 2 1 3 129 62 111 114 +606 4 2 1 3 111 62 129 17 +607 4 2 1 3 21 115 158 29 +608 4 2 1 3 21 158 115 110 +609 4 2 1 3 17 129 151 124 +610 4 2 1 3 17 151 129 28 +611 4 2 1 3 23 89 161 29 +612 4 2 1 3 23 161 89 84 +613 4 2 1 3 21 76 157 73 +614 4 2 1 3 21 157 76 22 +615 4 2 1 3 13 114 153 109 +616 4 2 1 3 153 114 13 28 +617 4 2 1 3 87 21 160 85 +618 4 2 1 3 160 21 87 22 +619 4 2 1 3 72 14 127 74 +620 4 2 1 3 127 14 72 13 +621 4 2 1 3 127 35 72 74 +622 4 2 1 3 72 35 127 13 +623 4 2 1 3 13 127 150 125 +624 4 2 1 3 13 150 127 14 +625 4 2 1 3 78 138 131 146 +626 4 2 1 3 78 131 138 171 +$EndElements diff --git a/test/porousmediumflow/2p/implicit/boxdfm/problem.hh b/test/porousmediumflow/2p/implicit/boxdfm/problem.hh new file mode 100644 index 0000000000000000000000000000000000000000..258385a9d707ae236995e982d43b10f871fd58cc --- /dev/null +++ b/test/porousmediumflow/2p/implicit/boxdfm/problem.hh @@ -0,0 +1,233 @@ +// -*- 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 . * + *****************************************************************************/ +/*! + * \ingroup TwoPTests + * \brief The properties for the incompressible 2p-boxdfm test + */ +#ifndef DUMUX_INCOMPRESSIBLE_TWOPBOXDFM_TEST_PROBLEM_HH +#define DUMUX_INCOMPRESSIBLE_TWOPBOXDFM_TEST_PROBLEM_HH + +#include +#include +#include +#include + +#include +#include +#include +#include + +#include "spatialparams.hh" + +#ifndef GRIDTYPE +#define GRIDTYPE Dune::YaspGrid<2> +#endif + +namespace Dumux +{ +// forward declarations +template class TwoPTestProblem; + +namespace Properties +{ + +// we need to derive first from twop and then from the box-dfm Model +// because the flux variables cache type of TwoP is overwritten in BoxDfmModel +NEW_TYPE_TAG(TwoPIncompressibleBoxDfm, INHERITS_FROM(TwoP, BoxDfmModel)); + +// Set the grid type +SET_TYPE_PROP(TwoPIncompressibleBoxDfm, Grid, GRIDTYPE); + +// Set the problem type +SET_TYPE_PROP(TwoPIncompressibleBoxDfm, Problem, TwoPTestProblem); + +// Set the spatial parameters +SET_PROP(TwoPIncompressibleBoxDfm, SpatialParams) +{ +private: + using FVG = typename GET_PROP_TYPE(TypeTag, FVGridGeometry); + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); +public: + using type = TwoPTestSpatialParams; +}; + +// the local residual containing the analytic derivative methods +SET_TYPE_PROP(TwoPIncompressibleBoxDfm, LocalResidual, TwoPIncompressibleLocalResidual); + +// Set the fluid system +SET_PROP(TwoPIncompressibleBoxDfm, FluidSystem) +{ + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using WettingPhase = FluidSystems::OnePLiquid >; + using NonwettingPhase = FluidSystems::OnePLiquid >; + using type = FluidSystems::TwoPImmiscible; +}; + +// Enable caching +SET_BOOL_PROP(TwoPIncompressibleBoxDfm, EnableGridVolumeVariablesCache, false); +SET_BOOL_PROP(TwoPIncompressibleBoxDfm, EnableGridFluxVariablesCache, false); +SET_BOOL_PROP(TwoPIncompressibleBoxDfm, EnableFVGridGeometryCache, false); + +// Enable the box-interface solver +SET_BOOL_PROP(TwoPIncompressibleBoxDfm, EnableBoxInterfaceSolver, true); +} // end namespace Properties + +/*! + * \ingroup TwoPTests + * \brief The incompressible 2p-boxdfm test problem. + */ +template +class TwoPTestProblem : public PorousMediumFlowProblem +{ + using ParentType = PorousMediumFlowProblem; + + using GridView = typename GET_PROP_TYPE(TypeTag, GridView); + using Element = typename GridView::template Codim<0>::Entity; + using GlobalPosition = typename Element::Geometry::GlobalCoordinate; + + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); + using NumEqVector = typename GET_PROP_TYPE(TypeTag, NumEqVector); + using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); + using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry); + using SubControlVolume = typename FVGridGeometry::SubControlVolume; + + // some indices for convenience + using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem); + using Indices = typename GET_PROP_TYPE(TypeTag, ModelTraits)::Indices; + enum + { + pressureH2OIdx = Indices::pressureIdx, + saturationDNAPLIdx = Indices::saturationIdx, + contiDNAPLEqIdx = Indices::conti0EqIdx + FluidSystem::comp1Idx, + waterPhaseIdx = FluidSystem::phase0Idx, + dnaplPhaseIdx = FluidSystem::phase1Idx + }; + + static constexpr Scalar eps_ = 1e-6; + static constexpr int dimWorld = GridView::dimensionworld; + +public: + + //! The constructor + TwoPTestProblem(std::shared_ptr fvGridGeometry) + : ParentType(fvGridGeometry) + {} + + /*! + * \brief Return how much the domain is extruded at a given sub-control volume. + * + * Here, we extrude the fracture scvs by half the aperture + */ + template + Scalar extrusionFactor(const Element& element, + const SubControlVolume& scv, + const ElementSolution& elemSol) const + { + // In the box-scheme, we compute fluxes etc element-wise, + // thus per element we compute only half a fracture !!! + static const Scalar aHalf = getParam("SpatialParams.FractureAperture")/2.0; + + if (scv.isOnFracture()) + return aHalf; + + return 1.0; + } + + /*! + * \brief Specifies which kind of boundary condition should be + * used for which equation on a given boundary segment + * + * \param values Stores the value of the boundary type + * \param globalPos The global position + */ + BoundaryTypes boundaryTypesAtPos(const GlobalPosition &globalPos) const + { + BoundaryTypes values; + values.setAllNeumann(); + if (globalPos[0] > this->fvGridGeometry().bBoxMax()[0] - eps_ || globalPos[dimWorld-1] < 0.25) + values.setAllDirichlet(); + return values; + } + + /*! + * \brief Evaluates the boundary conditions for a Dirichlet + * boundary segment + * + * \param values Stores the Dirichlet values for the conservation equations in + * \f$ [ \textnormal{unit of primary variable} ] \f$ + * \param globalPos The global position + */ + PrimaryVariables dirichletAtPos(const GlobalPosition& globalPos) const + { return initialAtPos(globalPos); } + + /*! + * \brief Evaluate the boundary conditions for a neumann + * boundary segment. + * + * \param values Stores the Neumann values for the conservation equations in + * \f$ [ \textnormal{unit of conserved quantity} / (m^(dim-1) \cdot s )] \f$ + * \param globalPos The position of the integration point of the boundary segment. + * + * For this method, the \a values parameter stores the mass flux + * in normal direction of each phase. Negative values mean influx. + */ + NumEqVector neumannAtPos(const GlobalPosition& globalPos) const + { + NumEqVector fluxes(0.0); + if (isInInjectionPatch_(globalPos)) fluxes[contiDNAPLEqIdx] = -0.04; // kg / s / m^2 + return fluxes; + } + + /*! + * \brief Evaluates the initial values for a control volume + * + * \param values Stores the initial values for the conservation equations in + * \f$ [ \textnormal{unit of primary variables} ] \f$ + * \param globalPos The global position + */ + PrimaryVariables initialAtPos(const GlobalPosition &globalPos) const + { + PrimaryVariables values; + values[pressureH2OIdx] = 1e5 + 9.81*1000*(1.0-globalPos[dimWorld-1]); + values[saturationDNAPLIdx] = 0; + return values; + } + + //! Returns the temperature \f$\mathrm{[K]}\f$ for an isothermal problem. + Scalar temperature() const { return 293.15; /* 10°C */ } + +private: + bool isInInjectionPatch_(const GlobalPosition& globalPos) const + { + bool isInPatch = true; + if ( !(globalPos[dimWorld-1] > this->fvGridGeometry().bBoxMax()[dimWorld-1] - eps_) ) + isInPatch = false; + + for (int dir = 0; dir < dimWorld-1; ++dir) + if (globalPos[dir] < 0.25 || globalPos[dir] > 0.5) + isInPatch = false; + + return isInPatch; + } +}; + +} // end namespace Dumux + +#endif diff --git a/test/porousmediumflow/2p/implicit/boxdfm/spatialparams.hh b/test/porousmediumflow/2p/implicit/boxdfm/spatialparams.hh new file mode 100644 index 0000000000000000000000000000000000000000..9d71d79ede721d18f15990d7eade1d878648256f --- /dev/null +++ b/test/porousmediumflow/2p/implicit/boxdfm/spatialparams.hh @@ -0,0 +1,187 @@ +// -*- 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 . * + *****************************************************************************/ +/*! + * \ingroup TwoPTests + * \brief The spatial params for the incompressible 2p test + */ +#ifndef DUMUX_INCOMPRESSIBLE_TWOPBOXDFM_TEST_SPATIAL_PARAMS_HH +#define DUMUX_INCOMPRESSIBLE_TWOPBOXDFM_TEST_SPATIAL_PARAMS_HH + +#include + +#include +#include +#include +#include + +#include + +namespace Dumux { + +/*! + * \ingroup TwoPTests + * \brief The spatial params for the incompressible 2p test + */ +template +class TwoPTestSpatialParams : public FVSpatialParams< FVGridGeometry, Scalar, TwoPTestSpatialParams > +{ + using ThisType = TwoPTestSpatialParams; + using ParentType = FVSpatialParams; + + using GridView = typename FVGridGeometry::GridView; + using Element = typename GridView::template Codim<0>::Entity; + using GlobalPosition = typename Element::Geometry::GlobalCoordinate; + + using FVElementGeometry = typename FVGridGeometry::LocalView; + using SubControlVolume = typename FVElementGeometry::SubControlVolume; + + static constexpr int dimWorld = GridView::dimensionworld; + +public: + using MaterialLaw = EffToAbsLaw< RegularizedBrooksCorey >; + using MaterialLawParams = typename MaterialLaw::Params; + using PermeabilityType = Scalar; + + TwoPTestSpatialParams(std::shared_ptr fvGridGeometry) : ParentType(fvGridGeometry) + { + // residual saturations + matrixMaterialParams_.setSwr(0.18); + matrixMaterialParams_.setSnr(0.0); + lensMaterialParams_.setSwr(0.28); + lensMaterialParams_.setSnr(0.0); + fractureMaterialParams_.setSwr(0.05); + fractureMaterialParams_.setSnr(0.0); + + // parameters for the Brooks-Corey law + matrixMaterialParams_.setPe(1e4); + matrixMaterialParams_.setLambda(2); + lensMaterialParams_.setPe(5e4); + lensMaterialParams_.setLambda(2); + fractureMaterialParams_.setPe(1e3); + fractureMaterialParams_.setLambda(2); + } + + /*! + * \brief Function for defining the (intrinsic) permeability \f$[m^2]\f$. + * In this test, we use element-wise distributed permeabilities. + * + * \param element The current element + * \param scv The sub-control volume inside the element. + * \param elemSol The solution at the dofs connected to the element. + * \return permeability + */ + template + PermeabilityType permeability(const Element& element, + const SubControlVolume& scv, + const ElementSolution& elemSol) const + { + if (scv.isOnFracture()) + return 5e-8; + else if (isInLens_(element.geometry().center())) + return 1e-13; + else + return 1e-12; + } + + /*! + * \brief Returns the porosity \f$[-]\f$ + * + * \param globalPos The global position + */ + template + Scalar porosity(const Element& element, + const SubControlVolume& scv, + const ElementSolution& elemSol) const + { + if (scv.isOnFracture()) + return 0.6; + else + return 0.15; + } + + /*! + * \brief Returns the parameter object for the Brooks-Corey material law. + * In this test, we use element-wise distributed material parameters. + * + * \param element The current element + * \param scv The sub-control volume inside the element. + * \param elemSol The solution at the dofs connected to the element. + * \return the material parameters object + */ + template + const MaterialLawParams& materialLawParams(const Element& element, + const SubControlVolume& scv, + const ElementSolution& elemSol) const + { + if (scv.isOnFracture()) + return fractureMaterialParams_; + else if (isInLens_(element.geometry().center())) + return lensMaterialParams_; + else + return matrixMaterialParams_; + } + + /*! + * \brief Function for defining which phase is to be considered as the wetting phase. + * + * \return the wetting phase index + * \param globalPos The global position + */ + template + int wettingPhaseAtPos(const GlobalPosition& globalPos) const + { return FluidSystem::phase0Idx; } + + //! Updates the map of which material parameters are associated with a nodal dof. + template + void updateMaterialInterfaceParams(const SolutionVector& x) + { + materialInterfaceParams_.update(this->fvGridGeometry(), *this, x); + } + + //! Returns the material parameters associated with a nodal dof + const BoxMaterialInterfaceParams& materialInterfaceParams() const + { return materialInterfaceParams_; } + +private: + bool isInLens_(const GlobalPosition& globalPos) const + { + bool isInLens = true; + if ( globalPos[dimWorld-1] > 0.5 || globalPos[dimWorld-1] < 0.25 ) + isInLens = false; + + for (int dir = 0; dir < dimWorld-1; ++dir) + if (globalPos[dir] < 0.25 || globalPos[dir] > 0.75) + isInLens = false; + + return isInLens; + } + + MaterialLawParams matrixMaterialParams_; + MaterialLawParams lensMaterialParams_; + MaterialLawParams fractureMaterialParams_; + + // Determines the parameters associated with the dofs at material interfaces + BoxMaterialInterfaceParams materialInterfaceParams_; + + static constexpr Scalar eps_ = 1.5e-7; +}; + +} // end namespace Dumux + +#endif diff --git a/test/porousmediumflow/2p/implicit/boxdfm/test_2p.input b/test/porousmediumflow/2p/implicit/boxdfm/test_2p.input new file mode 100644 index 0000000000000000000000000000000000000000..94ae60a0f48692464652d75309b5d8536fb133ac --- /dev/null +++ b/test/porousmediumflow/2p/implicit/boxdfm/test_2p.input @@ -0,0 +1,15 @@ +[TimeLoop] +DtInitial = 200 # [s] +TEnd = 2700 # [s] +MaxTimeStepSize = 50 + +[Grid] +LowerLeft = 0 0 +UpperRight = 1 1 +Cells = 20 20 + +[SpatialParams] +FractureAperture = 1e-3 + +[Problem] +Name = 2pboxdfm_quads_yasp diff --git a/test/porousmediumflow/2p/implicit/boxdfm/test_2pboxdfm.cc b/test/porousmediumflow/2p/implicit/boxdfm/test_2pboxdfm.cc new file mode 100644 index 0000000000000000000000000000000000000000..dac6d77ed3842b4a0f8d533649035775ea691d43 --- /dev/null +++ b/test/porousmediumflow/2p/implicit/boxdfm/test_2pboxdfm.cc @@ -0,0 +1,261 @@ +// -*- 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 . * + *****************************************************************************/ +/*! + * \file + * + * \brief test for the two-phase porousmedium flow model + */ +#include + +#include +#include + +#include +#include +#include +#include +#include + +#include "problem.hh" + +#include +#include +#include +#include +#include + +#include +#include + +#include +#include + +#include + +#include + +/*! + * \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) +{ + if (errorMsg.size() > 0) { + std::string errorMessageOut = "\nUsage: "; + errorMessageOut += progName; + errorMessageOut += " [options]\n"; + errorMessageOut += errorMsg; + errorMessageOut += "\n\nThe list of mandatory arguments for this program is:\n" + "\t-TimeManager.TEnd End of the simulation [s] \n" + "\t-TimeManager.DtInitial Initial timestep size [s] \n" + "\t-Grid.LowerLeft Lower left corner coordinates\n" + "\t-Grid.UpperRight Upper right corner coordinates\n" + "\t-Grid.Cells Number of cells in respective coordinate directions\n" + "\t definition in DGF format\n" + "\t-SpatialParams.LensLowerLeft coordinates of the lower left corner of the lens [m] \n" + "\t-SpatialParams.LensUpperRight coordinates of the upper right corner of the lens [m] \n" + "\t-SpatialParams.Permeability Permeability of the domain [m^2] \n" + "\t-SpatialParams.PermeabilityLens Permeability of the lens [m^2] \n"; + + std::cout << errorMessageOut + << "\n"; + } +} + +int main(int argc, char** argv) try +{ + using namespace Dumux; + + // define the type tag for this problem + using TypeTag = TTAG(TwoPIncompressibleBoxDfm); + + // 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 command line arguments and input file + Parameters::init(argc, argv, usage); + + // try to create a grid (from the given grid file or the input file) + using GridCreator = typename GET_PROP_TYPE(TypeTag, GridCreator); + GridCreator::makeGrid(); + GridCreator::loadBalance(); + + //////////////////////////////////////////////////////////// + // run instationary non-linear problem on this grid + //////////////////////////////////////////////////////////// + + // we compute on the leaf grid view + const auto& leafGridView = GridCreator::grid().leafGridView(); + + // create the finite volume grid geometry + using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry); + auto fvGridGeometry = std::make_shared(leafGridView); + + // mark some vertices to lie on fractures + // When the facet coupling framework is merged into master, some functionality + // can be reused to read a network from e.g. a gmsh file + std::vector vertexIsOnFracture(leafGridView.size(FVGridGeometry::GridView::dimension), false); + for (const auto& v : vertices(leafGridView)) + { + const auto c = v.geometry().center(); + constexpr int dimWorld = FVGridGeometry::GridView::dimensionworld; + + bool vertIsOnFrac = true; + + if ( !(c[0] > 0.5 - 1e-6 && c[0] < 0.5 + 1e-6) ) + vertIsOnFrac = false; + + if (dimWorld == 3 && (c[1] < 0.25 - 1e-6 || c[1] > 0.75 + 1e-6)) + vertIsOnFrac = false; + + if (c[dimWorld-1] > 0.6 + 1e-6 || c[dimWorld-1] < 0.15 - 1e-6) + vertIsOnFrac = false; + + vertexIsOnFracture[fvGridGeometry->vertexMapper().index(v)] = vertIsOnFrac; + } + + // update the geometry subject to the marked vertices + fvGridGeometry->update(vertexIsOnFracture); + + // the problem (initial and boundary conditions) + using Problem = typename GET_PROP_TYPE(TypeTag, Problem); + auto problem = std::make_shared(fvGridGeometry); + + // the solution vector + using SolutionVector = typename GET_PROP_TYPE(TypeTag, SolutionVector); + SolutionVector x(fvGridGeometry->numDofs()); + problem->applyInitialSolution(x); + auto xOld = x; + + // update the interface parameters + problem->spatialParams().updateMaterialInterfaceParams(x); + + // the grid variables + using GridVariables = typename GET_PROP_TYPE(TypeTag, GridVariables); + auto gridVariables = std::make_shared(problem, fvGridGeometry); + gridVariables->init(x, xOld); + + // get some time loop parameters + using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); + const auto tEnd = getParam("TimeLoop.TEnd"); + const auto maxDt = getParam("TimeLoop.MaxTimeStepSize"); + auto dt = getParam("TimeLoop.DtInitial"); + + // check if we are about to restart a previously interrupted simulation + Scalar restartTime = 0; + if (Parameters::getTree().hasKey("Restart") || Parameters::getTree().hasKey("TimeLoop.Restart")) + restartTime = getParam("TimeLoop.Restart"); + + // intialize the vtk output module + using VtkOutputFields = typename GET_PROP_TYPE(TypeTag, VtkOutputFields); + using FractureGrid = FRACTUREGRIDTYPE; + BoxDfmVtkOutputModule vtkWriter(*problem, *fvGridGeometry, *gridVariables, x, problem->name(), "", Dune::VTK::nonconforming); + VtkOutputFields::init(vtkWriter); //!< Add model specific output fields + vtkWriter.write(0.0); + + // instantiate time loop + auto timeLoop = std::make_shared>(restartTime, dt, tEnd); + timeLoop->setMaxTimeStepSize(maxDt); + + // the assembler with time loop for instationary problem + using Assembler = FVAssembler; + auto assembler = std::make_shared(problem, fvGridGeometry, gridVariables, timeLoop); + + // the linear solver + using LinearSolver = ILU0BiCGSTABBackend; + auto linearSolver = std::make_shared(); + + // the non-linear solver + using NewtonSolver = Dumux::NewtonSolver; + NewtonSolver nonLinearSolver(assembler, linearSolver); + + // time loop + timeLoop->start(); do + { + // set previous solution for storage evaluations + assembler->setPreviousSolution(xOld); + + // solve the non-linear system with time step control + nonLinearSolver.solve(x, *timeLoop); + + // make the new solution the old solution + xOld = x; + gridVariables->advanceTimeStep(); + + // advance to the time loop to the next step + timeLoop->advanceTimeStep(); + + // write vtk output + vtkWriter.write(timeLoop->time()); + + // report statistics of this time step + timeLoop->reportTimeStep(); + + // set new dt as suggested by the Newton solver + timeLoop->setTimeStepSize(nonLinearSolver.suggestTimeStepSize(timeLoop->timeStepSize())); + + } while (!timeLoop->finished()); + + timeLoop->finalize(leafGridView.comm()); + + //////////////////////////////////////////////////////////// + // finalize, print dumux message to say goodbye + //////////////////////////////////////////////////////////// + + // print dumux end message + if (mpiHelper.rank() == 0) + { + Parameters::print(); + DumuxMessage::print(/*firstCall=*/false); + } + + return 0; +} // end main +catch (Dumux::ParameterException &e) +{ + 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." + << " ---> Abort!" << std::endl; + return 2; +} +catch (Dune::Exception &e) +{ + std::cerr << "Dune reported error: " << e << " ---> Abort!" << std::endl; + return 3; +} +catch (...) +{ + std::cerr << "Unknown exception thrown! ---> Abort!" << std::endl; + return 4; +} diff --git a/test/references/2pboxdfm_2d_quads-reference.vtu b/test/references/2pboxdfm_2d_quads-reference.vtu new file mode 100644 index 0000000000000000000000000000000000000000..77d9aab08cfe921d232edbdf098481a4f070d3da --- /dev/null +++ b/test/references/2pboxdfm_2d_quads-reference.vtu @@ -0,0 +1,2021 @@ + + + + + + + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 + + + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10002.2 + 10000 10000 10002.2 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10001.3 10000 10002.2 10001.3 10591.1 10002.2 10000 10591.1 10001.5 + 10000 10000 10001.5 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10001.3 10000 10000.1 + 10001.3 10591.1 10000.1 10311.6 10591.1 10001.5 10311.6 10000.1 10001.5 10000 10000.1 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000.1 10000 10000 10000.1 10311.6 10000 10066.3 + 10311.6 10000.1 10066.3 10000 10000.1 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000.9 10000 10000 10000.9 10053 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10015.5 10000 10000.9 10015.5 10341.8 + 10000.9 10053 10341.8 10979.8 10053 10334.6 10979.8 11403.9 10334.6 10622.1 11403.9 11613.3 + 10622.1 10684.6 11613.3 11627.7 10684.6 10318.9 11627.7 11312.6 10318.9 10000 11312.6 10000 + 10000 10008.4 10000 10540.3 10008.4 10000.2 10540.3 10218.2 10000.2 10000 10218.2 10010.5 + 10000 10000 10010.5 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10040.2 + 10000 10015.5 10040.2 10762.4 10015.5 10341.8 10762.4 11607.5 10341.8 10979.8 11607.5 12025.1 + 10979.8 11403.9 12025.1 12281.2 11403.9 11613.3 12281.2 12425.1 11613.3 11627.7 12425.1 12431.6 + 11627.7 11312.6 12431.6 12172 11312.6 10000 12172 10000 10000 10540.3 10000 11691.7 + 10540.3 10218.2 11691.7 11485 10218.2 10010.5 11485 10746.1 10010.5 10000 10746.1 10060.2 + 10000 10000 10060.2 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10034.6 10000 10040.2 10034.6 10934.4 10040.2 10762.4 10934.4 11845.1 + 10762.4 11607.5 11845.1 12341.3 11607.5 12025.1 12341.3 12689.2 12025.1 12281.2 12689.2 12920.7 + 12281.2 12425.1 12920.7 13055.4 12425.1 12431.6 13055.4 13079.4 12431.6 12172 13079.4 12923.1 + 12172 10000 12923.1 12698.9 10000 11691.7 12698.9 12540 11691.7 11485 12540 12328.2 + 11485 10746.1 12328.2 11912 10746.1 10060.2 11912 11130.1 10060.2 10000 11130.1 10103.2 + 10000 10000 10103.2 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10034.6 10033.1 10786.1 + 10034.6 10934.4 10786.1 11844.7 10934.4 11845.1 11844.7 12438.5 11845.1 12341.3 12438.5 12883.9 + 12341.3 12689.2 12883.9 13214.6 12689.2 12920.7 13214.6 13448.4 12920.7 13055.4 13448.4 13592 + 13055.4 13079.4 13592 13636 13079.4 12923.1 13636 13584.6 12923.1 12698.9 13584.6 13450.3 + 12698.9 12540 13450.3 13245.5 12540 12328.2 13245.5 12965.1 12328.2 11912 12965.1 12580.7 + 11912 11130.1 12580.7 12051.8 11130.1 10103.2 12051.8 11166.5 10103.2 10000 11166.5 10073.5 + 10000 10000 10073.5 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10033.1 10786.1 10782 11674.7 10786.1 11844.7 11674.7 12341.5 + 11844.7 12438.5 12341.5 12886.2 12438.5 12883.9 12886.2 13326.8 12883.9 13214.6 13326.8 13676.8 + 13214.6 13448.4 13676.8 13934.1 13448.4 13592 13934.1 14094.4 13592 13636 14094.4 14149.3 + 13636 13584.6 14149.3 14105.9 13584.6 13450.3 14105.9 13970.6 13450.3 13245.5 13970.6 13751.8 + 13245.5 12965.1 13751.8 13457.2 12965.1 12580.7 13457.2 13085.8 12580.7 12051.8 13085.8 12611.9 + 12051.8 11166.5 12611.9 11982.4 11166.5 10073.5 11982.4 10875.6 10073.5 10000 10875.6 10019.6 + 10000 10000 10019.6 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10782 11674.7 11702 12132.8 11674.7 12341.5 12132.8 12705.9 12341.5 12886.2 12705.9 13243.8 + 12886.2 13326.8 13243.8 13721.6 13326.8 13676.8 13721.6 14121.1 13676.8 13934.1 14121.1 14422.3 + 13934.1 14094.4 14422.3 14608.7 14094.4 14149.3 14608.7 14667.3 14149.3 14105.9 14667.3 14608.7 + 14105.9 13970.6 14608.7 14445.2 13970.6 13751.8 14445.2 14193.4 13751.8 13457.2 14193.4 13870.7 + 13457.2 13085.8 13870.7 13486.1 13085.8 12611.9 13486.1 13030.7 12611.9 11982.4 13030.7 12462 + 11982.4 10875.6 12462 11696 10875.6 10019.6 11696 10365.3 10019.6 10000 10365.3 10000.8 + 10000 10000 10000.8 10000 10000 10000 10000 10000 11702 12132.8 12138.4 12440.6 + 12132.8 12705.9 12440.6 12973.5 12705.9 13243.8 12973.5 13544.9 13243.8 13721.6 13544.9 14095.2 + 13721.6 14121.1 14095.2 14581.1 14121.1 14422.3 14581.1 14954.3 14422.3 14608.7 14954.3 15179.2 + 14608.7 14667.3 15179.2 15240.1 14667.3 14608.7 15240.1 15152.1 14608.7 14445.2 15152.1 14934.9 + 14445.2 14193.4 14934.9 14619.6 14193.4 13870.7 14619.6 14239.8 13870.7 13486.1 14239.8 13815.1 + 13486.1 13030.7 13815.1 13344.5 13030.7 12462 13344.5 12800.9 12462 11696 12800.9 12112.6 + 11696 10365.3 12112.6 11041.9 10365.3 10000.8 11041.9 10042.5 10000.8 10000 10042.5 10000 + 10000 10000 10000 10000 12138.4 12440.6 12354.2 12624.8 12440.6 12973.5 12624.8 13162 + 12973.5 13544.9 13162 13795.3 13544.9 14095.2 13795.3 14459.7 14095.2 14581.1 14459.7 15088.2 + 14581.1 14954.3 15088.2 15579.9 14954.3 15179.2 15579.9 15860 15179.2 15240.1 15860 15922 + 15240.1 15152.1 15922 15787.4 15152.1 14934.9 15787.4 15475 14934.9 14619.6 15475 15044.4 + 14619.6 14239.8 15044.4 14564.7 14239.8 13815.1 14564.7 14070.8 13815.1 13344.5 14070.8 13562.8 + 13344.5 12800.9 13562.8 13013.5 12800.9 12112.6 13013.5 12360.2 12112.6 11041.9 12360.2 11478.4 + 11041.9 10042.5 11478.4 10207.6 10042.5 10000 10207.6 10000.1 10000 10000 10000.1 10000 + 12354.2 12624.8 12416.2 12685.4 12624.8 13162 12685.4 13248.5 13162 13795.3 13248.5 13960.6 + 13795.3 14459.7 13960.6 14792.8 14459.7 15088.2 14792.8 15679.7 15088.2 15579.9 15679.7 16383.3 + 15579.9 15860 16383.3 16729.5 15860 15922 16729.5 16789.2 15922 15787.4 16789.2 16592.3 + 15787.4 15475 16592.3 16097.1 15475 15044.4 16097.1 15440.5 15044.4 14564.7 15440.5 14797 + 14564.7 14070.8 14797 14211.6 14070.8 13562.8 14211.6 13657.2 13562.8 13013.5 13657.2 13091.8 + 13013.5 12360.2 13091.8 12452.9 12360.2 11478.4 12452.9 11631.3 11478.4 10207.6 11631.3 10356.6 + 10207.6 10000.1 10356.6 10000.7 10000.1 10000 10000.7 10000 12416.2 12685.4 12300.5 12578.7 + 12685.4 13248.5 12578.7 13160.7 13248.5 13960.6 13160.7 13923.1 13960.6 14792.8 13923.1 14909.4 + 14792.8 15679.7 14909.4 16426.4 15679.7 16383.3 16426.4 17570.8 16383.3 16729.5 17570.8 17917.8 + 16729.5 16789.2 17917.8 17969.9 16789.2 16592.3 17969.9 17757.7 16592.3 16097.1 17757.7 16846.3 + 16097.1 15440.5 16846.3 15602.5 15440.5 14797 15602.5 14789.1 14797 14211.6 14789.1 14142.8 + 14211.6 13657.2 14142.8 13563.4 13657.2 13091.8 13563.4 12989.9 13091.8 12452.9 12989.9 12355.2 + 12452.9 11631.3 12355.2 11534.2 11631.3 10356.6 11534.2 10298.1 10356.6 10000.7 10298.1 10000.4 + 10000.7 10000 10000.4 10000 + + + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 0.999638 + 1 1 0.999638 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 0.999785 1 0.999638 0.999785 0.911029 0.999638 1 0.911029 0.999753 + 1 1 0.999753 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 0.999785 1 0.999983 + 0.999785 0.911029 0.999983 0.951197 0.911029 0.999753 0.951197 0.999979 0.999753 1 0.999979 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 0.999983 1 1 0.999983 0.951197 1 0.989241 + 0.951197 0.999979 0.989241 1 0.999979 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 0.999857 1 1 0.999857 0.991372 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 0.997456 1 0.999857 0.997456 0.946696 + 0.999857 0.991372 0.946696 0.860179 0.991372 0.947758 0.860179 0.810529 0.947758 0.906763 0.810529 0.788001 + 0.906763 0.898289 0.788001 0.786496 0.898289 0.950098 0.786496 0.820749 0.950098 1 0.820749 1 + 1 0.998622 1 0.918085 0.998622 0.999959 0.918085 0.965347 0.999959 1 0.965347 0.998273 + 1 1 0.998273 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 0.993445 + 1 0.997456 0.993445 0.887933 0.997456 0.946696 0.887933 0.788606 0.946696 0.860179 0.788606 0.74707 + 0.860179 0.810529 0.74707 0.723664 0.810529 0.788001 0.723664 0.711147 0.788001 0.786496 0.711147 0.710592 + 0.786496 0.820749 0.710592 0.733466 0.820749 1 0.733466 1 1 0.918085 1 0.779868 + 0.918085 0.965347 0.779868 0.801662 0.965347 0.998273 0.801662 0.890085 0.998273 1 0.890085 0.99022 + 1 1 0.99022 0.999998 1 1 0.999998 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 0.994354 1 0.993445 0.994354 0.86584 0.993445 0.887933 0.86584 0.764431 + 0.887933 0.788606 0.764431 0.718386 0.788606 0.74707 0.718386 0.689269 0.74707 0.723664 0.689269 0.671179 + 0.723664 0.711147 0.671179 0.661097 0.711147 0.710592 0.661097 0.659331 0.710592 0.733466 0.659331 0.670999 + 0.733466 1 0.670999 0.688493 1 0.779868 0.688493 0.70146 0.779868 0.801662 0.70146 0.719532 + 0.801662 0.890085 0.719532 0.757889 0.890085 0.99022 0.757889 0.841935 0.99022 0.999998 0.841935 0.983336 + 0.999998 1 0.983336 0.999998 1 1 0.999998 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 0.994354 0.994594 0.88483 + 0.994354 0.86584 0.88483 0.764474 0.86584 0.764431 0.764474 0.710001 0.764431 0.718386 0.710001 0.673993 + 0.718386 0.689269 0.673993 0.649579 0.689269 0.671179 0.649579 0.633388 0.671179 0.661097 0.633388 0.623864 + 0.661097 0.659331 0.623864 0.621002 0.659331 0.670999 0.621002 0.624347 0.670999 0.688493 0.624347 0.633265 + 0.688493 0.70146 0.633265 0.647386 0.70146 0.719532 0.647386 0.66782 0.719532 0.757889 0.66782 0.698091 + 0.757889 0.841935 0.698091 0.744559 0.841935 0.983336 0.744559 0.837631 0.983336 0.999998 0.837631 0.988073 + 0.999998 1 0.988073 1 1 1 1 1 1 1 1 1 + 1 1 1 1 0.994594 0.88483 0.885369 0.781624 0.88483 0.764474 0.781624 0.718366 + 0.764474 0.710001 0.718366 0.673813 0.710001 0.673993 0.673813 0.6417 0.673993 0.649579 0.6417 0.618373 + 0.649579 0.633388 0.618373 0.602337 0.633388 0.623864 0.602337 0.592783 0.623864 0.621002 0.592783 0.589583 + 0.621002 0.624347 0.589583 0.592107 0.624347 0.633265 0.592107 0.600127 0.633265 0.647386 0.600127 0.613606 + 0.647386 0.66782 0.613606 0.632798 0.66782 0.698091 0.632798 0.658864 0.698091 0.744559 0.658864 0.695526 + 0.744559 0.837631 0.695526 0.751117 0.837631 0.988073 0.751117 0.873274 0.988073 1 0.873274 0.996795 + 1 1 0.996795 1 1 1 1 1 1 1 1 1 + 0.885369 0.781624 0.77882 0.737045 0.781624 0.718366 0.737045 0.687925 0.718366 0.673813 0.687925 0.647505 + 0.673813 0.6417 0.647505 0.615517 0.6417 0.618373 0.615517 0.59122 0.618373 0.602337 0.59122 0.574224 + 0.602337 0.592783 0.574224 0.564232 0.592783 0.589583 0.564232 0.561163 0.589583 0.592107 0.561163 0.564227 + 0.592107 0.600127 0.564227 0.572977 0.600127 0.613606 0.572977 0.587043 0.613606 0.632798 0.587043 0.606202 + 0.632798 0.658864 0.606202 0.630863 0.658864 0.695526 0.630863 0.662925 0.695526 0.751117 0.662925 0.708003 + 0.751117 0.873274 0.708003 0.779432 0.873274 0.996795 0.779432 0.943225 0.996795 1 0.943225 0.999875 + 1 1 0.999875 1 1 1 1 1 0.77882 0.737045 0.73653 0.709821 + 0.737045 0.687925 0.709821 0.667189 0.687925 0.647505 0.667189 0.626953 0.647505 0.615517 0.626953 0.592732 + 0.615517 0.59122 0.592732 0.565687 0.59122 0.574224 0.565687 0.546675 0.574224 0.564232 0.546675 0.535892 + 0.564232 0.561163 0.535892 0.53305 0.561163 0.564227 0.53305 0.537162 0.564227 0.572977 0.537162 0.547629 + 0.572977 0.587043 0.547629 0.563654 0.587043 0.606202 0.563654 0.584397 0.606202 0.630863 0.584397 0.609639 + 0.630863 0.662925 0.609639 0.640476 0.662925 0.708003 0.640476 0.680421 0.708003 0.779432 0.680421 0.738909 + 0.779432 0.943225 0.738909 0.852557 0.943225 0.999875 0.852557 0.993069 0.999875 1 0.993069 1 + 1 1 1 1 0.73653 0.709821 0.717259 0.694472 0.709821 0.667189 0.694472 0.65334 + 0.667189 0.626953 0.65334 0.610873 0.626953 0.592732 0.610873 0.572188 0.592732 0.565687 0.572188 0.540195 + 0.565687 0.546675 0.540195 0.517821 0.546675 0.535892 0.517821 0.505994 0.535892 0.53305 0.505994 0.50346 + 0.53305 0.537162 0.50346 0.508999 0.537162 0.547629 0.508999 0.522417 0.547629 0.563654 0.522417 0.542296 + 0.563654 0.584397 0.542296 0.566556 0.584397 0.609639 0.566556 0.594165 0.609639 0.640476 0.594165 0.625774 + 0.640476 0.680421 0.625774 0.664204 0.680421 0.738909 0.664204 0.716742 0.738909 0.852557 0.716742 0.802371 + 0.852557 0.993069 0.802371 0.966992 0.993069 1 0.966992 0.999984 1 1 0.999984 1 + 0.717259 0.694472 0.711911 0.689571 0.694472 0.65334 0.689571 0.647177 0.65334 0.610873 0.647177 0.600733 + 0.610873 0.572188 0.600733 0.554726 0.572188 0.540195 0.554726 0.513532 0.540195 0.517821 0.513532 0.485501 + 0.517821 0.505994 0.485501 0.472988 0.505994 0.50346 0.472988 0.470906 0.50346 0.508999 0.470906 0.477851 + 0.508999 0.522417 0.477851 0.496458 0.522417 0.542296 0.496458 0.523947 0.542296 0.566556 0.523947 0.554513 + 0.566556 0.594165 0.554513 0.586004 0.594165 0.625774 0.586004 0.619634 0.625774 0.664204 0.619634 0.658428 + 0.664204 0.716742 0.658428 0.708778 0.716742 0.802371 0.708778 0.786114 0.802371 0.966992 0.786114 0.944497 + 0.966992 0.999984 0.944497 0.999884 0.999984 1 0.999884 1 0.711911 0.689571 0.721958 0.698252 + 0.689571 0.647177 0.698252 0.653432 0.647177 0.600733 0.653432 0.603 0.600733 0.554726 0.603 0.548886 + 0.554726 0.513532 0.548886 0.4839 0.513532 0.485501 0.4839 0.445601 0.485501 0.472988 0.445601 0.435415 + 0.472988 0.470906 0.435415 0.433936 0.470906 0.477851 0.433936 0.440039 0.477851 0.496458 0.440039 0.468939 + 0.496458 0.523947 0.468939 0.516841 0.523947 0.554513 0.516841 0.554915 0.554513 0.586004 0.554915 0.589961 + 0.586004 0.619634 0.589961 0.625734 0.619634 0.658428 0.625734 0.66596 0.658428 0.708778 0.66596 0.717172 + 0.708778 0.786114 0.717172 0.796364 0.786114 0.944497 0.796364 0.95321 0.944497 0.999884 0.95321 0.999932 + 0.999884 1 0.999932 1 + + + 109810 109810 109320 109382 109810 109810 109382 109432 109810 109810 109432 109465 + 109810 109810 109465 109481 109810 109810 109481 109484 109810 109810 109484 109481 + 109810 109810 109481 109476 109810 109810 109476 109473 109810 109810 109473 109470 + 109810 109810 109470 109460 109810 109810 109460 109445 109810 109810 109445 109426 + 109810 109810 109426 109406 109810 109810 109406 109389 109810 109810 109389 109375 + 109810 109810 109375 109364 109810 109810 109364 109353 109810 109810 109353 109342 + 109810 109810 109342 109331 109810 109810 109331 109320 109320 109382 108829 108968 + 109382 109432 108968 109074 109432 109465 109074 109138 109465 109481 109138 109164 + 109481 109484 109164 109164 109484 109481 109164 109152 109481 109476 109152 109139 + 109476 109473 109139 109135 109473 109470 109135 109141 109470 109460 109141 109110 + 109460 109445 109110 109092 109445 109426 109092 109039 109426 109406 109039 108998 + 109406 109389 108998 108965 109389 109375 108965 108939 109375 109364 108939 108916 + 109364 109353 108916 108895 109353 109342 108895 108874 109342 109331 108874 108852 + 109331 109320 108852 108829 108829 108968 108338 108594 108968 109074 108594 108765 + 109074 109138 108765 108848 109138 109164 108848 108872 109164 109164 108872 108857 + 109164 109152 108857 108823 109152 109139 108823 108793 109139 109135 108793 108784 + 109135 109141 108784 108800 109141 109110 108800 108949 109110 109092 108949 108720 + 109092 109039 108720 108642 109039 108998 108642 108581 108998 108965 108581 108535 + 108965 108939 108535 108498 108939 108916 108498 108468 108916 108895 108468 108438 + 108895 108874 108438 108407 108874 108852 108407 108373 108852 108829 108373 108338 + 108338 108594 107848 108352 108594 108765 108352 108535 108765 108848 108535 108615 + 108848 108872 108615 108623 108872 108857 108623 108569 108857 108823 108569 108486 + 108823 108793 108486 108425 108793 108784 108425 108406 108784 108800 108406 108428 + 108800 108949 108428 108512 108949 108720 108512 108332 108720 108642 108332 108227 + 108642 108581 108227 108150 108581 108535 108150 108093 108535 108498 108093 108053 + 108498 108468 108053 108019 108468 108438 108019 107983 108438 108407 107983 107942 + 108407 108373 107942 107896 108373 108338 107896 107848 107848 108352 108211 108281 + 108352 108535 108281 108392 108535 108615 108392 108448 108615 108623 108448 108442 + 108623 108569 108442 108329 108569 108486 108329 108100 108486 108425 108100 108018 + 108425 108406 108018 107991 108406 108428 107991 108005 108428 108512 108005 108041 + 108512 108332 108041 107901 108332 108227 107901 107786 108227 108150 107786 107699 + 108150 108093 107699 107634 108093 108053 107634 107599 108053 108019 107599 107577 + 108019 107983 107577 107535 107983 107942 107535 107482 107942 107896 107482 107421 + 107896 107848 107421 107358 108211 108281 108243 108264 108281 108392 108264 108306 + 108392 108448 108306 108336 108448 108442 108336 108335 108442 108329 108335 108318 + 108329 108100 108318 108184 108100 108018 108184 108096 108018 107991 108096 108038 + 107991 108005 108038 107986 108005 108041 107986 107911 108041 107901 107911 107790 + 107901 107786 107790 107645 107786 107699 107645 107495 107699 107634 107495 107343 + 107634 107599 107343 107180 107599 107577 107180 107150 107577 107535 107150 107097 + 107535 107482 107097 107028 107482 107421 107028 106950 107421 107358 106950 106867 + 108243 108264 108215 108223 108264 108306 108223 108241 108306 108336 108241 108258 + 108336 108335 108258 108265 108335 108318 108265 108263 108318 108184 108263 108210 + 108184 108096 108210 108150 108096 108038 108150 108077 108038 107986 108077 107980 + 107986 107911 107980 107854 107911 107790 107854 107693 107790 107645 107693 107504 + 107645 107495 107504 107293 107495 107343 107293 107057 107343 107180 107057 106791 + 107180 107150 106791 106747 107150 107097 106747 106675 107097 107028 106675 106584 + 107028 106950 106584 106483 106950 106867 106483 106376 108215 108223 108167 108170 + 108223 108241 108170 108180 108241 108258 108180 108192 108258 108265 108192 108204 + 108265 108263 108204 108212 108263 108210 108212 108238 108210 108150 108238 108219 + 108150 108077 108219 108139 108077 107980 108139 108005 107980 107854 108005 107831 + 107854 107693 107831 107622 107693 107504 107622 107385 107504 107293 107385 107114 + 107293 107057 107114 106801 107057 106791 106801 106435 106791 106747 106435 106372 + 106747 106675 106372 106271 106675 106584 106271 106150 106584 106483 106150 106020 + 106483 106376 106020 105886 108167 108170 108110 108111 108170 108180 108111 108115 + 108180 108192 108115 108126 108192 108204 108126 108148 108204 108212 108148 108169 + 108212 108238 108169 108321 108238 108219 108321 108353 108219 108139 108353 108257 + 108139 108005 108257 108068 108005 107831 108068 107837 107831 107622 107837 107578 + 107622 107385 107578 107296 107385 107114 107296 106977 107114 106801 106977 106604 + 106801 106435 106604 106136 106435 106372 106136 106037 106372 106271 106037 105885 + 106271 106150 105885 105724 106150 106020 105724 105560 106020 105886 105560 105396 + 108110 108111 108052 108050 108111 108115 108050 108046 108115 108126 108046 108048 + 108126 108148 108048 108068 108148 108169 108068 108195 108169 108321 108195 108543 + 108321 108353 108543 108621 108353 108257 108621 108479 108257 108068 108479 108159 + 108068 107837 108159 107854 107837 107578 107854 107558 107578 107296 107558 107245 + 107296 106977 107245 106886 106977 106604 106886 106494 106604 106136 106494 105997 + 106136 106037 105997 105723 106037 105885 105723 105505 105885 105724 105505 105301 + 105724 105560 105301 105102 105560 105396 105102 104905 108052 108050 107999 107991 + 108050 108046 107991 107977 108046 108048 107977 107937 108048 108068 107937 108006 + 108068 108195 108006 108217 108195 108543 108217 108372 108543 108621 108372 108370 + 108621 108479 108370 108177 108479 108159 108177 107808 108159 107854 107808 107391 + 107854 107558 107391 107203 107558 107245 107203 106826 107245 106886 106826 106443 + 106886 106494 106443 106073 106494 105997 106073 105700 105997 105723 105700 105383 + 105723 105505 105383 105115 105505 105301 105115 104872 105301 105102 104872 104641 + 105102 104905 104641 104414 107999 107991 107959 107950 107991 107977 107950 107888 + 107977 107937 107888 108004 107937 108006 108004 108135 108006 108217 108135 108237 + 108217 108372 108237 108280 108372 108370 108280 108197 108370 108177 108197 107945 + 108177 107808 107945 107516 107808 107391 107516 106933 107391 107203 106933 106924 + 107203 106826 106924 106590 106826 106443 106590 106140 106443 106073 106140 105645 + 106073 105700 105645 105320 105700 105383 105320 104995 105383 105115 104995 104703 + 105115 104872 104703 104432 104872 104641 104432 104175 104641 104414 104175 103924 + 107959 107950 107959 107904 107950 107888 107904 108034 107888 108004 108034 108141 + 108004 108135 108141 108233 108135 108237 108233 108278 108237 108280 108278 108246 + 108280 108197 108246 108105 108197 107945 108105 107826 107945 107516 107826 107417 + 107516 106933 107417 107016 106933 106924 107016 106713 106924 106590 106713 106377 + 106590 106140 106377 105934 106140 105645 105934 105450 105645 105320 105450 104887 + 105320 104995 104887 104579 104995 104703 104579 104269 104703 104432 104269 103980 + 104432 104175 103980 103703 104175 103924 103703 103434 107959 107904 107980 108085 + 107904 108034 108085 108196 108034 108141 108196 108280 108141 108233 108280 108328 + 108233 108278 108328 108322 108278 108246 108322 108247 108246 108105 108247 108074 + 108105 107826 108074 107792 107826 107417 107792 107423 107417 107016 107423 107026 + 107016 106713 107026 106632 106713 106377 106632 106216 106377 105934 106216 105746 + 105934 105450 105746 105222 105450 104887 105222 104692 104887 104579 104692 104119 + 104579 104269 104119 103819 104269 103980 103819 103514 103980 103703 103514 103225 + 103703 103434 103225 102943 107980 108085 108274 108323 108085 108196 108323 108367 + 108196 108280 108367 108399 108280 108328 108399 108402 108328 108322 108402 108362 + 108322 108247 108362 108259 108247 108074 108259 108070 108074 107792 108070 107786 + 107792 107423 107786 107420 107423 107026 107420 107000 107026 106632 107000 106548 + 106632 106216 106548 106066 106216 105746 106066 105547 105746 105222 105547 104994 + 105222 104692 104994 104416 104692 104119 104416 103847 104119 103819 103847 103330 + 103819 103514 103330 103037 103514 103225 103037 102740 103225 102943 102740 102452 + 108274 108323 108527 108504 108323 108367 108504 108491 108367 108399 108491 108474 + 108399 108402 108474 108442 108402 108362 108442 108379 108362 108259 108379 108261 + 108259 108070 108261 108063 108070 107786 108063 107770 107786 107420 107770 107386 + 107420 107000 107386 106929 107000 106548 106929 106423 106548 106066 106423 105883 + 106066 105547 105883 105315 105547 104994 105315 104726 104994 104416 104726 104123 + 104416 103847 104123 103524 103847 103330 103524 102917 103330 103037 102917 102540 + 103037 102740 102540 102248 102740 102452 102248 101962 108527 108504 108582 108556 + 108504 108491 108556 108515 108491 108474 108515 108472 108474 108442 108472 108422 + 108442 108379 108422 108351 108379 108261 108351 108233 108261 108063 108233 108033 + 108063 107770 108033 107727 107770 107386 107727 107309 107386 106929 107309 106802 + 106929 106423 106802 106236 106423 105883 106236 105639 105883 105315 105639 105027 + 105315 104726 105027 104405 104726 104123 104405 103780 104123 103524 103780 103157 + 103524 102917 103157 102571 102917 102540 102571 102034 102540 102248 102034 101751 + 102248 101962 101751 101472 108582 108556 108473 108449 108556 108515 108449 108406 + 108515 108472 108406 108359 108472 108422 108359 108312 108422 108351 108312 108252 + 108351 108233 108252 108150 108233 108033 108150 107961 108033 107727 107961 107640 + 107727 107309 107640 107177 107309 106802 107177 106602 106802 106236 106602 105967 + 106236 105639 105967 105315 105639 105027 105315 104667 105027 104405 104667 104022 + 104405 103780 104022 103382 103780 103157 103382 102752 103157 102571 102752 102146 + 102571 102034 102146 101564 102034 101751 101564 101250 101751 101472 101250 100981 + 108473 108449 108201 108180 108449 108406 108180 108143 108406 108359 108143 108105 + 108359 108312 108105 108074 108312 108252 108074 108042 108252 108150 108042 107978 + 108150 107961 107978 107814 107961 107640 107814 107483 107640 107177 107483 106964 + 107177 106602 106964 106301 106602 105967 106301 105589 105967 105315 105589 104900 + 105315 104667 104900 104235 104667 104022 104235 103580 104022 103382 103580 102933 + 103382 102752 102933 102297 102752 102146 102297 101677 102146 101564 101677 101098 + 101564 101250 101098 100753 101250 100981 100753 100490 108201 108180 107776 107757 + 108180 108143 107757 107723 108143 108105 107723 107689 108105 108074 107689 107666 + 108074 108042 107666 107664 108042 107978 107664 107640 107978 107814 107640 107496 + 107814 107483 107496 107163 107483 106964 107163 106615 106964 106301 106615 105863 + 106301 105589 105863 105095 105589 104900 105095 104418 104900 104235 104418 103754 + 104235 103580 103754 103098 103580 102933 103098 102449 102933 102297 102449 101811 + 102297 101677 101811 101189 101677 101098 101189 100607 101098 100753 100607 100266 + 100753 100490 100266 100000 + + + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 + + + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 998.236 + 1000 1000 998.236 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 998.951 1000 998.236 998.951 631.659 998.236 1000 631.659 998.798 + 1000 1000 998.798 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 998.951 1000 999.918 + 998.951 631.659 999.918 782.36 631.659 998.798 782.36 999.896 998.798 1000 999.896 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 999.918 1000 1000 999.918 782.36 1000 948.54 + 782.36 999.896 948.54 1000 999.896 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 999.999 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 999.304 1000 999.999 999.304 958.573 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 999.999 1000 1000 999.999 987.647 1000 999.304 987.647 764.253 + 999.304 958.573 764.253 473.411 958.573 768.498 473.411 349.594 768.498 617.045 349.594 302.247 + 617.045 588.765 302.247 299.265 588.765 777.911 299.265 372.819 777.911 1000 372.819 1000 + 1000 993.294 1000 656.403 993.294 999.801 656.403 841.377 999.801 1000 841.377 991.604 + 1000 1000 991.604 999.999 1000 1000 999.999 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 999.999 1000 968.404 + 999.999 987.647 968.404 555.538 987.647 764.253 555.538 303.452 764.253 473.411 303.452 228.713 + 473.411 349.594 228.713 193.226 349.594 302.247 193.226 176.037 302.247 299.265 176.037 175.303 + 299.265 372.819 175.303 207.543 372.819 1000 207.543 1000 1000 656.403 1000 286.397 + 656.403 841.377 286.397 330.34 841.377 991.604 330.34 562.322 991.604 999.999 562.322 953.141 + 999.999 1000 953.141 999.992 1000 1000 999.992 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 972.743 1000 968.404 972.743 489.368 968.404 555.538 489.368 258.034 + 555.538 303.452 258.034 185.832 303.452 228.713 185.832 148.776 228.713 193.226 148.776 128.737 + 193.226 176.037 128.737 118.488 176.037 175.303 118.488 116.758 175.303 207.543 116.758 128.548 + 207.543 1000 128.548 147.871 1000 286.397 147.871 163.542 286.397 330.34 163.542 187.419 + 330.34 562.322 187.419 246.673 562.322 953.141 246.673 424.625 953.141 999.992 424.625 921.156 + 999.992 1000 921.156 999.991 1000 1000 999.991 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 972.743 973.889 545.86 + 972.743 489.368 545.86 258.11 489.368 258.034 258.11 174.522 258.034 185.832 174.522 131.712 + 185.832 148.776 131.712 107.543 148.776 128.737 107.543 93.4594 128.737 118.488 93.4594 85.851 + 118.488 116.758 85.851 83.6578 116.758 128.548 83.6578 86.2248 128.548 147.871 86.2248 93.358 + 147.871 163.542 93.358 105.548 163.542 187.419 105.548 125.252 187.419 246.673 125.252 159.356 + 246.673 424.625 159.356 224.689 424.625 921.156 224.689 413.689 921.156 999.991 413.689 943.075 + 999.991 1000 943.075 999.998 1000 1000 999.998 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 973.889 545.86 547.531 289.765 545.86 258.11 289.765 185.804 + 258.11 174.522 185.804 131.521 174.522 131.712 131.521 100.504 131.712 107.543 100.504 81.6808 + 107.543 93.4594 81.6808 70.3688 93.4594 85.851 70.3688 64.2141 85.851 83.6578 64.2141 62.2461 + 83.6578 86.2248 62.2461 63.7948 86.2248 93.358 63.7948 68.9076 93.358 105.548 68.9076 78.1856 + 105.548 125.252 78.1856 92.974 125.252 159.356 92.974 116.303 159.356 224.689 116.303 156.224 + 224.689 413.689 156.224 235.312 413.689 943.075 235.312 510.932 943.075 999.998 510.932 984.458 + 999.998 1000 984.458 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 547.531 289.765 284.401 212.963 289.765 185.804 212.963 147.212 185.804 131.521 147.212 105.655 + 131.521 100.504 105.655 79.573 100.504 81.6808 79.573 63.2475 81.6808 70.3688 63.2475 53.4215 + 70.3688 64.2141 53.4215 48.2079 64.2141 62.2461 48.2079 46.686 62.2461 63.7948 46.686 48.2056 + 63.7948 68.9076 48.2056 52.7489 68.9076 78.1856 52.7489 60.7164 78.1856 92.974 60.7164 72.9801 + 92.974 116.303 72.9801 91.3948 116.303 156.224 91.3948 120.299 156.224 235.312 120.299 171.905 + 235.312 510.932 171.905 285.564 510.932 984.458 285.564 750.509 984.458 1000 750.509 999.391 + 1000 1000 999.391 1000 1000 1000 1000 1000 284.401 212.963 212.177 174.285 + 212.963 147.212 174.285 124.605 147.212 105.655 124.605 88.2654 105.655 79.573 88.2654 64.1828 + 79.573 63.2475 64.1828 48.9421 63.2475 53.4215 48.9421 39.9823 53.4215 48.2079 39.9823 35.4826 + 48.2079 46.686 35.4826 34.3629 46.686 48.2056 34.3629 35.9921 48.2056 52.7489 35.9921 40.4001 + 52.7489 60.7164 40.4001 47.9188 60.7164 72.9801 47.9188 59.1531 72.9801 91.3948 59.1531 75.3634 + 91.3948 120.299 75.3634 99.4422 120.299 171.905 99.4422 138.703 171.905 285.564 138.703 215.829 + 285.564 750.509 215.829 452.544 750.509 999.391 452.544 966.614 999.391 1000 966.614 1000 + 1000 1000 1000 1000 212.177 174.285 184.281 154.95 174.285 124.605 154.95 111.029 + 124.605 88.2654 111.029 76.2325 88.2654 64.1828 76.2325 52.3266 64.1828 48.9421 52.3266 37.2303 + 48.9421 39.9823 37.2303 28.8067 39.9823 35.4826 28.8067 24.9795 35.4826 34.3629 24.9795 24.2119 + 34.3629 35.9921 24.2119 25.9132 35.9921 40.4001 25.9132 30.4065 40.4001 47.9188 30.4065 38.1065 + 47.9188 59.1531 38.1065 49.385 59.1531 75.3634 49.385 65.0787 75.3634 99.4422 65.0787 87.3381 + 99.4422 138.703 87.3381 121.579 138.703 215.829 121.579 183.573 215.829 452.544 183.573 331.849 + 452.544 966.614 331.849 848.451 966.614 1000 848.451 999.924 1000 1000 999.924 1000 + 184.281 154.95 177.051 149.129 154.95 111.029 149.129 105.358 111.029 76.2325 105.358 69.3058 + 76.2325 52.3266 69.3058 43.6112 52.3266 37.2303 43.6112 27.3712 37.2303 28.8067 27.3712 19.2661 + 28.8067 24.9795 19.2661 16.2984 24.9795 24.2119 16.2984 15.8399 24.2119 25.9132 15.8399 17.4077 + 25.9132 30.4065 17.4077 22.1824 30.4065 38.1065 22.1824 30.9536 38.1065 49.385 30.9536 43.5121 + 49.385 65.0787 43.5121 60.0991 65.0787 87.3381 60.0991 82.6246 87.3381 121.579 82.6246 115.881 + 121.579 183.573 115.881 172.917 183.573 331.849 172.917 298.512 331.849 848.451 298.512 755.524 + 848.451 999.924 755.524 999.433 999.924 1000 999.433 1000 177.051 149.129 190.813 159.555 + 149.129 105.358 159.555 111.115 105.358 69.3058 111.115 70.812 69.3058 43.6112 70.812 40.9556 + 43.6112 27.3712 40.9556 18.8654 27.3712 19.2661 18.8654 11.0068 19.2661 16.2984 11.0068 9.41309 + 16.2984 15.8399 9.41309 9.19694 15.8399 17.4077 9.19694 10.1135 17.4077 22.1824 10.1135 15.4159 + 22.1824 30.9536 15.4159 28.4738 30.9536 43.5121 28.4738 43.6994 43.5121 60.0991 43.6994 62.4759 + 60.0991 82.6246 62.4759 87.307 82.6246 115.881 87.307 123.352 115.881 172.917 123.352 184.161 + 172.917 298.512 184.161 319.222 298.512 755.524 319.222 790.558 755.524 999.433 790.558 999.669 + 999.433 1000 999.669 1000 + + + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 0 -0 0 0 0 0 0 + 0 0 0 -0 0 0 -0 -0 0 0 -0 4.61003e-37 + 0 0 4.61003e-37 4.36794e-12 0 0 4.36794e-12 1.50481e-36 0 0 1.50481e-36 -0 + 0 0 -0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 -0 0 -0 + -0 0 -0 -0 0 0 -0 0 0 -0 0 -0 + -0 -0 -0 8.24713e-39 -0 4.61003e-37 8.24713e-39 2.02748e-12 4.61003e-37 4.36794e-12 2.02748e-12 0.000361898 + 4.36794e-12 1.50481e-36 0.000361898 2.94829e-12 1.50481e-36 -0 2.94829e-12 1.95631e-37 -0 0 1.95631e-37 -0 + 0 0 -0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 -0 0 -0 -0 -0 -0 0 + -0 0 0 -0 0 -0 -0 0 -0 8.24713e-39 0 4.07017e-14 + 8.24713e-39 2.02748e-12 4.07017e-14 0.000215155 2.02748e-12 0.000361898 0.000215155 0.0889711 0.000361898 2.94829e-12 0.0889711 0.000246613 + 2.94829e-12 1.95631e-37 0.000246613 2.87447e-13 1.95631e-37 -0 2.87447e-13 2.10296e-40 -0 0 2.10296e-40 -0 + 0 0 -0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 -0 0 0 -0 0 0 0 0 -0 0 0 + -0 0 0 0 0 4.07017e-14 0 1.75999e-17 4.07017e-14 0.000215155 1.75999e-17 1.67598e-05 + 0.000215155 0.0889711 1.67598e-05 0.0488026 0.0889711 0.000246613 0.0488026 2.1316e-05 0.000246613 2.87447e-13 2.1316e-05 1.88442e-16 + 2.87447e-13 2.10296e-40 1.88442e-16 0 2.10296e-40 -0 0 -0 -0 0 -0 0 + 0 0 0 0 0 0 0 -0 0 0 -0 -0 + 0 0 -0 -0 0 0 -0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 1.75999e-17 0 0 1.75999e-17 1.67598e-05 0 3.66235e-08 1.67598e-05 0.0488026 3.66235e-08 0.0107591 + 0.0488026 2.1316e-05 0.0107591 5.92191e-08 2.1316e-05 1.88442e-16 5.92191e-08 0 1.88442e-16 0 0 0 + 0 -0 0 0 -0 0 0 0 0 0 0 0 + 0 -0 0 0 -0 -0 0 -0 -0 -0 -0 -0 + -0 0 -0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 -0 0 0 -0 -0 0 0 -0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 -0 + 0 0 -0 -0 0 0 -0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 -0 -0 -0 -0 -0 -0 5.31744e-38 + -0 0 5.31744e-38 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 -0 0 -0 -0 -0 + -0 -0 -0 2.33335e-26 -0 5.31744e-38 2.33335e-26 7.43372e-13 5.31744e-38 0 7.43372e-13 2.96039e-07 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 -0 -0 -0 -0 -0 -0 2.5552e-22 -0 2.33335e-26 2.5552e-22 5.41039e-09 + 2.33335e-26 7.43372e-13 5.41039e-09 0.000142694 7.43372e-13 2.96039e-07 0.000142694 0.00862766 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 -0 0 0 -0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 -0 -0 -0 1.28128e-22 + -0 2.5552e-22 1.28128e-22 1.17293e-07 2.5552e-22 5.41039e-09 1.17293e-07 0.0025442 5.41039e-09 0.000142694 0.0025442 0.0533041 + 0.000142694 0.00862766 0.0533041 0.139821 0.00862766 0.0522417 0.139821 0.189471 0.0522417 0.0932366 0.189471 0.211999 + 0.0932366 0.101711 0.211999 0.213504 0.101711 0.0499015 0.213504 0.179251 0.0499015 0 0.179251 0 + 0 0.00137828 0 0.0819149 0.00137828 4.07236e-05 0.0819149 0.0346531 4.07236e-05 1.53262e-09 0.0346531 0.00172665 + 1.53262e-09 0 0.00172665 2.27874e-07 0 0 2.27874e-07 3.77098e-19 0 -0 3.77098e-19 -0 + -0 0 -0 -0 0 0 -0 0 0 0 0 0 + 0 0 0 0 -0 1.28128e-22 1.01542e-22 9.31425e-08 1.28128e-22 1.17293e-07 9.31425e-08 0.0065553 + 1.17293e-07 0.0025442 0.0065553 0.112067 0.0025442 0.0533041 0.112067 0.211394 0.0533041 0.139821 0.211394 0.25293 + 0.139821 0.189471 0.25293 0.276336 0.189471 0.211999 0.276336 0.288853 0.211999 0.213504 0.288853 0.289408 + 0.213504 0.179251 0.289408 0.266534 0.179251 0 0.266534 0 0 0.0819149 0 0.220132 + 0.0819149 0.0346531 0.220132 0.198338 0.0346531 0.00172665 0.198338 0.109915 0.00172665 2.27874e-07 0.109915 0.00977965 + 2.27874e-07 3.77098e-19 0.00977965 1.63672e-06 3.77098e-19 -0 1.63672e-06 9.07526e-19 -0 -0 9.07526e-19 -0 + -0 0 -0 -0 0 0 -0 0 0 0 0 0 + 1.01542e-22 9.31425e-08 8.69066e-08 0.0056458 9.31425e-08 0.0065553 0.0056458 0.13416 0.0065553 0.112067 0.13416 0.235569 + 0.112067 0.211394 0.235569 0.281614 0.211394 0.25293 0.281614 0.310731 0.25293 0.276336 0.310731 0.328821 + 0.276336 0.288853 0.328821 0.338903 0.288853 0.289408 0.338903 0.340669 0.289408 0.266534 0.340669 0.329001 + 0.266534 0 0.329001 0.311507 0 0.220132 0.311507 0.29854 0.220132 0.198338 0.29854 0.280468 + 0.198338 0.109915 0.280468 0.242111 0.109915 0.00977965 0.242111 0.158065 0.00977965 1.63672e-06 0.158065 0.016664 + 1.63672e-06 9.07526e-19 0.016664 1.89366e-06 9.07526e-19 -0 1.89366e-06 5.54174e-19 -0 -0 5.54174e-19 -0 + -0 0 -0 -0 0 0 -0 0 8.69066e-08 0.0056458 0.00540592 0.11517 + 0.0056458 0.13416 0.11517 0.235526 0.13416 0.235569 0.235526 0.289999 0.235569 0.281614 0.289999 0.326007 + 0.281614 0.310731 0.326007 0.350421 0.310731 0.328821 0.350421 0.366612 0.328821 0.338903 0.366612 0.376136 + 0.338903 0.340669 0.376136 0.378998 0.340669 0.329001 0.378998 0.375653 0.329001 0.311507 0.375653 0.366735 + 0.311507 0.29854 0.366735 0.352614 0.29854 0.280468 0.352614 0.33218 0.280468 0.242111 0.33218 0.301909 + 0.242111 0.158065 0.301909 0.255441 0.158065 0.016664 0.255441 0.162369 0.016664 1.89366e-06 0.162369 0.0119273 + 1.89366e-06 5.54174e-19 0.0119273 4.57177e-07 5.54174e-19 -0 4.57177e-07 7.2417e-21 -0 -0 7.2417e-21 -0 + -0 0 -0 0 0.00540592 0.11517 0.114631 0.218376 0.11517 0.235526 0.218376 0.281634 + 0.235526 0.289999 0.281634 0.326187 0.289999 0.326007 0.326187 0.3583 0.326007 0.350421 0.3583 0.381627 + 0.350421 0.366612 0.381627 0.397663 0.366612 0.376136 0.397663 0.407217 0.376136 0.378998 0.407217 0.410417 + 0.378998 0.375653 0.410417 0.407893 0.375653 0.366735 0.407893 0.399873 0.366735 0.352614 0.399873 0.386394 + 0.352614 0.33218 0.386394 0.367202 0.33218 0.301909 0.367202 0.341136 0.301909 0.255441 0.341136 0.304474 + 0.255441 0.162369 0.304474 0.248883 0.162369 0.0119273 0.248883 0.126726 0.0119273 4.57177e-07 0.126726 0.00320496 + 4.57177e-07 7.2417e-21 0.00320496 5.72748e-09 7.2417e-21 -0 5.72748e-09 1.24835e-26 -0 0 1.24835e-26 0 + 0.114631 0.218376 0.22118 0.262955 0.218376 0.281634 0.262955 0.312075 0.281634 0.326187 0.312075 0.352495 + 0.326187 0.3583 0.352495 0.384483 0.3583 0.381627 0.384483 0.40878 0.381627 0.397663 0.40878 0.425776 + 0.397663 0.407217 0.425776 0.435768 0.407217 0.410417 0.435768 0.438837 0.410417 0.407893 0.438837 0.435773 + 0.407893 0.399873 0.435773 0.427023 0.399873 0.386394 0.427023 0.412957 0.386394 0.367202 0.412957 0.393798 + 0.367202 0.341136 0.393798 0.369137 0.341136 0.304474 0.369137 0.337075 0.304474 0.248883 0.337075 0.291997 + 0.248883 0.126726 0.291997 0.220568 0.126726 0.00320496 0.220568 0.0567747 0.00320496 5.72748e-09 0.0567747 0.000124917 + 5.72748e-09 1.24835e-26 0.000124917 2.16155e-13 1.24835e-26 0 2.16155e-13 0 0.22118 0.262955 0.26347 0.290179 + 0.262955 0.312075 0.290179 0.332811 0.312075 0.352495 0.332811 0.373047 0.352495 0.384483 0.373047 0.407268 + 0.384483 0.40878 0.407268 0.434313 0.40878 0.425776 0.434313 0.453325 0.425776 0.435768 0.453325 0.464108 + 0.435768 0.438837 0.464108 0.46695 0.438837 0.435773 0.46695 0.462838 0.435773 0.427023 0.462838 0.452371 + 0.427023 0.412957 0.452371 0.436346 0.412957 0.393798 0.436346 0.415603 0.393798 0.369137 0.415603 0.390361 + 0.369137 0.337075 0.390361 0.359524 0.337075 0.291997 0.359524 0.319579 0.291997 0.220568 0.319579 0.261091 + 0.220568 0.0567747 0.261091 0.147443 0.0567747 0.000124917 0.147443 0.00693147 0.000124917 2.16155e-13 0.00693147 6.76677e-08 + 2.16155e-13 0 6.76677e-08 0 0.26347 0.290179 0.282741 0.305528 0.290179 0.332811 0.305528 0.346661 + 0.332811 0.373047 0.346661 0.389127 0.373047 0.407268 0.389127 0.427812 0.407268 0.434313 0.427812 0.459805 + 0.434313 0.453325 0.459805 0.482179 0.453325 0.464108 0.482179 0.494006 0.464108 0.46695 0.494006 0.49654 + 0.46695 0.462838 0.49654 0.491001 0.462838 0.452371 0.491001 0.477583 0.452371 0.436346 0.477583 0.457704 + 0.436346 0.415603 0.457704 0.433444 0.415603 0.390361 0.433444 0.405835 0.390361 0.359524 0.405835 0.374226 + 0.359524 0.319579 0.374226 0.335796 0.319579 0.261091 0.335796 0.283258 0.261091 0.147443 0.283258 0.197629 + 0.147443 0.00693147 0.197629 0.0330076 0.00693147 6.76677e-08 0.0330076 1.55681e-05 6.76677e-08 0 1.55681e-05 0 + 0.282741 0.305528 0.288089 0.310429 0.305528 0.346661 0.310429 0.352823 0.346661 0.389127 0.352823 0.399267 + 0.389127 0.427812 0.399267 0.445274 0.427812 0.459805 0.445274 0.486468 0.459805 0.482179 0.486468 0.514499 + 0.482179 0.494006 0.514499 0.527012 0.494006 0.49654 0.527012 0.529094 0.49654 0.491001 0.529094 0.522149 + 0.491001 0.477583 0.522149 0.503542 0.477583 0.457704 0.503542 0.476053 0.457704 0.433444 0.476053 0.445488 + 0.433444 0.405835 0.445488 0.413996 0.405835 0.374226 0.413996 0.380366 0.374226 0.335796 0.380366 0.341572 + 0.335796 0.283258 0.341572 0.291222 0.283258 0.197629 0.291222 0.213886 0.197629 0.0330076 0.213886 0.0555027 + 0.0330076 1.55681e-05 0.0555027 0.000116215 1.55681e-05 0 0.000116215 0 0.288089 0.310429 0.278042 0.301747 + 0.310429 0.352823 0.301747 0.346568 0.352823 0.399267 0.346568 0.397 0.399267 0.445274 0.397 0.451114 + 0.445274 0.486468 0.451114 0.5161 0.486468 0.514499 0.5161 0.554399 0.514499 0.527012 0.554399 0.564585 + 0.527012 0.529094 0.564585 0.566064 0.529094 0.522149 0.566064 0.559961 0.522149 0.503542 0.559961 0.531061 + 0.503542 0.476053 0.531061 0.483159 0.476053 0.445488 0.483159 0.445085 0.445488 0.413996 0.445085 0.410039 + 0.413996 0.380366 0.410039 0.374266 0.380366 0.341572 0.374266 0.33404 0.341572 0.291222 0.33404 0.282828 + 0.291222 0.213886 0.282828 0.203636 0.213886 0.0555027 0.203636 0.0467904 0.0555027 0.000116215 0.0467904 6.77642e-05 + 0.000116215 0 6.77642e-05 0 + + + 119810 119810 119320 119382 119810 119810 119382 119432 119810 119810 119432 119465 + 119810 119810 119465 119481 119810 119810 119481 119484 119810 119810 119484 119481 + 119810 119810 119481 119476 119810 119810 119476 119473 119810 119810 119473 119470 + 119810 119810 119470 119460 119810 119810 119460 119445 119810 119810 119445 119426 + 119810 119810 119426 119406 119810 119810 119406 119389 119810 119810 119389 119375 + 119810 119810 119375 119364 119810 119810 119364 119353 119810 119810 119353 119342 + 119810 119810 119342 119331 119810 119810 119331 119320 119320 119382 118829 118968 + 119382 119432 118968 119074 119432 119465 119074 119138 119465 119481 119138 119164 + 119481 119484 119164 119164 119484 119481 119164 119152 119481 119476 119152 119139 + 119476 119473 119139 119135 119473 119470 119135 119141 119470 119460 119141 119113 + 119460 119445 119113 119092 119445 119426 119092 119039 119426 119406 119039 118998 + 119406 119389 118998 118965 119389 119375 118965 118939 119375 119364 118939 118916 + 119364 119353 118916 118895 119353 119342 118895 118874 119342 119331 118874 118852 + 119331 119320 118852 118829 118829 118968 118338 118594 118968 119074 118594 118765 + 119074 119138 118765 118848 119138 119164 118848 118872 119164 119164 118872 118857 + 119164 119152 118857 118823 119152 119139 118823 118793 119139 119135 118793 118784 + 119135 119141 118784 118802 119141 119113 118802 119540 119113 119092 119540 118721 + 119092 119039 118721 118642 119039 118998 118642 118581 118998 118965 118581 118535 + 118965 118939 118535 118498 118939 118916 118498 118468 118916 118895 118468 118438 + 118895 118874 118438 118407 118874 118852 118407 118373 118852 118829 118373 118338 + 118338 118594 117848 118352 118594 118765 118352 118535 118765 118848 118535 118615 + 118848 118872 118615 118623 118872 118857 118623 118569 118857 118823 118569 118486 + 118823 118793 118486 118425 118793 118784 118425 118406 118784 118802 118406 118428 + 118802 119540 118428 118824 119540 118721 118824 118332 118721 118642 118332 118227 + 118642 118581 118227 118150 118581 118535 118150 118093 118535 118498 118093 118053 + 118498 118468 118053 118019 118468 118438 118019 117983 118438 118407 117983 117942 + 118407 118373 117942 117896 118373 118338 117896 117848 117848 118352 118211 118281 + 118352 118535 118281 118392 118535 118615 118392 118448 118615 118623 118448 118442 + 118623 118569 118442 118329 118569 118486 118329 118100 118486 118425 118100 118018 + 118425 118406 118018 117991 118406 118428 117991 118005 118428 118824 118005 118108 + 118824 118332 118108 117901 118332 118227 117901 117786 118227 118150 117786 117699 + 118150 118093 117699 117634 118093 118053 117634 117599 118053 118019 117599 117577 + 118019 117983 117577 117535 117983 117942 117535 117482 117942 117896 117482 117421 + 117896 117848 117421 117358 118211 118281 118243 118264 118281 118392 118264 118306 + 118392 118448 118306 118336 118448 118442 118336 118335 118442 118329 118335 118318 + 158329 158100 158318 158184 158100 158018 158184 158096 158018 157991 158096 158038 + 157991 158005 158038 157986 158005 158041 157986 157911 158041 157901 157911 157790 + 157901 157786 157790 157645 157786 157699 157645 157495 157699 157634 157495 157343 + 157634 157599 157343 157180 117599 117577 117180 117150 117577 117535 117150 117097 + 117535 117482 117097 117028 117482 117421 117028 116950 117421 117358 116950 116867 + 118243 118264 118215 118223 118264 118306 118223 118241 118306 118336 118241 118258 + 118336 118335 118258 118265 118335 118318 118265 118263 158318 158184 158263 158210 + 158184 158096 158210 158150 158096 158038 158150 158077 158038 157986 158077 157980 + 157986 157911 157980 157854 157911 157790 157854 157693 157790 157645 157693 157504 + 157645 157495 157504 157293 157495 157343 157293 157057 157343 157180 157057 156791 + 117180 117150 116791 116747 117150 117097 116747 116675 117097 117028 116675 116584 + 117028 116950 116584 116483 116950 116867 116483 116376 118215 118223 118167 118170 + 118223 118241 118170 118180 118241 118258 118180 118192 118258 118265 118192 118204 + 118265 118263 118204 118212 158263 158210 158212 158238 158210 158150 158238 158219 + 158150 158077 158219 158139 158077 157980 158139 158005 157980 157854 158005 157831 + 157854 157693 157831 157622 157693 157504 157622 157385 157504 157293 157385 157114 + 157293 157057 157114 156801 157057 156791 156801 156435 116791 116747 116435 116372 + 116747 116675 116372 116271 116675 116584 116271 116150 116584 116483 116150 116020 + 116483 116376 116020 115886 118167 118170 118110 118111 118170 118180 118111 118115 + 118180 118192 118115 118126 118192 118204 118126 118148 118204 118212 118148 118169 + 158212 158238 158169 158321 158238 158219 158321 158353 158219 158139 158353 158257 + 158139 158005 158257 158068 158005 157831 158068 157837 157831 157622 157837 157578 + 157622 157385 157578 157296 157385 157114 157296 156977 157114 156801 156977 156604 + 156801 156435 156604 156136 116435 116372 116136 116037 116372 116271 116037 115885 + 116271 116150 115885 115724 116150 116020 115724 115560 116020 115886 115560 115396 + 118110 118111 118052 118050 118111 118115 118050 118046 118115 118126 118046 118048 + 118126 118148 118048 118069 118148 118169 118069 118248 158169 158321 158195 158543 + 158321 158353 158543 158621 158353 158257 158621 158479 158257 158068 158479 158159 + 158068 157837 158159 157854 157837 157578 157854 157558 157578 157296 157558 157245 + 157296 156977 157245 156886 156977 156604 156886 156494 156604 156136 156494 155997 + 116136 116037 115997 115723 116037 115885 115723 115505 115885 115724 115505 115301 + 115724 115560 115301 115102 115560 115396 115102 114905 118052 118050 117999 117991 + 118050 118046 117991 117977 118046 118048 117977 117952 118048 118069 117952 118348 + 118069 118248 118348 119197 118248 118878 119197 119776 118878 119243 119776 119984 + 119243 119164 119984 119805 119164 118478 119805 119121 118478 117854 119121 117391 + 117854 117567 117391 117744 117567 117245 117744 117045 117245 116886 117045 116453 + 116886 116494 116453 116073 116494 115997 116073 115700 115997 115723 115700 115383 + 115723 115505 115383 115115 115505 115301 115115 114872 115301 115102 114872 114641 + 115102 114905 114641 114414 117999 117991 117959 117950 117991 117977 117950 117928 + 117977 117952 117928 118766 117952 118348 118766 119743 118348 119197 119743 120262 + 119197 119776 120262 120561 119776 119984 120561 120622 119984 119805 120622 120377 + 119805 119121 120377 119688 119121 117391 119688 116933 117391 117744 116933 118616 + 117744 117045 118616 118075 117045 116453 118075 116886 116453 116073 116886 115705 + 116073 115700 115705 115320 115700 115383 115320 114995 115383 115115 114995 114703 + 115115 114872 114703 114432 114872 114641 114432 114175 114641 114414 114175 113924 + 117959 117950 117959 117938 117950 117928 117938 118969 117928 118766 118969 119986 + 118766 119743 119986 120574 119743 120262 120574 120968 120262 120561 120968 121166 + 120561 120622 121166 121160 120622 120377 121160 120905 120377 119688 120905 120340 + 119688 116933 120340 119715 116933 118616 119715 119253 118616 118075 119253 118705 + 118075 116886 118705 117846 116886 115705 117846 116580 115705 115320 116580 114990 + 115320 114995 114990 114579 114995 114703 114579 114269 114703 114432 114269 113980 + 114432 114175 113980 113703 114175 113924 113703 113434 117959 117938 118013 118871 + 117938 118969 118871 120040 118969 119986 120040 120719 119986 120574 120719 121212 + 120574 120968 121212 121537 120968 121166 121537 121695 121166 121160 121695 121666 + 121160 120905 121666 121428 120905 120340 121428 121008 120340 119715 121008 120476 + 119715 119253 120476 119878 119253 118705 119878 119181 118705 117846 119181 118326 + 117846 116580 118326 117274 116580 114990 117274 115859 114990 114579 115859 114193 + 114579 114269 114193 113819 114269 113980 113819 113514 113980 113703 113514 113225 + 113703 113434 113225 112943 118013 118871 119056 119998 118871 120040 119998 120709 + 120040 120719 120709 121286 120719 121212 121286 121729 121212 121537 121729 122039 + 121537 121695 122039 122193 121695 121666 122193 122164 121666 121428 122164 121935 + 121428 121008 121935 121525 121008 120476 121525 120970 120476 119878 120970 120300 + 119878 119181 120300 119523 119181 118326 119523 118633 118326 117274 118633 117606 + 117274 115859 117606 116399 115859 114193 116399 114722 114193 113819 114722 113350 + 113819 113514 113350 113037 113514 113225 113037 112740 113225 112943 112740 112452 + 119056 119998 120229 120637 119998 120709 120637 121196 120709 121286 121196 121717 + 121286 121729 121717 122164 121729 122039 122164 122500 122039 122193 122500 122684 + 122193 122164 122684 122672 122164 121935 122672 122437 121935 121525 122437 121994 + 121525 120970 121994 121374 120970 120300 121374 120617 120300 119523 120617 119753 + 119523 118633 119753 118801 118633 117606 118801 117757 117606 116399 117757 116585 + 116399 114722 116585 115220 114722 113350 115220 113282 113350 113037 113282 112541 + 113037 112740 112541 112248 112740 112452 112248 111962 120229 120637 120721 120997 + 120637 121196 120997 121489 121196 121717 121489 122017 121717 122164 122017 122518 + 122164 122500 122518 122932 122500 122684 122932 123187 122684 122672 123187 123212 + 122672 122437 123212 122967 122437 121994 122967 122462 121994 121374 122462 121737 + 121374 120617 121737 120856 120617 119753 120856 119879 119753 118801 119879 118842 + 118801 117757 118842 117750 117757 116585 117750 116581 116585 115220 116581 115270 + 115220 113282 115270 113613 113282 112541 113613 112076 112541 112248 112076 111751 + 112248 111962 111751 111472 120721 120997 120827 121074 120997 121489 121074 121568 + 121489 122017 121568 122155 122017 122518 122155 122772 122518 122932 122772 123340 + 122932 123187 123340 123730 123187 123212 123730 123821 123212 122967 123821 123562 + 122967 122462 123562 122965 122462 121737 122965 122077 121737 120856 122077 121011 + 120856 119879 121011 119880 119879 118842 119880 118738 118842 117750 118738 117585 + 117750 116581 117585 116396 116581 115270 116396 115112 115270 113613 115112 113625 + 113613 112076 113625 111771 112076 111751 111771 111250 111751 111472 111250 110981 + 120827 121074 120617 120866 121074 121568 120866 121391 121568 122155 121391 122065 + 122155 122772 122065 122867 122772 123340 122867 123722 123340 123730 123722 124361 + 123730 123821 124361 124544 123821 123562 124544 124272 123562 122965 124272 123557 + 122965 122077 123557 122398 122077 121011 122398 121030 121011 119880 121030 119697 + 119880 118738 119697 118447 118738 117585 118447 117238 117585 116396 117238 116025 + 116396 115112 116025 114750 115112 113625 114750 113308 113625 111771 113308 111454 + 111771 111250 111454 110753 111250 110981 110753 110490 120617 120866 120077 120336 + 120866 121391 120336 120883 121391 122065 120883 121612 122065 122867 121612 122576 + 122867 123722 122576 124091 123722 124361 124091 125211 124361 124544 125211 125414 + 124544 124272 125414 125133 124272 123557 125133 124373 123557 122398 124373 122710 + 122398 121030 122710 120698 121030 119697 120698 119207 119697 118447 119207 117897 + 118447 117238 117897 116661 117238 116025 116661 115439 116025 114750 115439 114166 + 114750 113308 114166 112723 113308 111454 112723 110905 111454 110753 110905 110266 + 110753 110490 110266 110000 + + + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 + + + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 5.30355e-31 0 0 5.30355e-31 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 5.30402e-32 0 5.30355e-31 5.30402e-32 3.01563e-07 + 5.30355e-31 0 3.01563e-07 1.63086e-31 0 0 1.63086e-31 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 4.34635e-37 + 0 5.30402e-32 4.34635e-37 6.33743e-08 5.30402e-32 3.01563e-07 6.33743e-08 4.23874 3.01563e-07 1.63086e-31 4.23874 9.5433e-08 + 1.63086e-31 0 9.5433e-08 1.51368e-34 0 0 1.51368e-34 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 4.34635e-37 0 0 4.34635e-37 6.33743e-08 0 2.99581e-11 + 6.33743e-08 4.23874 2.99581e-11 0.717666 4.23874 9.5433e-08 0.717666 6.16351e-11 9.5433e-08 1.51368e-34 6.16351e-11 3.78351e-44 + 1.51368e-34 0 3.78351e-44 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 2.99581e-11 0 3.12603e-19 2.99581e-11 0.717666 3.12603e-19 0.00787385 + 0.717666 6.16351e-11 0.00787385 1.3216e-18 6.16351e-11 3.78351e-44 1.3216e-18 0 3.78351e-44 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 2.61465e-33 0 0 2.61465e-33 1.65104e-16 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 1.00786e-21 + 0 2.61465e-33 1.00786e-21 1.84882e-08 2.61465e-33 1.65104e-16 1.84882e-08 0.00406539 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 1.02691e-17 0 1.00786e-21 1.02691e-17 0.000104638 1.00786e-21 1.84882e-08 0.000104638 0.93249 + 1.84882e-08 0.00406539 0.93249 15.9121 0.00406539 0.878426 15.9121 38.2847 0.878426 4.86466 38.2847 52.7958 + 4.86466 6.2807 52.7958 53.8715 6.2807 0.766717 53.8715 32.6458 0.766717 0 32.6458 0 + 0 1.66479e-05 0 3.32314 1.66479e-05 4.29776e-10 3.32314 0.259218 4.29776e-10 2.29097e-23 0.259218 3.27243e-05 + 2.29097e-23 0 3.27243e-05 7.53004e-17 0 0 7.53004e-17 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 5.1423e-18 0 1.02691e-17 5.1423e-18 0.00178546 + 1.02691e-17 0.000104638 0.00178546 8.34459 0.000104638 0.93249 8.34459 52.3671 0.93249 15.9121 52.3671 87.09 + 15.9121 38.2847 87.09 111.658 38.2847 52.7958 111.658 126.358 52.7958 53.8715 126.358 127.035 + 53.8715 32.6458 127.035 100.913 32.6458 0 100.913 0 0 3.32314 0 58.7713 + 3.32314 0.259218 58.7713 43.6467 0.259218 3.27243e-05 43.6467 7.88424 3.27243e-05 7.53004e-17 7.88424 0.00591678 + 7.53004e-17 0 0.00591678 2.79022e-14 0 0 2.79022e-14 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 5.1423e-18 4.17707e-18 0.00114128 5.1423e-18 0.00178546 0.00114128 14.1097 0.00178546 8.34459 14.1097 71.2401 + 8.34459 52.3671 71.2401 117.721 52.3671 87.09 117.721 154.752 87.09 111.658 154.752 180.888 + 111.658 126.358 180.888 196.52 126.358 127.035 196.52 199.336 127.035 100.913 199.336 181.161 + 100.913 0 181.161 155.823 0 58.7713 155.823 138.501 58.7713 43.6467 138.501 116.388 + 43.6467 7.88424 116.388 76.9816 7.88424 0.00591678 76.9816 22.7095 0.00591678 2.79022e-14 22.7095 0.0291487 + 2.79022e-14 0 0.0291487 4.32133e-14 0 0 4.32133e-14 0 0 0 0 0 + 0 0 0 0 0 0 0 0 4.17707e-18 0.00114128 0.00100205 9.03882 + 0.00114128 14.1097 9.03882 71.2032 14.1097 71.2401 71.2032 127.76 71.2401 117.721 127.76 176.663 + 117.721 154.752 176.663 215.321 154.752 180.888 215.321 243.474 180.888 196.52 243.474 260.978 + 196.52 199.336 260.978 266.377 199.336 181.161 266.377 260.074 181.161 155.823 260.074 243.695 + 155.823 138.501 243.695 219.016 138.501 116.388 219.016 186.01 116.388 76.9816 186.01 142.884 + 76.9816 22.7095 142.884 89.5474 22.7095 0.0291487 89.5474 24.5439 0.0291487 4.32133e-14 24.5439 0.0107193 + 4.32133e-14 0 0.0107193 6.08087e-16 0 0 6.08087e-16 0 0 0 0 0 + 0 0 0 0 0.00100205 9.03882 8.91571 57.4469 9.03882 71.2032 57.4469 117.745 + 71.2032 127.76 117.745 176.931 127.76 176.663 176.931 228.769 176.663 215.321 228.769 271.391 + 215.321 243.474 271.391 303.148 243.474 260.978 303.148 323.024 260.978 266.377 323.024 329.84 + 266.377 260.074 329.84 324.456 260.074 243.695 324.456 307.682 243.695 219.016 307.682 280.622 + 219.016 186.01 280.622 244.537 186.01 142.884 244.537 200.086 142.884 89.5474 200.086 146.276 + 89.5474 24.5439 146.276 83.2185 24.5439 0.0107193 83.2185 11.9505 0.0107193 6.08087e-16 11.9505 0.000209088 + 6.08087e-16 0 0.000209088 1.19565e-21 0 0 1.19565e-21 0 0 0 0 0 + 8.91571 57.4469 59.5706 97.1545 57.4469 117.745 97.1545 156.61 117.745 176.931 156.61 218.815 + 176.931 228.769 218.815 276.9 228.769 271.391 276.9 326.342 271.391 303.148 326.342 363.674 + 303.148 323.024 363.674 386.675 323.024 329.84 386.675 393.896 329.84 324.456 393.896 386.686 + 324.456 307.682 386.686 366.502 307.682 280.622 366.502 335.308 280.622 244.537 335.308 295.311 + 244.537 200.086 295.311 248.046 200.086 146.276 248.046 193.628 146.276 83.2185 193.628 130.226 + 83.2185 11.9505 130.226 59.1036 11.9505 0.000209088 59.1036 1.12428 0.000209088 1.19565e-21 1.12428 1.24035e-08 + 1.19565e-21 0 1.24035e-08 6.44058e-35 0 0 6.44058e-35 0 59.5706 97.1545 97.6902 127.981 + 97.1545 156.61 127.981 186.983 156.61 218.815 186.983 255.224 218.815 276.9 255.224 323.131 + 276.9 326.342 323.131 383.278 326.342 363.674 383.278 428.975 363.674 386.675 428.975 456.137 + 386.675 393.896 456.137 463.444 393.896 386.686 463.444 452.889 386.686 366.502 452.889 426.614 + 366.502 335.308 426.614 388.028 335.308 295.311 388.028 341.057 295.311 248.046 341.057 288.438 + 248.046 193.628 288.438 230.901 193.628 130.226 230.901 167.232 130.226 59.1036 167.232 95.2317 + 59.1036 1.12428 95.2317 18.564 1.12428 1.24035e-08 18.564 0.00211033 1.24035e-08 6.44058e-35 0.00211033 1.97177e-18 + 6.44058e-35 0 1.97177e-18 0 97.6902 127.981 119.042 147.684 127.981 186.983 147.684 209.072 + 186.983 255.224 209.072 285.995 255.224 323.131 285.995 368.297 323.131 383.278 368.297 445.189 + 383.278 428.975 445.189 503.657 428.975 456.137 503.657 536.103 456.137 463.444 536.103 543.191 + 463.444 452.889 543.191 527.761 452.889 426.614 527.761 491.336 426.614 388.028 491.336 439.896 + 388.028 341.057 439.896 381.255 341.057 288.438 381.255 320.104 288.438 230.901 320.104 257.411 + 230.901 167.232 257.411 191.62 167.232 95.2317 191.62 119.65 95.2317 18.564 119.65 43.2017 + 18.564 0.00211033 43.2017 0.224246 0.00211033 1.97177e-18 0.224246 2.40115e-11 1.97177e-18 0 2.40115e-11 0 + 119.042 147.684 125.429 154.336 147.684 209.072 154.336 219.371 209.072 285.995 219.371 306.436 + 285.995 368.297 306.436 409.28 368.297 445.189 409.28 515.303 445.189 503.657 515.303 594.799 + 503.657 536.103 594.799 632.151 536.103 543.191 632.151 638.479 543.191 527.761 638.479 617.499 + 527.761 491.336 617.499 563.029 491.336 439.896 563.029 487.269 439.896 381.255 487.269 409.795 + 381.255 320.104 409.795 337.558 320.104 257.411 337.558 268.98 257.411 191.62 268.98 200.786 + 191.62 119.65 200.786 129.266 119.65 43.2017 129.266 54.1466 43.2017 0.224246 54.1466 1.05124 + 0.224246 2.40115e-11 1.05124 9.98789e-09 2.40115e-11 0 9.98789e-09 0 125.429 154.336 113.596 142.672 + 154.336 219.371 142.672 208.92 219.371 306.436 208.92 301.795 306.436 409.28 301.795 423.515 + 409.28 515.303 423.515 599.514 515.303 594.799 599.514 717.807 594.799 632.151 717.807 750.989 + 632.151 638.479 750.989 755.865 638.479 617.499 755.865 735.838 617.499 563.029 735.838 644.483 + 563.029 487.269 644.483 506.306 487.269 409.795 506.306 408.823 409.795 337.558 408.823 329.032 + 337.558 268.98 329.032 257.485 268.98 200.786 257.485 188.884 200.786 129.266 188.884 119.144 + 129.266 54.1466 119.144 47.0651 54.1466 1.05124 47.0651 0.633304 1.05124 9.98789e-09 0.633304 1.98014e-09 + 9.98789e-09 0 1.98014e-09 0 + + + + + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 + + + + + 0 0 0 0.05 0 0 0 0.05 0 0.05 0.05 0 + 0.05 0 0 0.1 0 0 0.05 0.05 0 0.1 0.05 0 + 0.1 0 0 0.15 0 0 0.1 0.05 0 0.15 0.05 0 + 0.15 0 0 0.2 0 0 0.15 0.05 0 0.2 0.05 0 + 0.2 0 0 0.25 0 0 0.2 0.05 0 0.25 0.05 0 + 0.25 0 0 0.3 0 0 0.25 0.05 0 0.3 0.05 0 + 0.3 0 0 0.35 0 0 0.3 0.05 0 0.35 0.05 0 + 0.35 0 0 0.4 0 0 0.35 0.05 0 0.4 0.05 0 + 0.4 0 0 0.45 0 0 0.4 0.05 0 0.45 0.05 0 + 0.45 0 0 0.5 0 0 0.45 0.05 0 0.5 0.05 0 + 0.5 0 0 0.55 0 0 0.5 0.05 0 0.55 0.05 0 + 0.55 0 0 0.6 0 0 0.55 0.05 0 0.6 0.05 0 + 0.6 0 0 0.65 0 0 0.6 0.05 0 0.65 0.05 0 + 0.65 0 0 0.7 0 0 0.65 0.05 0 0.7 0.05 0 + 0.7 0 0 0.75 0 0 0.7 0.05 0 0.75 0.05 0 + 0.75 0 0 0.8 0 0 0.75 0.05 0 0.8 0.05 0 + 0.8 0 0 0.85 0 0 0.8 0.05 0 0.85 0.05 0 + 0.85 0 0 0.9 0 0 0.85 0.05 0 0.9 0.05 0 + 0.9 0 0 0.95 0 0 0.9 0.05 0 0.95 0.05 0 + 0.95 0 0 1 0 0 0.95 0.05 0 1 0.05 0 + 0 0.05 0 0.05 0.05 0 0 0.1 0 0.05 0.1 0 + 0.05 0.05 0 0.1 0.05 0 0.05 0.1 0 0.1 0.1 0 + 0.1 0.05 0 0.15 0.05 0 0.1 0.1 0 0.15 0.1 0 + 0.15 0.05 0 0.2 0.05 0 0.15 0.1 0 0.2 0.1 0 + 0.2 0.05 0 0.25 0.05 0 0.2 0.1 0 0.25 0.1 0 + 0.25 0.05 0 0.3 0.05 0 0.25 0.1 0 0.3 0.1 0 + 0.3 0.05 0 0.35 0.05 0 0.3 0.1 0 0.35 0.1 0 + 0.35 0.05 0 0.4 0.05 0 0.35 0.1 0 0.4 0.1 0 + 0.4 0.05 0 0.45 0.05 0 0.4 0.1 0 0.45 0.1 0 + 0.45 0.05 0 0.5 0.05 0 0.45 0.1 0 0.5 0.1 0 + 0.5 0.05 0 0.55 0.05 0 0.5 0.1 0 0.55 0.1 0 + 0.55 0.05 0 0.6 0.05 0 0.55 0.1 0 0.6 0.1 0 + 0.6 0.05 0 0.65 0.05 0 0.6 0.1 0 0.65 0.1 0 + 0.65 0.05 0 0.7 0.05 0 0.65 0.1 0 0.7 0.1 0 + 0.7 0.05 0 0.75 0.05 0 0.7 0.1 0 0.75 0.1 0 + 0.75 0.05 0 0.8 0.05 0 0.75 0.1 0 0.8 0.1 0 + 0.8 0.05 0 0.85 0.05 0 0.8 0.1 0 0.85 0.1 0 + 0.85 0.05 0 0.9 0.05 0 0.85 0.1 0 0.9 0.1 0 + 0.9 0.05 0 0.95 0.05 0 0.9 0.1 0 0.95 0.1 0 + 0.95 0.05 0 1 0.05 0 0.95 0.1 0 1 0.1 0 + 0 0.1 0 0.05 0.1 0 0 0.15 0 0.05 0.15 0 + 0.05 0.1 0 0.1 0.1 0 0.05 0.15 0 0.1 0.15 0 + 0.1 0.1 0 0.15 0.1 0 0.1 0.15 0 0.15 0.15 0 + 0.15 0.1 0 0.2 0.1 0 0.15 0.15 0 0.2 0.15 0 + 0.2 0.1 0 0.25 0.1 0 0.2 0.15 0 0.25 0.15 0 + 0.25 0.1 0 0.3 0.1 0 0.25 0.15 0 0.3 0.15 0 + 0.3 0.1 0 0.35 0.1 0 0.3 0.15 0 0.35 0.15 0 + 0.35 0.1 0 0.4 0.1 0 0.35 0.15 0 0.4 0.15 0 + 0.4 0.1 0 0.45 0.1 0 0.4 0.15 0 0.45 0.15 0 + 0.45 0.1 0 0.5 0.1 0 0.45 0.15 0 0.5 0.15 0 + 0.5 0.1 0 0.55 0.1 0 0.5 0.15 0 0.55 0.15 0 + 0.55 0.1 0 0.6 0.1 0 0.55 0.15 0 0.6 0.15 0 + 0.6 0.1 0 0.65 0.1 0 0.6 0.15 0 0.65 0.15 0 + 0.65 0.1 0 0.7 0.1 0 0.65 0.15 0 0.7 0.15 0 + 0.7 0.1 0 0.75 0.1 0 0.7 0.15 0 0.75 0.15 0 + 0.75 0.1 0 0.8 0.1 0 0.75 0.15 0 0.8 0.15 0 + 0.8 0.1 0 0.85 0.1 0 0.8 0.15 0 0.85 0.15 0 + 0.85 0.1 0 0.9 0.1 0 0.85 0.15 0 0.9 0.15 0 + 0.9 0.1 0 0.95 0.1 0 0.9 0.15 0 0.95 0.15 0 + 0.95 0.1 0 1 0.1 0 0.95 0.15 0 1 0.15 0 + 0 0.15 0 0.05 0.15 0 0 0.2 0 0.05 0.2 0 + 0.05 0.15 0 0.1 0.15 0 0.05 0.2 0 0.1 0.2 0 + 0.1 0.15 0 0.15 0.15 0 0.1 0.2 0 0.15 0.2 0 + 0.15 0.15 0 0.2 0.15 0 0.15 0.2 0 0.2 0.2 0 + 0.2 0.15 0 0.25 0.15 0 0.2 0.2 0 0.25 0.2 0 + 0.25 0.15 0 0.3 0.15 0 0.25 0.2 0 0.3 0.2 0 + 0.3 0.15 0 0.35 0.15 0 0.3 0.2 0 0.35 0.2 0 + 0.35 0.15 0 0.4 0.15 0 0.35 0.2 0 0.4 0.2 0 + 0.4 0.15 0 0.45 0.15 0 0.4 0.2 0 0.45 0.2 0 + 0.45 0.15 0 0.5 0.15 0 0.45 0.2 0 0.5 0.2 0 + 0.5 0.15 0 0.55 0.15 0 0.5 0.2 0 0.55 0.2 0 + 0.55 0.15 0 0.6 0.15 0 0.55 0.2 0 0.6 0.2 0 + 0.6 0.15 0 0.65 0.15 0 0.6 0.2 0 0.65 0.2 0 + 0.65 0.15 0 0.7 0.15 0 0.65 0.2 0 0.7 0.2 0 + 0.7 0.15 0 0.75 0.15 0 0.7 0.2 0 0.75 0.2 0 + 0.75 0.15 0 0.8 0.15 0 0.75 0.2 0 0.8 0.2 0 + 0.8 0.15 0 0.85 0.15 0 0.8 0.2 0 0.85 0.2 0 + 0.85 0.15 0 0.9 0.15 0 0.85 0.2 0 0.9 0.2 0 + 0.9 0.15 0 0.95 0.15 0 0.9 0.2 0 0.95 0.2 0 + 0.95 0.15 0 1 0.15 0 0.95 0.2 0 1 0.2 0 + 0 0.2 0 0.05 0.2 0 0 0.25 0 0.05 0.25 0 + 0.05 0.2 0 0.1 0.2 0 0.05 0.25 0 0.1 0.25 0 + 0.1 0.2 0 0.15 0.2 0 0.1 0.25 0 0.15 0.25 0 + 0.15 0.2 0 0.2 0.2 0 0.15 0.25 0 0.2 0.25 0 + 0.2 0.2 0 0.25 0.2 0 0.2 0.25 0 0.25 0.25 0 + 0.25 0.2 0 0.3 0.2 0 0.25 0.25 0 0.3 0.25 0 + 0.3 0.2 0 0.35 0.2 0 0.3 0.25 0 0.35 0.25 0 + 0.35 0.2 0 0.4 0.2 0 0.35 0.25 0 0.4 0.25 0 + 0.4 0.2 0 0.45 0.2 0 0.4 0.25 0 0.45 0.25 0 + 0.45 0.2 0 0.5 0.2 0 0.45 0.25 0 0.5 0.25 0 + 0.5 0.2 0 0.55 0.2 0 0.5 0.25 0 0.55 0.25 0 + 0.55 0.2 0 0.6 0.2 0 0.55 0.25 0 0.6 0.25 0 + 0.6 0.2 0 0.65 0.2 0 0.6 0.25 0 0.65 0.25 0 + 0.65 0.2 0 0.7 0.2 0 0.65 0.25 0 0.7 0.25 0 + 0.7 0.2 0 0.75 0.2 0 0.7 0.25 0 0.75 0.25 0 + 0.75 0.2 0 0.8 0.2 0 0.75 0.25 0 0.8 0.25 0 + 0.8 0.2 0 0.85 0.2 0 0.8 0.25 0 0.85 0.25 0 + 0.85 0.2 0 0.9 0.2 0 0.85 0.25 0 0.9 0.25 0 + 0.9 0.2 0 0.95 0.2 0 0.9 0.25 0 0.95 0.25 0 + 0.95 0.2 0 1 0.2 0 0.95 0.25 0 1 0.25 0 + 0 0.25 0 0.05 0.25 0 0 0.3 0 0.05 0.3 0 + 0.05 0.25 0 0.1 0.25 0 0.05 0.3 0 0.1 0.3 0 + 0.1 0.25 0 0.15 0.25 0 0.1 0.3 0 0.15 0.3 0 + 0.15 0.25 0 0.2 0.25 0 0.15 0.3 0 0.2 0.3 0 + 0.2 0.25 0 0.25 0.25 0 0.2 0.3 0 0.25 0.3 0 + 0.25 0.25 0 0.3 0.25 0 0.25 0.3 0 0.3 0.3 0 + 0.3 0.25 0 0.35 0.25 0 0.3 0.3 0 0.35 0.3 0 + 0.35 0.25 0 0.4 0.25 0 0.35 0.3 0 0.4 0.3 0 + 0.4 0.25 0 0.45 0.25 0 0.4 0.3 0 0.45 0.3 0 + 0.45 0.25 0 0.5 0.25 0 0.45 0.3 0 0.5 0.3 0 + 0.5 0.25 0 0.55 0.25 0 0.5 0.3 0 0.55 0.3 0 + 0.55 0.25 0 0.6 0.25 0 0.55 0.3 0 0.6 0.3 0 + 0.6 0.25 0 0.65 0.25 0 0.6 0.3 0 0.65 0.3 0 + 0.65 0.25 0 0.7 0.25 0 0.65 0.3 0 0.7 0.3 0 + 0.7 0.25 0 0.75 0.25 0 0.7 0.3 0 0.75 0.3 0 + 0.75 0.25 0 0.8 0.25 0 0.75 0.3 0 0.8 0.3 0 + 0.8 0.25 0 0.85 0.25 0 0.8 0.3 0 0.85 0.3 0 + 0.85 0.25 0 0.9 0.25 0 0.85 0.3 0 0.9 0.3 0 + 0.9 0.25 0 0.95 0.25 0 0.9 0.3 0 0.95 0.3 0 + 0.95 0.25 0 1 0.25 0 0.95 0.3 0 1 0.3 0 + 0 0.3 0 0.05 0.3 0 0 0.35 0 0.05 0.35 0 + 0.05 0.3 0 0.1 0.3 0 0.05 0.35 0 0.1 0.35 0 + 0.1 0.3 0 0.15 0.3 0 0.1 0.35 0 0.15 0.35 0 + 0.15 0.3 0 0.2 0.3 0 0.15 0.35 0 0.2 0.35 0 + 0.2 0.3 0 0.25 0.3 0 0.2 0.35 0 0.25 0.35 0 + 0.25 0.3 0 0.3 0.3 0 0.25 0.35 0 0.3 0.35 0 + 0.3 0.3 0 0.35 0.3 0 0.3 0.35 0 0.35 0.35 0 + 0.35 0.3 0 0.4 0.3 0 0.35 0.35 0 0.4 0.35 0 + 0.4 0.3 0 0.45 0.3 0 0.4 0.35 0 0.45 0.35 0 + 0.45 0.3 0 0.5 0.3 0 0.45 0.35 0 0.5 0.35 0 + 0.5 0.3 0 0.55 0.3 0 0.5 0.35 0 0.55 0.35 0 + 0.55 0.3 0 0.6 0.3 0 0.55 0.35 0 0.6 0.35 0 + 0.6 0.3 0 0.65 0.3 0 0.6 0.35 0 0.65 0.35 0 + 0.65 0.3 0 0.7 0.3 0 0.65 0.35 0 0.7 0.35 0 + 0.7 0.3 0 0.75 0.3 0 0.7 0.35 0 0.75 0.35 0 + 0.75 0.3 0 0.8 0.3 0 0.75 0.35 0 0.8 0.35 0 + 0.8 0.3 0 0.85 0.3 0 0.8 0.35 0 0.85 0.35 0 + 0.85 0.3 0 0.9 0.3 0 0.85 0.35 0 0.9 0.35 0 + 0.9 0.3 0 0.95 0.3 0 0.9 0.35 0 0.95 0.35 0 + 0.95 0.3 0 1 0.3 0 0.95 0.35 0 1 0.35 0 + 0 0.35 0 0.05 0.35 0 0 0.4 0 0.05 0.4 0 + 0.05 0.35 0 0.1 0.35 0 0.05 0.4 0 0.1 0.4 0 + 0.1 0.35 0 0.15 0.35 0 0.1 0.4 0 0.15 0.4 0 + 0.15 0.35 0 0.2 0.35 0 0.15 0.4 0 0.2 0.4 0 + 0.2 0.35 0 0.25 0.35 0 0.2 0.4 0 0.25 0.4 0 + 0.25 0.35 0 0.3 0.35 0 0.25 0.4 0 0.3 0.4 0 + 0.3 0.35 0 0.35 0.35 0 0.3 0.4 0 0.35 0.4 0 + 0.35 0.35 0 0.4 0.35 0 0.35 0.4 0 0.4 0.4 0 + 0.4 0.35 0 0.45 0.35 0 0.4 0.4 0 0.45 0.4 0 + 0.45 0.35 0 0.5 0.35 0 0.45 0.4 0 0.5 0.4 0 + 0.5 0.35 0 0.55 0.35 0 0.5 0.4 0 0.55 0.4 0 + 0.55 0.35 0 0.6 0.35 0 0.55 0.4 0 0.6 0.4 0 + 0.6 0.35 0 0.65 0.35 0 0.6 0.4 0 0.65 0.4 0 + 0.65 0.35 0 0.7 0.35 0 0.65 0.4 0 0.7 0.4 0 + 0.7 0.35 0 0.75 0.35 0 0.7 0.4 0 0.75 0.4 0 + 0.75 0.35 0 0.8 0.35 0 0.75 0.4 0 0.8 0.4 0 + 0.8 0.35 0 0.85 0.35 0 0.8 0.4 0 0.85 0.4 0 + 0.85 0.35 0 0.9 0.35 0 0.85 0.4 0 0.9 0.4 0 + 0.9 0.35 0 0.95 0.35 0 0.9 0.4 0 0.95 0.4 0 + 0.95 0.35 0 1 0.35 0 0.95 0.4 0 1 0.4 0 + 0 0.4 0 0.05 0.4 0 0 0.45 0 0.05 0.45 0 + 0.05 0.4 0 0.1 0.4 0 0.05 0.45 0 0.1 0.45 0 + 0.1 0.4 0 0.15 0.4 0 0.1 0.45 0 0.15 0.45 0 + 0.15 0.4 0 0.2 0.4 0 0.15 0.45 0 0.2 0.45 0 + 0.2 0.4 0 0.25 0.4 0 0.2 0.45 0 0.25 0.45 0 + 0.25 0.4 0 0.3 0.4 0 0.25 0.45 0 0.3 0.45 0 + 0.3 0.4 0 0.35 0.4 0 0.3 0.45 0 0.35 0.45 0 + 0.35 0.4 0 0.4 0.4 0 0.35 0.45 0 0.4 0.45 0 + 0.4 0.4 0 0.45 0.4 0 0.4 0.45 0 0.45 0.45 0 + 0.45 0.4 0 0.5 0.4 0 0.45 0.45 0 0.5 0.45 0 + 0.5 0.4 0 0.55 0.4 0 0.5 0.45 0 0.55 0.45 0 + 0.55 0.4 0 0.6 0.4 0 0.55 0.45 0 0.6 0.45 0 + 0.6 0.4 0 0.65 0.4 0 0.6 0.45 0 0.65 0.45 0 + 0.65 0.4 0 0.7 0.4 0 0.65 0.45 0 0.7 0.45 0 + 0.7 0.4 0 0.75 0.4 0 0.7 0.45 0 0.75 0.45 0 + 0.75 0.4 0 0.8 0.4 0 0.75 0.45 0 0.8 0.45 0 + 0.8 0.4 0 0.85 0.4 0 0.8 0.45 0 0.85 0.45 0 + 0.85 0.4 0 0.9 0.4 0 0.85 0.45 0 0.9 0.45 0 + 0.9 0.4 0 0.95 0.4 0 0.9 0.45 0 0.95 0.45 0 + 0.95 0.4 0 1 0.4 0 0.95 0.45 0 1 0.45 0 + 0 0.45 0 0.05 0.45 0 0 0.5 0 0.05 0.5 0 + 0.05 0.45 0 0.1 0.45 0 0.05 0.5 0 0.1 0.5 0 + 0.1 0.45 0 0.15 0.45 0 0.1 0.5 0 0.15 0.5 0 + 0.15 0.45 0 0.2 0.45 0 0.15 0.5 0 0.2 0.5 0 + 0.2 0.45 0 0.25 0.45 0 0.2 0.5 0 0.25 0.5 0 + 0.25 0.45 0 0.3 0.45 0 0.25 0.5 0 0.3 0.5 0 + 0.3 0.45 0 0.35 0.45 0 0.3 0.5 0 0.35 0.5 0 + 0.35 0.45 0 0.4 0.45 0 0.35 0.5 0 0.4 0.5 0 + 0.4 0.45 0 0.45 0.45 0 0.4 0.5 0 0.45 0.5 0 + 0.45 0.45 0 0.5 0.45 0 0.45 0.5 0 0.5 0.5 0 + 0.5 0.45 0 0.55 0.45 0 0.5 0.5 0 0.55 0.5 0 + 0.55 0.45 0 0.6 0.45 0 0.55 0.5 0 0.6 0.5 0 + 0.6 0.45 0 0.65 0.45 0 0.6 0.5 0 0.65 0.5 0 + 0.65 0.45 0 0.7 0.45 0 0.65 0.5 0 0.7 0.5 0 + 0.7 0.45 0 0.75 0.45 0 0.7 0.5 0 0.75 0.5 0 + 0.75 0.45 0 0.8 0.45 0 0.75 0.5 0 0.8 0.5 0 + 0.8 0.45 0 0.85 0.45 0 0.8 0.5 0 0.85 0.5 0 + 0.85 0.45 0 0.9 0.45 0 0.85 0.5 0 0.9 0.5 0 + 0.9 0.45 0 0.95 0.45 0 0.9 0.5 0 0.95 0.5 0 + 0.95 0.45 0 1 0.45 0 0.95 0.5 0 1 0.5 0 + 0 0.5 0 0.05 0.5 0 0 0.55 0 0.05 0.55 0 + 0.05 0.5 0 0.1 0.5 0 0.05 0.55 0 0.1 0.55 0 + 0.1 0.5 0 0.15 0.5 0 0.1 0.55 0 0.15 0.55 0 + 0.15 0.5 0 0.2 0.5 0 0.15 0.55 0 0.2 0.55 0 + 0.2 0.5 0 0.25 0.5 0 0.2 0.55 0 0.25 0.55 0 + 0.25 0.5 0 0.3 0.5 0 0.25 0.55 0 0.3 0.55 0 + 0.3 0.5 0 0.35 0.5 0 0.3 0.55 0 0.35 0.55 0 + 0.35 0.5 0 0.4 0.5 0 0.35 0.55 0 0.4 0.55 0 + 0.4 0.5 0 0.45 0.5 0 0.4 0.55 0 0.45 0.55 0 + 0.45 0.5 0 0.5 0.5 0 0.45 0.55 0 0.5 0.55 0 + 0.5 0.5 0 0.55 0.5 0 0.5 0.55 0 0.55 0.55 0 + 0.55 0.5 0 0.6 0.5 0 0.55 0.55 0 0.6 0.55 0 + 0.6 0.5 0 0.65 0.5 0 0.6 0.55 0 0.65 0.55 0 + 0.65 0.5 0 0.7 0.5 0 0.65 0.55 0 0.7 0.55 0 + 0.7 0.5 0 0.75 0.5 0 0.7 0.55 0 0.75 0.55 0 + 0.75 0.5 0 0.8 0.5 0 0.75 0.55 0 0.8 0.55 0 + 0.8 0.5 0 0.85 0.5 0 0.8 0.55 0 0.85 0.55 0 + 0.85 0.5 0 0.9 0.5 0 0.85 0.55 0 0.9 0.55 0 + 0.9 0.5 0 0.95 0.5 0 0.9 0.55 0 0.95 0.55 0 + 0.95 0.5 0 1 0.5 0 0.95 0.55 0 1 0.55 0 + 0 0.55 0 0.05 0.55 0 0 0.6 0 0.05 0.6 0 + 0.05 0.55 0 0.1 0.55 0 0.05 0.6 0 0.1 0.6 0 + 0.1 0.55 0 0.15 0.55 0 0.1 0.6 0 0.15 0.6 0 + 0.15 0.55 0 0.2 0.55 0 0.15 0.6 0 0.2 0.6 0 + 0.2 0.55 0 0.25 0.55 0 0.2 0.6 0 0.25 0.6 0 + 0.25 0.55 0 0.3 0.55 0 0.25 0.6 0 0.3 0.6 0 + 0.3 0.55 0 0.35 0.55 0 0.3 0.6 0 0.35 0.6 0 + 0.35 0.55 0 0.4 0.55 0 0.35 0.6 0 0.4 0.6 0 + 0.4 0.55 0 0.45 0.55 0 0.4 0.6 0 0.45 0.6 0 + 0.45 0.55 0 0.5 0.55 0 0.45 0.6 0 0.5 0.6 0 + 0.5 0.55 0 0.55 0.55 0 0.5 0.6 0 0.55 0.6 0 + 0.55 0.55 0 0.6 0.55 0 0.55 0.6 0 0.6 0.6 0 + 0.6 0.55 0 0.65 0.55 0 0.6 0.6 0 0.65 0.6 0 + 0.65 0.55 0 0.7 0.55 0 0.65 0.6 0 0.7 0.6 0 + 0.7 0.55 0 0.75 0.55 0 0.7 0.6 0 0.75 0.6 0 + 0.75 0.55 0 0.8 0.55 0 0.75 0.6 0 0.8 0.6 0 + 0.8 0.55 0 0.85 0.55 0 0.8 0.6 0 0.85 0.6 0 + 0.85 0.55 0 0.9 0.55 0 0.85 0.6 0 0.9 0.6 0 + 0.9 0.55 0 0.95 0.55 0 0.9 0.6 0 0.95 0.6 0 + 0.95 0.55 0 1 0.55 0 0.95 0.6 0 1 0.6 0 + 0 0.6 0 0.05 0.6 0 0 0.65 0 0.05 0.65 0 + 0.05 0.6 0 0.1 0.6 0 0.05 0.65 0 0.1 0.65 0 + 0.1 0.6 0 0.15 0.6 0 0.1 0.65 0 0.15 0.65 0 + 0.15 0.6 0 0.2 0.6 0 0.15 0.65 0 0.2 0.65 0 + 0.2 0.6 0 0.25 0.6 0 0.2 0.65 0 0.25 0.65 0 + 0.25 0.6 0 0.3 0.6 0 0.25 0.65 0 0.3 0.65 0 + 0.3 0.6 0 0.35 0.6 0 0.3 0.65 0 0.35 0.65 0 + 0.35 0.6 0 0.4 0.6 0 0.35 0.65 0 0.4 0.65 0 + 0.4 0.6 0 0.45 0.6 0 0.4 0.65 0 0.45 0.65 0 + 0.45 0.6 0 0.5 0.6 0 0.45 0.65 0 0.5 0.65 0 + 0.5 0.6 0 0.55 0.6 0 0.5 0.65 0 0.55 0.65 0 + 0.55 0.6 0 0.6 0.6 0 0.55 0.65 0 0.6 0.65 0 + 0.6 0.6 0 0.65 0.6 0 0.6 0.65 0 0.65 0.65 0 + 0.65 0.6 0 0.7 0.6 0 0.65 0.65 0 0.7 0.65 0 + 0.7 0.6 0 0.75 0.6 0 0.7 0.65 0 0.75 0.65 0 + 0.75 0.6 0 0.8 0.6 0 0.75 0.65 0 0.8 0.65 0 + 0.8 0.6 0 0.85 0.6 0 0.8 0.65 0 0.85 0.65 0 + 0.85 0.6 0 0.9 0.6 0 0.85 0.65 0 0.9 0.65 0 + 0.9 0.6 0 0.95 0.6 0 0.9 0.65 0 0.95 0.65 0 + 0.95 0.6 0 1 0.6 0 0.95 0.65 0 1 0.65 0 + 0 0.65 0 0.05 0.65 0 0 0.7 0 0.05 0.7 0 + 0.05 0.65 0 0.1 0.65 0 0.05 0.7 0 0.1 0.7 0 + 0.1 0.65 0 0.15 0.65 0 0.1 0.7 0 0.15 0.7 0 + 0.15 0.65 0 0.2 0.65 0 0.15 0.7 0 0.2 0.7 0 + 0.2 0.65 0 0.25 0.65 0 0.2 0.7 0 0.25 0.7 0 + 0.25 0.65 0 0.3 0.65 0 0.25 0.7 0 0.3 0.7 0 + 0.3 0.65 0 0.35 0.65 0 0.3 0.7 0 0.35 0.7 0 + 0.35 0.65 0 0.4 0.65 0 0.35 0.7 0 0.4 0.7 0 + 0.4 0.65 0 0.45 0.65 0 0.4 0.7 0 0.45 0.7 0 + 0.45 0.65 0 0.5 0.65 0 0.45 0.7 0 0.5 0.7 0 + 0.5 0.65 0 0.55 0.65 0 0.5 0.7 0 0.55 0.7 0 + 0.55 0.65 0 0.6 0.65 0 0.55 0.7 0 0.6 0.7 0 + 0.6 0.65 0 0.65 0.65 0 0.6 0.7 0 0.65 0.7 0 + 0.65 0.65 0 0.7 0.65 0 0.65 0.7 0 0.7 0.7 0 + 0.7 0.65 0 0.75 0.65 0 0.7 0.7 0 0.75 0.7 0 + 0.75 0.65 0 0.8 0.65 0 0.75 0.7 0 0.8 0.7 0 + 0.8 0.65 0 0.85 0.65 0 0.8 0.7 0 0.85 0.7 0 + 0.85 0.65 0 0.9 0.65 0 0.85 0.7 0 0.9 0.7 0 + 0.9 0.65 0 0.95 0.65 0 0.9 0.7 0 0.95 0.7 0 + 0.95 0.65 0 1 0.65 0 0.95 0.7 0 1 0.7 0 + 0 0.7 0 0.05 0.7 0 0 0.75 0 0.05 0.75 0 + 0.05 0.7 0 0.1 0.7 0 0.05 0.75 0 0.1 0.75 0 + 0.1 0.7 0 0.15 0.7 0 0.1 0.75 0 0.15 0.75 0 + 0.15 0.7 0 0.2 0.7 0 0.15 0.75 0 0.2 0.75 0 + 0.2 0.7 0 0.25 0.7 0 0.2 0.75 0 0.25 0.75 0 + 0.25 0.7 0 0.3 0.7 0 0.25 0.75 0 0.3 0.75 0 + 0.3 0.7 0 0.35 0.7 0 0.3 0.75 0 0.35 0.75 0 + 0.35 0.7 0 0.4 0.7 0 0.35 0.75 0 0.4 0.75 0 + 0.4 0.7 0 0.45 0.7 0 0.4 0.75 0 0.45 0.75 0 + 0.45 0.7 0 0.5 0.7 0 0.45 0.75 0 0.5 0.75 0 + 0.5 0.7 0 0.55 0.7 0 0.5 0.75 0 0.55 0.75 0 + 0.55 0.7 0 0.6 0.7 0 0.55 0.75 0 0.6 0.75 0 + 0.6 0.7 0 0.65 0.7 0 0.6 0.75 0 0.65 0.75 0 + 0.65 0.7 0 0.7 0.7 0 0.65 0.75 0 0.7 0.75 0 + 0.7 0.7 0 0.75 0.7 0 0.7 0.75 0 0.75 0.75 0 + 0.75 0.7 0 0.8 0.7 0 0.75 0.75 0 0.8 0.75 0 + 0.8 0.7 0 0.85 0.7 0 0.8 0.75 0 0.85 0.75 0 + 0.85 0.7 0 0.9 0.7 0 0.85 0.75 0 0.9 0.75 0 + 0.9 0.7 0 0.95 0.7 0 0.9 0.75 0 0.95 0.75 0 + 0.95 0.7 0 1 0.7 0 0.95 0.75 0 1 0.75 0 + 0 0.75 0 0.05 0.75 0 0 0.8 0 0.05 0.8 0 + 0.05 0.75 0 0.1 0.75 0 0.05 0.8 0 0.1 0.8 0 + 0.1 0.75 0 0.15 0.75 0 0.1 0.8 0 0.15 0.8 0 + 0.15 0.75 0 0.2 0.75 0 0.15 0.8 0 0.2 0.8 0 + 0.2 0.75 0 0.25 0.75 0 0.2 0.8 0 0.25 0.8 0 + 0.25 0.75 0 0.3 0.75 0 0.25 0.8 0 0.3 0.8 0 + 0.3 0.75 0 0.35 0.75 0 0.3 0.8 0 0.35 0.8 0 + 0.35 0.75 0 0.4 0.75 0 0.35 0.8 0 0.4 0.8 0 + 0.4 0.75 0 0.45 0.75 0 0.4 0.8 0 0.45 0.8 0 + 0.45 0.75 0 0.5 0.75 0 0.45 0.8 0 0.5 0.8 0 + 0.5 0.75 0 0.55 0.75 0 0.5 0.8 0 0.55 0.8 0 + 0.55 0.75 0 0.6 0.75 0 0.55 0.8 0 0.6 0.8 0 + 0.6 0.75 0 0.65 0.75 0 0.6 0.8 0 0.65 0.8 0 + 0.65 0.75 0 0.7 0.75 0 0.65 0.8 0 0.7 0.8 0 + 0.7 0.75 0 0.75 0.75 0 0.7 0.8 0 0.75 0.8 0 + 0.75 0.75 0 0.8 0.75 0 0.75 0.8 0 0.8 0.8 0 + 0.8 0.75 0 0.85 0.75 0 0.8 0.8 0 0.85 0.8 0 + 0.85 0.75 0 0.9 0.75 0 0.85 0.8 0 0.9 0.8 0 + 0.9 0.75 0 0.95 0.75 0 0.9 0.8 0 0.95 0.8 0 + 0.95 0.75 0 1 0.75 0 0.95 0.8 0 1 0.8 0 + 0 0.8 0 0.05 0.8 0 0 0.85 0 0.05 0.85 0 + 0.05 0.8 0 0.1 0.8 0 0.05 0.85 0 0.1 0.85 0 + 0.1 0.8 0 0.15 0.8 0 0.1 0.85 0 0.15 0.85 0 + 0.15 0.8 0 0.2 0.8 0 0.15 0.85 0 0.2 0.85 0 + 0.2 0.8 0 0.25 0.8 0 0.2 0.85 0 0.25 0.85 0 + 0.25 0.8 0 0.3 0.8 0 0.25 0.85 0 0.3 0.85 0 + 0.3 0.8 0 0.35 0.8 0 0.3 0.85 0 0.35 0.85 0 + 0.35 0.8 0 0.4 0.8 0 0.35 0.85 0 0.4 0.85 0 + 0.4 0.8 0 0.45 0.8 0 0.4 0.85 0 0.45 0.85 0 + 0.45 0.8 0 0.5 0.8 0 0.45 0.85 0 0.5 0.85 0 + 0.5 0.8 0 0.55 0.8 0 0.5 0.85 0 0.55 0.85 0 + 0.55 0.8 0 0.6 0.8 0 0.55 0.85 0 0.6 0.85 0 + 0.6 0.8 0 0.65 0.8 0 0.6 0.85 0 0.65 0.85 0 + 0.65 0.8 0 0.7 0.8 0 0.65 0.85 0 0.7 0.85 0 + 0.7 0.8 0 0.75 0.8 0 0.7 0.85 0 0.75 0.85 0 + 0.75 0.8 0 0.8 0.8 0 0.75 0.85 0 0.8 0.85 0 + 0.8 0.8 0 0.85 0.8 0 0.8 0.85 0 0.85 0.85 0 + 0.85 0.8 0 0.9 0.8 0 0.85 0.85 0 0.9 0.85 0 + 0.9 0.8 0 0.95 0.8 0 0.9 0.85 0 0.95 0.85 0 + 0.95 0.8 0 1 0.8 0 0.95 0.85 0 1 0.85 0 + 0 0.85 0 0.05 0.85 0 0 0.9 0 0.05 0.9 0 + 0.05 0.85 0 0.1 0.85 0 0.05 0.9 0 0.1 0.9 0 + 0.1 0.85 0 0.15 0.85 0 0.1 0.9 0 0.15 0.9 0 + 0.15 0.85 0 0.2 0.85 0 0.15 0.9 0 0.2 0.9 0 + 0.2 0.85 0 0.25 0.85 0 0.2 0.9 0 0.25 0.9 0 + 0.25 0.85 0 0.3 0.85 0 0.25 0.9 0 0.3 0.9 0 + 0.3 0.85 0 0.35 0.85 0 0.3 0.9 0 0.35 0.9 0 + 0.35 0.85 0 0.4 0.85 0 0.35 0.9 0 0.4 0.9 0 + 0.4 0.85 0 0.45 0.85 0 0.4 0.9 0 0.45 0.9 0 + 0.45 0.85 0 0.5 0.85 0 0.45 0.9 0 0.5 0.9 0 + 0.5 0.85 0 0.55 0.85 0 0.5 0.9 0 0.55 0.9 0 + 0.55 0.85 0 0.6 0.85 0 0.55 0.9 0 0.6 0.9 0 + 0.6 0.85 0 0.65 0.85 0 0.6 0.9 0 0.65 0.9 0 + 0.65 0.85 0 0.7 0.85 0 0.65 0.9 0 0.7 0.9 0 + 0.7 0.85 0 0.75 0.85 0 0.7 0.9 0 0.75 0.9 0 + 0.75 0.85 0 0.8 0.85 0 0.75 0.9 0 0.8 0.9 0 + 0.8 0.85 0 0.85 0.85 0 0.8 0.9 0 0.85 0.9 0 + 0.85 0.85 0 0.9 0.85 0 0.85 0.9 0 0.9 0.9 0 + 0.9 0.85 0 0.95 0.85 0 0.9 0.9 0 0.95 0.9 0 + 0.95 0.85 0 1 0.85 0 0.95 0.9 0 1 0.9 0 + 0 0.9 0 0.05 0.9 0 0 0.95 0 0.05 0.95 0 + 0.05 0.9 0 0.1 0.9 0 0.05 0.95 0 0.1 0.95 0 + 0.1 0.9 0 0.15 0.9 0 0.1 0.95 0 0.15 0.95 0 + 0.15 0.9 0 0.2 0.9 0 0.15 0.95 0 0.2 0.95 0 + 0.2 0.9 0 0.25 0.9 0 0.2 0.95 0 0.25 0.95 0 + 0.25 0.9 0 0.3 0.9 0 0.25 0.95 0 0.3 0.95 0 + 0.3 0.9 0 0.35 0.9 0 0.3 0.95 0 0.35 0.95 0 + 0.35 0.9 0 0.4 0.9 0 0.35 0.95 0 0.4 0.95 0 + 0.4 0.9 0 0.45 0.9 0 0.4 0.95 0 0.45 0.95 0 + 0.45 0.9 0 0.5 0.9 0 0.45 0.95 0 0.5 0.95 0 + 0.5 0.9 0 0.55 0.9 0 0.5 0.95 0 0.55 0.95 0 + 0.55 0.9 0 0.6 0.9 0 0.55 0.95 0 0.6 0.95 0 + 0.6 0.9 0 0.65 0.9 0 0.6 0.95 0 0.65 0.95 0 + 0.65 0.9 0 0.7 0.9 0 0.65 0.95 0 0.7 0.95 0 + 0.7 0.9 0 0.75 0.9 0 0.7 0.95 0 0.75 0.95 0 + 0.75 0.9 0 0.8 0.9 0 0.75 0.95 0 0.8 0.95 0 + 0.8 0.9 0 0.85 0.9 0 0.8 0.95 0 0.85 0.95 0 + 0.85 0.9 0 0.9 0.9 0 0.85 0.95 0 0.9 0.95 0 + 0.9 0.9 0 0.95 0.9 0 0.9 0.95 0 0.95 0.95 0 + 0.95 0.9 0 1 0.9 0 0.95 0.95 0 1 0.95 0 + 0 0.95 0 0.05 0.95 0 0 1 0 0.05 1 0 + 0.05 0.95 0 0.1 0.95 0 0.05 1 0 0.1 1 0 + 0.1 0.95 0 0.15 0.95 0 0.1 1 0 0.15 1 0 + 0.15 0.95 0 0.2 0.95 0 0.15 1 0 0.2 1 0 + 0.2 0.95 0 0.25 0.95 0 0.2 1 0 0.25 1 0 + 0.25 0.95 0 0.3 0.95 0 0.25 1 0 0.3 1 0 + 0.3 0.95 0 0.35 0.95 0 0.3 1 0 0.35 1 0 + 0.35 0.95 0 0.4 0.95 0 0.35 1 0 0.4 1 0 + 0.4 0.95 0 0.45 0.95 0 0.4 1 0 0.45 1 0 + 0.45 0.95 0 0.5 0.95 0 0.45 1 0 0.5 1 0 + 0.5 0.95 0 0.55 0.95 0 0.5 1 0 0.55 1 0 + 0.55 0.95 0 0.6 0.95 0 0.55 1 0 0.6 1 0 + 0.6 0.95 0 0.65 0.95 0 0.6 1 0 0.65 1 0 + 0.65 0.95 0 0.7 0.95 0 0.65 1 0 0.7 1 0 + 0.7 0.95 0 0.75 0.95 0 0.7 1 0 0.75 1 0 + 0.75 0.95 0 0.8 0.95 0 0.75 1 0 0.8 1 0 + 0.8 0.95 0 0.85 0.95 0 0.8 1 0 0.85 1 0 + 0.85 0.95 0 0.9 0.95 0 0.85 1 0 0.9 1 0 + 0.9 0.95 0 0.95 0.95 0 0.9 1 0 0.95 1 0 + 0.95 0.95 0 1 0.95 0 0.95 1 0 1 1 0 + + + + + 0 1 3 2 4 5 7 6 8 9 11 10 + 12 13 15 14 16 17 19 18 20 21 23 22 + 24 25 27 26 28 29 31 30 32 33 35 34 + 36 37 39 38 40 41 43 42 44 45 47 46 + 48 49 51 50 52 53 55 54 56 57 59 58 + 60 61 63 62 64 65 67 66 68 69 71 70 + 72 73 75 74 76 77 79 78 80 81 83 82 + 84 85 87 86 88 89 91 90 92 93 95 94 + 96 97 99 98 100 101 103 102 104 105 107 106 + 108 109 111 110 112 113 115 114 116 117 119 118 + 120 121 123 122 124 125 127 126 128 129 131 130 + 132 133 135 134 136 137 139 138 140 141 143 142 + 144 145 147 146 148 149 151 150 152 153 155 154 + 156 157 159 158 160 161 163 162 164 165 167 166 + 168 169 171 170 172 173 175 174 176 177 179 178 + 180 181 183 182 184 185 187 186 188 189 191 190 + 192 193 195 194 196 197 199 198 200 201 203 202 + 204 205 207 206 208 209 211 210 212 213 215 214 + 216 217 219 218 220 221 223 222 224 225 227 226 + 228 229 231 230 232 233 235 234 236 237 239 238 + 240 241 243 242 244 245 247 246 248 249 251 250 + 252 253 255 254 256 257 259 258 260 261 263 262 + 264 265 267 266 268 269 271 270 272 273 275 274 + 276 277 279 278 280 281 283 282 284 285 287 286 + 288 289 291 290 292 293 295 294 296 297 299 298 + 300 301 303 302 304 305 307 306 308 309 311 310 + 312 313 315 314 316 317 319 318 320 321 323 322 + 324 325 327 326 328 329 331 330 332 333 335 334 + 336 337 339 338 340 341 343 342 344 345 347 346 + 348 349 351 350 352 353 355 354 356 357 359 358 + 360 361 363 362 364 365 367 366 368 369 371 370 + 372 373 375 374 376 377 379 378 380 381 383 382 + 384 385 387 386 388 389 391 390 392 393 395 394 + 396 397 399 398 400 401 403 402 404 405 407 406 + 408 409 411 410 412 413 415 414 416 417 419 418 + 420 421 423 422 424 425 427 426 428 429 431 430 + 432 433 435 434 436 437 439 438 440 441 443 442 + 444 445 447 446 448 449 451 450 452 453 455 454 + 456 457 459 458 460 461 463 462 464 465 467 466 + 468 469 471 470 472 473 475 474 476 477 479 478 + 480 481 483 482 484 485 487 486 488 489 491 490 + 492 493 495 494 496 497 499 498 500 501 503 502 + 504 505 507 506 508 509 511 510 512 513 515 514 + 516 517 519 518 520 521 523 522 524 525 527 526 + 528 529 531 530 532 533 535 534 536 537 539 538 + 540 541 543 542 544 545 547 546 548 549 551 550 + 552 553 555 554 556 557 559 558 560 561 563 562 + 564 565 567 566 568 569 571 570 572 573 575 574 + 576 577 579 578 580 581 583 582 584 585 587 586 + 588 589 591 590 592 593 595 594 596 597 599 598 + 600 601 603 602 604 605 607 606 608 609 611 610 + 612 613 615 614 616 617 619 618 620 621 623 622 + 624 625 627 626 628 629 631 630 632 633 635 634 + 636 637 639 638 640 641 643 642 644 645 647 646 + 648 649 651 650 652 653 655 654 656 657 659 658 + 660 661 663 662 664 665 667 666 668 669 671 670 + 672 673 675 674 676 677 679 678 680 681 683 682 + 684 685 687 686 688 689 691 690 692 693 695 694 + 696 697 699 698 700 701 703 702 704 705 707 706 + 708 709 711 710 712 713 715 714 716 717 719 718 + 720 721 723 722 724 725 727 726 728 729 731 730 + 732 733 735 734 736 737 739 738 740 741 743 742 + 744 745 747 746 748 749 751 750 752 753 755 754 + 756 757 759 758 760 761 763 762 764 765 767 766 + 768 769 771 770 772 773 775 774 776 777 779 778 + 780 781 783 782 784 785 787 786 788 789 791 790 + 792 793 795 794 796 797 799 798 800 801 803 802 + 804 805 807 806 808 809 811 810 812 813 815 814 + 816 817 819 818 820 821 823 822 824 825 827 826 + 828 829 831 830 832 833 835 834 836 837 839 838 + 840 841 843 842 844 845 847 846 848 849 851 850 + 852 853 855 854 856 857 859 858 860 861 863 862 + 864 865 867 866 868 869 871 870 872 873 875 874 + 876 877 879 878 880 881 883 882 884 885 887 886 + 888 889 891 890 892 893 895 894 896 897 899 898 + 900 901 903 902 904 905 907 906 908 909 911 910 + 912 913 915 914 916 917 919 918 920 921 923 922 + 924 925 927 926 928 929 931 930 932 933 935 934 + 936 937 939 938 940 941 943 942 944 945 947 946 + 948 949 951 950 952 953 955 954 956 957 959 958 + 960 961 963 962 964 965 967 966 968 969 971 970 + 972 973 975 974 976 977 979 978 980 981 983 982 + 984 985 987 986 988 989 991 990 992 993 995 994 + 996 997 999 998 1000 1001 1003 1002 1004 1005 1007 1006 + 1008 1009 1011 1010 1012 1013 1015 1014 1016 1017 1019 1018 + 1020 1021 1023 1022 1024 1025 1027 1026 1028 1029 1031 1030 + 1032 1033 1035 1034 1036 1037 1039 1038 1040 1041 1043 1042 + 1044 1045 1047 1046 1048 1049 1051 1050 1052 1053 1055 1054 + 1056 1057 1059 1058 1060 1061 1063 1062 1064 1065 1067 1066 + 1068 1069 1071 1070 1072 1073 1075 1074 1076 1077 1079 1078 + 1080 1081 1083 1082 1084 1085 1087 1086 1088 1089 1091 1090 + 1092 1093 1095 1094 1096 1097 1099 1098 1100 1101 1103 1102 + 1104 1105 1107 1106 1108 1109 1111 1110 1112 1113 1115 1114 + 1116 1117 1119 1118 1120 1121 1123 1122 1124 1125 1127 1126 + 1128 1129 1131 1130 1132 1133 1135 1134 1136 1137 1139 1138 + 1140 1141 1143 1142 1144 1145 1147 1146 1148 1149 1151 1150 + 1152 1153 1155 1154 1156 1157 1159 1158 1160 1161 1163 1162 + 1164 1165 1167 1166 1168 1169 1171 1170 1172 1173 1175 1174 + 1176 1177 1179 1178 1180 1181 1183 1182 1184 1185 1187 1186 + 1188 1189 1191 1190 1192 1193 1195 1194 1196 1197 1199 1198 + 1200 1201 1203 1202 1204 1205 1207 1206 1208 1209 1211 1210 + 1212 1213 1215 1214 1216 1217 1219 1218 1220 1221 1223 1222 + 1224 1225 1227 1226 1228 1229 1231 1230 1232 1233 1235 1234 + 1236 1237 1239 1238 1240 1241 1243 1242 1244 1245 1247 1246 + 1248 1249 1251 1250 1252 1253 1255 1254 1256 1257 1259 1258 + 1260 1261 1263 1262 1264 1265 1267 1266 1268 1269 1271 1270 + 1272 1273 1275 1274 1276 1277 1279 1278 1280 1281 1283 1282 + 1284 1285 1287 1286 1288 1289 1291 1290 1292 1293 1295 1294 + 1296 1297 1299 1298 1300 1301 1303 1302 1304 1305 1307 1306 + 1308 1309 1311 1310 1312 1313 1315 1314 1316 1317 1319 1318 + 1320 1321 1323 1322 1324 1325 1327 1326 1328 1329 1331 1330 + 1332 1333 1335 1334 1336 1337 1339 1338 1340 1341 1343 1342 + 1344 1345 1347 1346 1348 1349 1351 1350 1352 1353 1355 1354 + 1356 1357 1359 1358 1360 1361 1363 1362 1364 1365 1367 1366 + 1368 1369 1371 1370 1372 1373 1375 1374 1376 1377 1379 1378 + 1380 1381 1383 1382 1384 1385 1387 1386 1388 1389 1391 1390 + 1392 1393 1395 1394 1396 1397 1399 1398 1400 1401 1403 1402 + 1404 1405 1407 1406 1408 1409 1411 1410 1412 1413 1415 1414 + 1416 1417 1419 1418 1420 1421 1423 1422 1424 1425 1427 1426 + 1428 1429 1431 1430 1432 1433 1435 1434 1436 1437 1439 1438 + 1440 1441 1443 1442 1444 1445 1447 1446 1448 1449 1451 1450 + 1452 1453 1455 1454 1456 1457 1459 1458 1460 1461 1463 1462 + 1464 1465 1467 1466 1468 1469 1471 1470 1472 1473 1475 1474 + 1476 1477 1479 1478 1480 1481 1483 1482 1484 1485 1487 1486 + 1488 1489 1491 1490 1492 1493 1495 1494 1496 1497 1499 1498 + 1500 1501 1503 1502 1504 1505 1507 1506 1508 1509 1511 1510 + 1512 1513 1515 1514 1516 1517 1519 1518 1520 1521 1523 1522 + 1524 1525 1527 1526 1528 1529 1531 1530 1532 1533 1535 1534 + 1536 1537 1539 1538 1540 1541 1543 1542 1544 1545 1547 1546 + 1548 1549 1551 1550 1552 1553 1555 1554 1556 1557 1559 1558 + 1560 1561 1563 1562 1564 1565 1567 1566 1568 1569 1571 1570 + 1572 1573 1575 1574 1576 1577 1579 1578 1580 1581 1583 1582 + 1584 1585 1587 1586 1588 1589 1591 1590 1592 1593 1595 1594 + 1596 1597 1599 1598 + + + 4 8 12 16 20 24 28 32 36 40 44 48 + 52 56 60 64 68 72 76 80 84 88 92 96 + 100 104 108 112 116 120 124 128 132 136 140 144 + 148 152 156 160 164 168 172 176 180 184 188 192 + 196 200 204 208 212 216 220 224 228 232 236 240 + 244 248 252 256 260 264 268 272 276 280 284 288 + 292 296 300 304 308 312 316 320 324 328 332 336 + 340 344 348 352 356 360 364 368 372 376 380 384 + 388 392 396 400 404 408 412 416 420 424 428 432 + 436 440 444 448 452 456 460 464 468 472 476 480 + 484 488 492 496 500 504 508 512 516 520 524 528 + 532 536 540 544 548 552 556 560 564 568 572 576 + 580 584 588 592 596 600 604 608 612 616 620 624 + 628 632 636 640 644 648 652 656 660 664 668 672 + 676 680 684 688 692 696 700 704 708 712 716 720 + 724 728 732 736 740 744 748 752 756 760 764 768 + 772 776 780 784 788 792 796 800 804 808 812 816 + 820 824 828 832 836 840 844 848 852 856 860 864 + 868 872 876 880 884 888 892 896 900 904 908 912 + 916 920 924 928 932 936 940 944 948 952 956 960 + 964 968 972 976 980 984 988 992 996 1000 1004 1008 + 1012 1016 1020 1024 1028 1032 1036 1040 1044 1048 1052 1056 + 1060 1064 1068 1072 1076 1080 1084 1088 1092 1096 1100 1104 + 1108 1112 1116 1120 1124 1128 1132 1136 1140 1144 1148 1152 + 1156 1160 1164 1168 1172 1176 1180 1184 1188 1192 1196 1200 + 1204 1208 1212 1216 1220 1224 1228 1232 1236 1240 1244 1248 + 1252 1256 1260 1264 1268 1272 1276 1280 1284 1288 1292 1296 + 1300 1304 1308 1312 1316 1320 1324 1328 1332 1336 1340 1344 + 1348 1352 1356 1360 1364 1368 1372 1376 1380 1384 1388 1392 + 1396 1400 1404 1408 1412 1416 1420 1424 1428 1432 1436 1440 + 1444 1448 1452 1456 1460 1464 1468 1472 1476 1480 1484 1488 + 1492 1496 1500 1504 1508 1512 1516 1520 1524 1528 1532 1536 + 1540 1544 1548 1552 1556 1560 1564 1568 1572 1576 1580 1584 + 1588 1592 1596 1600 + + + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 + + + + + diff --git a/test/references/2pboxdfm_2d_trias-reference.vtu b/test/references/2pboxdfm_2d_trias-reference.vtu new file mode 100644 index 0000000000000000000000000000000000000000..cabf0dbe8f5186b2e3eb90653a0b59efb2d70933 --- /dev/null +++ b/test/references/2pboxdfm_2d_trias-reference.vtu @@ -0,0 +1,332 @@ + + + + + + + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + + + 10000 10000 10000 10000 10000 10000 10000.4 10000 10000 10000.4 10000.3 10000 + 10000.4 10000 10000 10000.4 10000 10001.5 10000 10002.1 10000 10683.8 10000 10002.1 + 10000 10000.3 10002.1 10683.8 10002.1 10000.3 10683.8 10002.2 10000 10000 10002.2 10000 + 10683.8 10000.7 10002.2 10000 10002.2 10000.7 10000.4 10146.5 10000.3 10683.8 10000.3 10146.5 + 50000 50000 50000 10683.8 10146.5 10000.7 10146.5 10000 10000.7 50000 50000 50000 + 10000 10000 10000.7 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10205.2 10001.5 10000 10492.2 10001.5 10205.2 + 10000.4 10001.5 10492.2 50000 50000 50000 10492.2 10205.2 11671.1 12076.7 11671.1 10205.2 + 10492.2 11671.1 12723.1 10492.2 12723.1 11646.8 12076.7 13423.4 11671.1 12723.1 11671.1 13423.4 + 12723.1 13423.4 14197.9 12984.2 13423.4 12076.7 12984.2 15662 13423.4 15662 14197.9 13423.4 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 10492.2 11646.8 10000 10000 10000 11646.8 10000 11646.8 12939.5 10000 10891.6 10000 + 10000 10891.6 10067.6 10000 12650.8 10891.6 50000 50000 50000 10000 10067.6 10000 + 10000 10000 10000 10067.6 10000 10000 10067.6 10891.6 11809.1 10146 10067.6 11809.1 + 10067.6 10146 10000 10000 10146 10000 12723.1 12939.5 11646.8 12723.1 14197.9 12939.5 + 13850.5 12939.5 14197.9 10000 12939.5 12650.8 13850.5 12650.8 12939.5 11809.1 10891.6 12650.8 + 13850.5 13447.8 12650.8 11809.1 12650.8 13447.8 15603.9 13850.5 14197.9 15603.9 14197.9 15662 + 15603.9 13447.8 13850.5 12749.5 13447.8 15603.9 11809.1 11452 10146 11809.1 13447.8 11452 + 10000 10146 11452 12749.5 11452 13447.8 10000 10000 11452 10000 11452 12749.5 + + + 1 1 1 1 0.999995 1 0.999927 1 1 0.999927 0.999946 1 + 0.999927 1 0.999995 0.999927 0.999995 0.999754 1 0.999661 1 0.898395 1 0.999661 + 1 0.999946 0.999661 0.898395 0.999661 0.999946 0.898395 0.999636 1 1 0.999636 1 + 0.898395 0.999892 0.999636 1 0.999636 0.999892 0.999927 0.976496 0.999946 0.898395 0.999946 0.976496 + 1 1 1 0.898395 0.976496 0.999892 0.976496 1 0.999892 1 1 1 + 1 1 0.999892 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 0.96736 0.999754 0.999995 0.924866 0.999754 0.96736 + 0.999927 0.999754 0.924866 1 1 1 0.924866 0.96736 0.781993 0.742233 0.781993 0.96736 + 0.924866 0.781993 0.686553 0.924866 0.686553 0.784505 0.742233 0.635081 0.781993 0.686553 0.781993 0.635081 + 0.686553 0.635081 0.586786 0.666392 0.635081 0.742233 0.666392 0.514285 0.635081 0.514285 0.586786 0.635081 + 1 1 1 1 1 1 1 1 1 1 1 1 + 0.924866 0.784505 1 1 1 0.784505 1 0.784505 0.669757 1 0.871237 1 + 1 0.871237 0.989033 1 0.692361 0.871237 1 1 1 1 0.989033 1 + 1 1 1 0.989033 1 1 0.989033 0.871237 0.768005 0.976578 0.989033 0.768005 + 0.989033 0.976578 1 1 0.976578 1 0.686553 0.669757 0.784505 0.686553 0.586786 0.669757 + 0.607448 0.669757 0.586786 1 0.669757 0.692361 0.607448 0.692361 0.669757 0.768005 0.871237 0.692361 + 0.607448 0.633431 0.692361 0.768005 0.692361 0.633431 0.516782 0.607448 0.586786 0.516782 0.586786 0.514285 + 0.516782 0.633431 0.607448 0.684465 0.633431 0.516782 0.768005 0.805248 0.976578 0.768005 0.633431 0.805248 + 1 0.976578 0.805248 0.684465 0.805248 0.633431 1 1 0.805248 1 0.805248 0.684465 + + + 109810 109262 109810 109810 108861 109262 108567 109810 109262 108567 108872 109810 + 108567 109262 108861 108567 108861 108507 109810 109404 109810 109233 109810 109404 + 109810 108872 109404 109233 109404 108872 109233 109282 109810 109810 109282 109810 + 109233 108499 109282 109810 109282 108499 108567 108339 108872 109233 108872 108339 + 108567 108406 108339 109233 108339 108499 108339 107630 108499 108339 107476 107630 + 107630 109810 108499 107630 108652 109810 109810 109810 108652 109810 108652 107358 + 107630 106456 108652 107358 108652 106456 108270 108507 108861 108738 108507 108270 + 108567 108507 108738 108567 108738 108406 108738 108270 109410 110045 109410 108270 + 108738 109410 109191 108738 109191 108313 110045 109895 109410 109191 109410 109895 + 109191 109895 109031 109179 109895 110045 109179 109125 109895 109125 109031 109895 + 108339 108406 107981 108738 107981 108406 108339 107981 107476 107981 105955 107476 + 108738 108313 107981 107201 107981 108313 107201 108313 108178 107201 106845 107981 + 107981 106845 105955 107201 106927 106845 107630 107476 105955 107630 105955 106456 + 107358 106456 104905 105955 104905 106456 105955 106845 105761 104359 105955 105761 + 105955 104359 104905 104905 104359 102452 109191 108178 108313 109191 109031 108178 + 107632 108178 109031 107201 108178 106927 107632 106927 108178 105761 106845 106927 + 107632 105924 106927 105761 106927 105924 107510 107632 109031 107510 109031 109125 + 107510 105924 107632 103344 105924 107510 105761 103313 104359 105761 105924 103313 + 102452 104359 103313 103344 103313 105924 100000 102452 103313 100000 103313 103344 + + + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + + + 1000 1000 1000 1000 999.976 1000 999.642 1000 1000 999.642 999.735 1000 + 999.642 1000 999.976 999.642 999.976 998.799 1000 998.345 1000 589.111 1000 998.345 + 1000 999.735 998.345 589.111 998.345 999.735 589.111 998.225 1000 1000 998.225 1000 + 589.111 999.472 998.225 1000 998.225 999.472 999.642 890.181 999.735 589.111 999.735 890.181 + 1000 1000 1000 589.111 890.181 999.472 890.181 999.999 999.472 1000 1000 1000 + 999.999 1000 999.472 999.999 1000 1000 1000 1000 1000 1000 1000 1000 + 999.999 999.999 1000 1000 1000 999.999 850.036 998.799 999.976 680.859 998.799 850.036 + 999.642 998.799 680.859 1000 1000 1000 680.859 850.036 290.477 221.01 290.477 850.036 + 680.859 290.477 145.628 680.859 145.628 295.354 221.01 94.8638 290.477 145.628 290.477 94.8638 + 145.628 94.8638 60.5634 123.792 94.8638 221.01 123.792 27.6192 94.8638 27.6192 60.5634 94.8638 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 680.859 295.354 1000 1000 1000 295.354 1000 295.354 127.253 1000 504.953 1000 + 1000 504.953 947.565 1000 152.423 504.953 1000 1000 1000 999.999 947.565 999.999 + 1000 999.999 1000 947.565 1000 999.999 947.565 504.953 264.404 890.548 947.565 264.404 + 947.565 890.548 1000 1000 890.548 1000 145.628 127.253 295.354 145.628 60.5634 127.253 + 73.8374 127.253 60.5634 1000 127.253 152.423 73.8374 152.423 127.253 264.404 504.953 152.423 + 73.8374 93.4949 152.423 264.404 152.423 93.4949 28.4539 73.8374 60.5634 28.4539 60.5634 27.6192 + 28.4539 93.4949 73.8374 143.241 93.4949 28.4539 264.404 338.03 890.548 264.404 93.4949 338.03 + 1000 890.548 338.03 143.241 338.03 93.4949 1000 1000 338.03 1000 338.03 143.241 + + + 0 4.56525e-14 0 0 4.91868e-06 4.56525e-14 7.3485e-05 0 4.56525e-14 7.3485e-05 5.43468e-05 0 + 7.3485e-05 4.56525e-14 4.91868e-06 7.3485e-05 4.91868e-06 0.000246223 0 0.000339423 0 0.101605 0 0.000339423 + 0 5.43468e-05 0.000339423 0.101605 0.000339423 5.43468e-05 0.101605 0.000364057 0 0 0.000364057 0 + 0.101605 0.000108282 0.000364057 0 0.000364057 0.000108282 7.3485e-05 0.0235044 5.43468e-05 0.101605 5.43468e-05 0.0235044 + 0 0 0 0.101605 0.0235044 0.000108282 0.0235044 1.90232e-07 0.000108282 0 0 0 + 1.90232e-07 0 0.000108282 1.90232e-07 5.6424e-22 0 0 0 5.6424e-22 0 5.6424e-22 0 + 1.90232e-07 2.10601e-07 5.6424e-22 0 5.6424e-22 2.10601e-07 0.0326403 0.000246223 4.91868e-06 0.0751341 0.000246223 0.0326403 + 7.3485e-05 0.000246223 0.0751341 0 0 0 0.0751341 0.0326403 0.218007 0.257767 0.218007 0.0326403 + 0.0751341 0.218007 0.313447 0.0751341 0.313447 0.215495 0.257767 0.364919 0.218007 0.313447 0.218007 0.364919 + 0.313447 0.364919 0.413214 0.333608 0.364919 0.257767 0.333608 0.485715 0.364919 0.485715 0.413214 0.364919 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0.0751341 0.215495 0 0 0 0.215495 0 0.215495 0.330243 0 0.128763 0 + 0 0.128763 0.0109672 0 0.307639 0.128763 0 0 0 1.90232e-07 0.0109672 2.10601e-07 + 0 2.10601e-07 0 0.0109672 0 2.10601e-07 0.0109672 0.128763 0.231995 0.0234223 0.0109672 0.231995 + 0.0109672 0.0234223 0 0 0.0234223 0 0.313447 0.330243 0.215495 0.313447 0.413214 0.330243 + 0.392552 0.330243 0.413214 0 0.330243 0.307639 0.392552 0.307639 0.330243 0.231995 0.128763 0.307639 + 0.392552 0.366569 0.307639 0.231995 0.307639 0.366569 0.483218 0.392552 0.413214 0.483218 0.413214 0.485715 + 0.483218 0.366569 0.392552 0.315535 0.366569 0.483218 0.231995 0.194752 0.0234223 0.231995 0.366569 0.194752 + 0 0.0234223 0.194752 0.315535 0.194752 0.366569 0 0 0.194752 0 0.194752 0.315535 + + + 119810 119262 119810 119810 118861 119262 118567 119810 119262 118567 118872 119810 + 118567 119262 118861 118567 118861 118508 119810 119406 119810 119917 119810 119406 + 119810 118872 119406 119917 119406 118872 119917 119284 119810 119810 119284 119810 + 119917 118500 119284 119810 119284 118500 118567 118485 118872 119917 118872 118485 + 158567 158406 158339 119917 118485 118500 118485 117630 118500 158339 157476 157630 + 117630 119810 118500 117630 118652 119810 119810 119810 118652 119810 118652 117358 + 117630 116456 118652 117358 118652 116456 118475 118508 118861 119230 118508 118475 + 118567 118508 119230 158567 158738 158406 119230 118475 121081 122121 121081 118475 + 119230 121081 121914 119230 121914 119960 122121 123319 121081 121914 121081 123319 + 121914 123319 123228 122163 123319 122121 122163 124787 123319 124787 123228 123319 + 158339 158406 157981 158738 157981 158406 158339 157981 157476 157981 155955 157476 + 119230 119960 117981 117201 117981 119960 117201 119960 121118 117201 117737 117981 + 117981 117737 116023 117201 119578 117737 157630 157476 155955 117630 116023 116456 + 117358 116456 114905 116023 114905 116456 116023 117737 117570 114505 116023 117570 + 116023 114505 114905 114905 114505 112452 121914 121118 119960 121914 123228 121118 + 121482 121118 123228 117201 121118 119578 121482 119578 121118 117570 117737 119578 + 121482 119372 119578 117570 119578 119372 123114 121482 123228 123114 123228 124787 + 123114 119372 121482 116093 119372 123114 117570 114765 114505 117570 119372 114765 + 112452 114505 114765 116093 114765 119372 110000 112452 114765 110000 114765 116093 + + + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + + + 0 6.07431e-37 0 0 7.57283e-13 6.07431e-37 2.52517e-09 0 6.07431e-37 2.52517e-09 1.02146e-09 0 + 2.52517e-09 6.07431e-37 7.57283e-13 2.52517e-09 7.57283e-13 9.49807e-08 0 2.48798e-07 0 6.26162 0 2.48798e-07 + 0 1.02146e-09 2.48798e-07 6.26162 2.48798e-07 1.02146e-09 6.26162 3.06991e-07 0 0 3.06991e-07 0 + 6.26162 8.07888e-09 3.06991e-07 0 3.06991e-07 8.07888e-09 2.52517e-09 0.0814499 1.02146e-09 6.26162 1.02146e-09 0.0814499 + 0 0 0 6.26162 0.0814499 8.07888e-09 0.0814499 4.3809e-17 8.07888e-09 0 0 0 + 4.3809e-17 0 8.07888e-09 4.3809e-17 0 0 0 0 0 0 0 0 + 4.3809e-17 5.94426e-17 0 0 0 5.94426e-17 0.216893 9.49807e-08 7.57283e-13 2.57548 9.49807e-08 0.216893 + 2.52517e-09 9.49807e-08 2.57548 0 0 0 2.57548 0.216893 57.1711 91.861 57.1711 0.216893 + 2.57548 57.1711 158.521 2.57548 158.521 55.3155 91.861 240.434 57.1711 158.521 57.1711 240.434 + 158.521 240.434 335.863 188.214 240.434 91.861 188.214 513.249 240.434 513.249 335.863 240.434 + 0 0 0 0 0 0 0 0 0 0 0 0 + 2.57548 55.3155 0 0 0 55.3155 0 55.3155 183.046 0 12.5193 0 + 0 12.5193 0.00833857 0 150.527 12.5193 0 0 0 4.3809e-17 0.00833857 5.94426e-17 + 0 5.94426e-17 0 0.00833857 0 5.94426e-17 0.00833857 12.5193 68.2198 0.0806038 0.00833857 68.2198 + 0.00833857 0.0806038 0 0 0.0806038 0 158.521 183.046 55.3155 158.521 335.863 183.046 + 292.809 183.046 335.863 0 183.046 150.527 292.809 150.527 183.046 68.2198 12.5193 150.527 + 292.809 243.396 150.527 68.2198 150.527 243.396 506.465 292.809 335.863 506.465 335.863 513.249 + 506.465 243.396 292.809 161.456 243.396 506.465 68.2198 41.4243 0.0806038 68.2198 243.396 41.4243 + 0 0.0806038 41.4243 161.456 41.4243 243.396 0 0 41.4243 0 41.4243 161.456 + + + + + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 + + + + + 0 0 0 0.125 0.125 0 0.25 0 0 0 0 0 + 0 0.25 0 0.125 0.125 0 0.25 0.25 0 0.25 0 0 + 0.125 0.125 0 0.25 0.25 0 0.37664 0.179956 0 0.25 0 0 + 0.25 0.25 0 0.125 0.125 0 0 0.25 0 0.25 0.25 0 + 0 0.25 0 0.125 0.375 0 0.25 0 0 0.402173 0.078821 0 + 0.5 0 0 0.5 0.15 0 0.5 0 0 0.402173 0.078821 0 + 0.25 0 0 0.37664 0.179956 0 0.402173 0.078821 0 0.5 0.15 0 + 0.402173 0.078821 0 0.37664 0.179956 0 0.5 0.15 0 0.597827 0.078821 0 + 0.5 0 0 0.5 0 0 0.597827 0.078821 0 0.75 0 0 + 0.5 0.15 0 0.62336 0.179956 0 0.597827 0.078821 0 0.75 0 0 + 0.597827 0.078821 0 0.62336 0.179956 0 0.25 0.25 0 0.5 0.25 0 + 0.37664 0.179956 0 0.5 0.15 0 0.37664 0.179956 0 0.5 0.25 0 + 0.25 0.25 0 0.375 0.375 0 0.5 0.25 0 0.5 0.15 0 + 0.5 0.25 0 0.62336 0.179956 0 0.5 0.25 0 0.75 0.25 0 + 0.62336 0.179956 0 0.5 0.25 0 0.625 0.375 0 0.75 0.25 0 + 0.75 0.25 0 0.75 0 0 0.62336 0.179956 0 0.75 0.25 0 + 0.875 0.125 0 0.75 0 0 1 0 0 0.75 0 0 + 0.875 0.125 0 1 0 0 0.875 0.125 0 1 0.25 0 + 0.75 0.25 0 0.875 0.375 0 0.875 0.125 0 1 0.25 0 + 0.875 0.125 0 0.875 0.375 0 0 0.5 0 0.125 0.375 0 + 0 0.25 0 0.25 0.5 0 0.125 0.375 0 0 0.5 0 + 0.25 0.25 0 0.125 0.375 0 0.25 0.5 0 0.25 0.25 0 + 0.25 0.5 0 0.375 0.375 0 0.25 0.5 0 0 0.5 0 + 0.1475 0.6475 0 0 0.75 0 0.1475 0.6475 0 0 0.5 0 + 0.25 0.5 0 0.1475 0.6475 0 0.288455 0.708047 0 0.25 0.5 0 + 0.288455 0.708047 0 0.391546 0.602561 0 0 0.75 0 0.154493 0.84607 0 + 0.1475 0.6475 0 0.288455 0.708047 0 0.1475 0.6475 0 0.154493 0.84607 0 + 0.288455 0.708047 0 0.154493 0.84607 0 0.360239 0.86125 0 0 1 0 + 0.154493 0.84607 0 0 0.75 0 0 1 0 0.25 1 0 + 0.154493 0.84607 0 0.25 1 0 0.360239 0.86125 0 0.154493 0.84607 0 + 0.5 0.25 0 0.375 0.375 0 0.5 0.5 0 0.25 0.5 0 + 0.5 0.5 0 0.375 0.375 0 0.5 0.25 0 0.5 0.5 0 + 0.625 0.375 0 0.5 0.5 0 0.75 0.5 0 0.625 0.375 0 + 0.25 0.5 0 0.391546 0.602561 0 0.5 0.5 0 0.5 0.6 0 + 0.5 0.5 0 0.391546 0.602561 0 0.5 0.6 0 0.391546 0.602561 0 + 0.430764 0.712341 0 0.5 0.6 0 0.609787 0.602915 0 0.5 0.5 0 + 0.5 0.5 0 0.609787 0.602915 0 0.75 0.5 0 0.5 0.6 0 + 0.57666 0.710051 0 0.609787 0.602915 0 0.75 0.25 0 0.625 0.375 0 + 0.75 0.5 0 0.75 0.25 0 0.75 0.5 0 0.875 0.375 0 + 1 0.25 0 0.875 0.375 0 1 0.5 0 0.75 0.5 0 + 1 0.5 0 0.875 0.375 0 0.75 0.5 0 0.609787 0.602915 0 + 0.711417 0.719098 0 0.8525 0.6475 0 0.75 0.5 0 0.711417 0.719098 0 + 0.75 0.5 0 0.8525 0.6475 0 1 0.5 0 1 0.5 0 + 0.8525 0.6475 0 1 0.75 0 0.288455 0.708047 0 0.430764 0.712341 0 + 0.391546 0.602561 0 0.288455 0.708047 0 0.360239 0.86125 0 0.430764 0.712341 0 + 0.507497 0.818795 0 0.430764 0.712341 0 0.360239 0.86125 0 0.5 0.6 0 + 0.430764 0.712341 0 0.57666 0.710051 0 0.507497 0.818795 0 0.57666 0.710051 0 + 0.430764 0.712341 0 0.711417 0.719098 0 0.609787 0.602915 0 0.57666 0.710051 0 + 0.507497 0.818795 0 0.646328 0.861801 0 0.57666 0.710051 0 0.711417 0.719098 0 + 0.57666 0.710051 0 0.646328 0.861801 0 0.5 1 0 0.507497 0.818795 0 + 0.360239 0.86125 0 0.5 1 0 0.360239 0.86125 0 0.25 1 0 + 0.5 1 0 0.646328 0.861801 0 0.507497 0.818795 0 0.75 1 0 + 0.646328 0.861801 0 0.5 1 0 0.711417 0.719098 0 0.8525 0.8525 0 + 0.8525 0.6475 0 0.711417 0.719098 0 0.646328 0.861801 0 0.8525 0.8525 0 + 1 0.75 0 0.8525 0.6475 0 0.8525 0.8525 0 0.75 1 0 + 0.8525 0.8525 0 0.646328 0.861801 0 1 1 0 1 0.75 0 + 0.8525 0.8525 0 1 1 0 0.8525 0.8525 0 0.75 1 0 + + + + + 0 1 2 3 4 5 6 7 8 9 10 11 + 12 13 14 15 16 17 18 19 20 21 22 23 + 24 25 26 27 28 29 30 31 32 33 34 35 + 36 37 38 39 40 41 42 43 44 45 46 47 + 48 49 50 51 52 53 54 55 56 57 58 59 + 60 61 62 63 64 65 66 67 68 69 70 71 + 72 73 74 75 76 77 78 79 80 81 82 83 + 84 85 86 87 88 89 90 91 92 93 94 95 + 96 97 98 99 100 101 102 103 104 105 106 107 + 108 109 110 111 112 113 114 115 116 117 118 119 + 120 121 122 123 124 125 126 127 128 129 130 131 + 132 133 134 135 136 137 138 139 140 141 142 143 + 144 145 146 147 148 149 150 151 152 153 154 155 + 156 157 158 159 160 161 162 163 164 165 166 167 + 168 169 170 171 172 173 174 175 176 177 178 179 + 180 181 182 183 184 185 186 187 188 189 190 191 + 192 193 194 195 196 197 198 199 200 201 202 203 + 204 205 206 207 208 209 210 211 212 213 214 215 + 216 217 218 219 220 221 222 223 224 225 226 227 + + + 3 6 9 12 15 18 21 24 27 30 33 36 + 39 42 45 48 51 54 57 60 63 66 69 72 + 75 78 81 84 87 90 93 96 99 102 105 108 + 111 114 117 120 123 126 129 132 135 138 141 144 + 147 150 153 156 159 162 165 168 171 174 177 180 + 183 186 189 192 195 198 201 204 207 210 213 216 + 219 222 225 228 + + + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 5 5 5 5 5 5 5 5 + 5 5 5 5 + + + + + diff --git a/test/references/2pboxdfm_3d_tets-reference.vtu b/test/references/2pboxdfm_3d_tets-reference.vtu new file mode 100644 index 0000000000000000000000000000000000000000..17f598426dbf93913a89be9225beae92d87c4565 --- /dev/null +++ b/test/references/2pboxdfm_3d_tets-reference.vtu @@ -0,0 +1,3011 @@ + + + + + + + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + 0.15 0.15 0.15 0.15 0.15 0.15 0.15 0.15 + + + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000.2 10000 10000.2 10000 10000 10000 10000.4 10000.2 10000 10000 + 10000.2 10000 10000 10000.4 10000 10012.8 10000.2 10000.4 10000.2 10012.8 10000 10000 + 10000 10000 10000 10001.4 10000 10000 10000 10000 10000 10000 10000 10012.8 + 10000 10000 10000 10000 10000 10000 10001.4 10000 10000.4 10000 10000 10001.4 + 10000 10000.4 10000 10012.8 10000.4 10000 10012.8 10001.4 10001.4 10000 10000 10000 + 10000 10012.8 10001.4 10000 10000 10000 10000 10000 10000 10000.2 10000 10000 + 10000 10000.7 10000 10000 10000 10000 10000 10000 10000 10000.7 10000 10000 + 10000.7 10000.2 10000 10000 10000 10000 10000.2 10012.8 10000.7 10000.2 10000 10012.8 + 10000.7 10000 10000 10015.1 10000.7 10000 10015.1 10012.8 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10001.4 10000 10000 10000 10000 10000 10000 10001.4 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10001.4 10000 + 10001.4 10000 10000 10000 10000 10001.4 10000 10000.6 10000 10000 10000 10000.6 + 10001.4 10000 10000 10000.6 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000.6 10000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000.6 10000 10000 10000 10000 10000 10000 10000 10000.6 + 10000 10000.8 10000 10000.6 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000.7 10000 10000 10000 10000 10000 10000 10000 10000.7 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000.4 10000 10000.7 10000 10015.1 + 10000 10000.7 10015.1 10000.4 10000 10000.7 10000 10000 10000 10000 10000 10000.4 + 10000.7 10000 10000 10000.4 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000.4 10000 10000 10000 + 10000.4 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000.4 10000 10000 10000 10000 + 10000 10000 10000.4 10000 10000 10000 10000 10000 10000 10000 10000 10000.4 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 50000 + 50000 50000 50000 50000 50000 50000 50000 50000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000.8 10000 10000 + 10000.8 10000 10000 10000.2 10000 10000 10000 10000.2 10000 10000 10000 10000 + 10000 10000 10000 10000.2 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000.2 10000 10000 10000 10000.2 + 10000 10000 10000 10000 10000 10000 10000 10000.2 10000 10000 10000 10000 + 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000 10000.2 10000 + 10000 10000 10000 10000 10000.2 10000.4 10022.6 10000 10000.4 10000.2 10299 10012.8 + 10000.4 10000.2 10022.6 10299 10000.4 10299 10314.4 10012.8 10022.6 10000.4 10299 10314.4 + 10299 10314.4 10012.8 11200.4 10314.4 10000.4 10012.8 10001.4 10012.8 10000 10001.4 10000 + 10314.4 10012.8 10000 10001.4 10751.1 10314.4 10000 10001.4 10314.4 10000 10012.8 11200.4 + 10314.4 10751.1 10000 11200.4 10000.2 10000.7 10299 10012.8 10299 10012.8 10015.1 11200.4 + 10000.7 10015.1 10590.7 10299 10000.7 10015.1 10299 10012.8 10015.1 10590.7 10299 11200.4 + 10590.7 11200.4 10015.1 10435.2 10030.3 10012.8 10000 11200.4 10015.1 10012.8 10030.3 11200.4 + 10012.8 10030.3 10000 10000 10000 10030.3 10000 10000 10030.3 10000 10000 11200.4 + 10015.1 10030.3 10000 11200.4 10000 10000 10030.3 10000 10000 10030.3 10000 10000 + 10030.3 10000 10000 11200.4 10000 10459.2 10000 11200.4 10015.1 11200.4 10000 10435.2 + 10000 10459.2 10000 11200.4 11037.7 10868.1 10022.6 10299 10868.1 10022.6 10299 10314.4 + 11037.7 10868.1 10050.8 10022.6 10868.1 10299 11037.7 11200.4 10868.1 10314.4 10299 11200.4 + 10868.1 11037.7 13457.7 11200.4 11037.7 10868.1 11423.2 10050.8 10868.1 13457.7 10830.6 10314.4 + 11423.2 10868.1 10830.6 10050.8 10868.1 13457.7 11423.2 10830.6 10802.8 13457.7 11037.7 10299 + 10802.8 11037.7 11423.2 10050.8 10802.8 11037.7 13457.7 11423.2 10868.1 13457.7 11037.7 11423.2 + 13457.7 10830.6 10314.4 10751.1 13457.7 10314.4 10868.1 11200.4 10314.4 13457.7 10751.1 11200.4 + 12713.1 10000 10751.1 11200.4 10658.9 10830.6 12713.1 10751.1 13457.7 12713.1 10751.1 11200.4 + 10830.6 13457.7 12713.1 10751.1 11200.4 11037.7 13457.7 10299 13457.7 10299 12777.2 11200.4 + 12777.2 10802.8 10590.7 10299 12777.2 10299 10590.7 11200.4 12777.2 11200.4 10590.7 10435.2 + 12777.2 13457.7 10802.8 10299 12777.2 10802.8 10707.2 10590.7 12713.1 10459.2 10000 11200.4 + 13304 10459.2 12713.1 11200.4 12777.2 13304 11200.4 10435.2 10000 10459.2 13304 11200.4 + 10000 11200.4 13304 10435.2 13457.7 13304 12713.1 11200.4 13457.7 12777.2 13304 11200.4 + 10149 10000 10001.4 10000.6 10000 10001.4 10000 10000.6 10000 10149 10001.4 10000.6 + 10149 10751.1 10000 10001.4 10751.1 10149 10000 10459.2 10149 10000.6 10000 10459.2 + 10000 10149 10000 10000.6 10000 10149 10000 10000 10000 10000 10000 10000 + 10149 10000 10000 10000.6 10149 10000 10000.6 10459.2 10149 10000 10000 10459.2 + 10149 10000 10000 10000 10001.6 10000 10000 10000.6 10000 10000 10001.6 10000 + 10000 10001.6 10000 10459.2 10000 10000.6 10001.6 10459.2 10001.6 10000 10000 10000 + 10000 10000 10000 10001.6 10000.8 10000 10000 10001.6 10000 10001.6 10000 10459.2 + 10000.8 10001.6 10000.6 10459.2 10000 10001.6 10000.8 10459.2 10000.8 10000.6 10000 10459.2 + 10000 10000 10000 10000.6 10000 10000 10000.8 10000.6 10000 10000 10000 10000.8 + 10000 10000 10000.8 10459.2 12713.1 10380.2 10751.1 10149 10751.1 12713.1 10149 10459.2 + 10751.1 10000 12713.1 10459.2 10459.2 10001.1 10438 10149 12713.1 10438 10149 10459.2 + 10380.2 10658.9 12713.1 10751.1 10438 10380.2 12713.1 10149 10001.1 10149 10000 10000 + 10149 10000 10000 10000 10000 10001.1 10000 10000 10001.1 10000 10149 10459.2 + 10000 10001.1 10438 10459.2 10380.2 10438 10001.1 10149 10380.2 10001.1 10000.5 10000 + 10380.2 10001.1 10438 10000.5 10001.1 10000.5 10000 10000 10000 10438 10001.1 10000.5 + 10438 10000 10000 10000 10000 10000.5 10000 10000 10000.5 10438 10000 10000 + 13304 10438 12713.1 10459.2 10438 13304 10385.1 10459.2 10000 10438 10000 10459.2 + 10438 10000 10000 10459.2 10000 10438 10000 10000 10000 10438 10385.1 10459.2 + 10438 10000 10000 10385.1 10000 10000 10000 10385.1 10002.3 10000.7 10015.1 10590.7 + 10000.7 10002.3 10015.1 10000.4 10002.3 10000.7 10000 10000.4 10015.1 10000.4 10002.3 10435.2 + 10002.3 10590.7 10015.1 10435.2 10015.1 10000 10001.4 10435.2 10001.4 10015.1 10030.3 10000 + 10030.3 10001.4 10000 10000 10000 10001.4 10000 10000 10001.4 10000 10000 10435.2 + 10015.1 10001.4 10000.4 10435.2 10001.4 10000 10000.4 10435.2 10000 10001.4 10000 10000 + 10001.4 10000.4 10000 10000 10001.4 10000 10000 10000 10001.4 10000 10000 10435.2 + 10000.7 10002.3 10000 10000.4 10000 10000 10000 10000 10000 10000.7 10000 10000.4 + 10000 10000.7 10000 10000 10000.7 10002.3 10000 10000 10000.7 10002.3 10000.4 10435.2 + 10002.3 10000.7 10001.3 10435.2 10000.4 10000 10000 10000 10000 10000 10000.7 10000.4 + 10000 10000.7 10000.4 10000 10000.4 10000 10000.7 10435.2 10000.7 10000 10000.5 10435.2 + 10000.7 10000 10000.5 10000 10346.2 10002.3 10549.8 10590.7 10002.3 10549.8 10590.7 10435.2 + 10002.3 10001.3 10549.8 10435.2 10346.2 12777.2 10707.2 10590.7 12777.2 10590.7 10549.8 10435.2 + 12777.2 10346.2 10549.8 10590.7 10000 10310.8 10365.6 10435.2 10365.6 10310.8 13304 10435.2 + 12777.2 10549.8 13304 10435.2 10549.8 10365.6 13304 10435.2 10000.7 10001.2 10001.3 10435.2 + 10001.2 10549.8 10001.3 10435.2 10002.3 10000.7 10000 10001.3 10000.7 10000 10001.3 10001.2 + 10001.3 10000 10000.1 10001.2 10346.2 10002.3 10001.3 10549.8 10346.2 10001.3 10000.6 10549.8 + 10001.3 10346.2 10000.6 10000.1 10001.3 10549.8 10001.2 10000.6 10000.6 10001.3 10000.1 10001.2 + 10000.1 10549.8 10001.2 10000.7 10000.1 10001.2 10549.8 10000.6 10000.1 10000.6 10000.1 10001.2 + 10000.7 10365.6 10549.8 10435.2 10435.2 10001.2 10549.8 10000.7 10365.6 10000.5 10000 10435.2 + 10365.6 10000.7 10000.5 10435.2 10000.7 10000.1 10365.6 10000.5 10000.1 10000.7 10365.6 10549.8 + 10000.1 10365.6 10000.5 10000 10000 10000.8 10000 10000.5 10000 10000 10000 10000.5 + 10000 10000.5 10000 10310.8 10000 10000.8 10000.5 10310.8 10000 10000 10000 10000.5 + 10000 10000 10000.5 10000 10000 10000.5 10000 10000.2 10000 10000 10000.5 10310.8 + 10000.8 10000.2 10000.5 10310.8 10000 10000.5 10000.2 10310.8 10000 10310.8 10000 10435.2 + 10000 10459.2 10000.8 10310.8 10000 10000 10310.8 10435.2 10000 10000 10000.8 10000.2 + 10000 10000 10000 10000.8 10000 10000.2 10000.8 10310.8 10000 10000 10000 10000.2 + 10000 10000.8 10459.2 10310.8 10000 10000 10000.8 10310.8 10000 10000 10000 10000.2 + 10000 10000.1 10000 10000.2 10000 10000 10000.1 10000.2 10000.5 10000 10000.1 10310.8 + 10000.1 10000 10000.2 10310.8 10000.5 10000 10000.1 10000 10000.1 10000 10000 10000.2 + 10000 10000 10000 10000.2 10000 10000 10000 10000 10000 10000 10000 10000 + 10000.1 10000.2 10000 10310.8 10000.1 10000.1 10000 10310.8 10000 10000 10000.1 10000 + 13304 10459.2 10000 10310.8 13304 10310.8 10000 10435.2 10385.1 10459.2 13304 10310.8 + 10385.1 13304 10156.6 10310.8 13304 10365.6 10156.6 10310.8 10000 10459.2 10385.1 10310.8 + 10000 10385.1 10000 10310.8 10000 10385.1 10000 10000 10385.1 10156.6 10000 10310.8 + 10310.8 10000 10156.6 10000 10000 10000 10385.1 10000 10000 10385.1 10156.6 10000 + 10365.6 10000 10000.5 10310.8 10156.6 10000.5 10000.1 10310.8 10000.1 10156.6 10000.1 10310.8 + 10000.5 10000.2 10156.6 10000.1 10365.6 10000.5 10156.6 10310.8 10000.2 10365.6 10000.5 10156.6 + 10365.6 10000.2 10000.5 10000 10000.1 10000 10000 10310.8 10000.1 10000 10156.6 10310.8 + 10000 10000.1 10000.1 10000 10000 10000.1 10000 10000 10000.1 10000 10000 10000 + 10000.1 10156.6 10000 10000 10000 10156.6 10000 10000 10000 10000 10156.6 10000 + 10000 10000 10000 10000 10000.2 10000.1 10156.6 10000.1 10000.1 10000.2 10156.6 10000 + 10000.2 10000.1 10000 10000 10000 10000.1 10000 10000 + + + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 0.999972 1 0.999972 1 1 1 0.999934 0.999972 1 1 + 0.999972 1 1 0.999934 1 0.997904 0.999972 0.999934 0.999972 0.997904 1 1 + 1 1 1 0.999775 1 1 1 1 1 1 1 0.997904 + 1 1 1 1 1 1 0.999775 1 0.999934 1 1 0.999775 + 1 0.999934 1 0.997904 0.999934 1 0.997904 0.999775 0.999775 1 1 1 + 1 0.997904 0.999775 1 1 1 1 1 1 0.999972 1 1 + 1 0.999878 1 1 1 1 1 1 1 0.999878 1 1 + 0.999878 0.999972 1 1 1 1 0.999972 0.997904 0.999878 0.999972 1 0.997904 + 0.999878 1 1 0.997534 0.999878 1 0.997534 0.997904 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 0.999775 1 1 1 1 1 1 0.999775 1 1 + 1 1 1 1 1 0.999997 1 1 0.999997 1 0.999775 1 + 0.999775 1 1 1 1 0.999775 1 0.999907 1 1 0.999997 0.999907 + 0.999775 0.999997 1 0.999907 1 0.999997 1 1 1 1 1 1 + 1 0.999997 1 1 0.999997 1 1 1 1 0.999997 0.999907 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 0.999907 1 1 1 1 1 1 1 0.999907 + 1 0.999872 1 0.999907 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 0.999878 1 1 1 1 1 1 1 0.999878 1 1 1 + 1 1 1 1 1 1 1 0.999927 1 0.999878 1 0.997534 + 1 0.999878 0.997534 0.999927 1 0.999878 1 1 1 1 1 0.999927 + 0.999878 1 1 0.999927 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 0.999927 1 1 1 + 0.999927 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 0.999927 1 1 1 1 + 1 1 0.999927 1 1 1 1 1 1 1 1 0.999927 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 0.999872 1 1 + 0.999872 1 1 0.999972 1 1 1 0.999972 1 1 1 1 + 1 1 1 0.999972 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 0.999972 1 1 1 0.999972 + 1 1 1 1 1 1 1 0.999972 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 0.999972 1 + 1 1 1 1 0.999972 0.999934 0.996301 1 0.999934 0.999972 0.953075 0.997904 + 0.999934 0.999972 0.996301 0.953075 0.999934 0.953075 0.950777 0.997904 0.996301 0.999934 0.953075 0.950777 + 0.953075 0.950777 0.997904 0.833657 0.950777 0.999934 0.997904 0.999775 0.997904 1 0.999775 1 + 0.950777 0.997904 1 0.999775 0.889425 0.950777 1 0.999775 0.950777 1 0.997904 0.833657 + 0.950777 0.889425 1 0.833657 0.999972 0.999878 0.953075 0.997904 0.953075 0.997904 0.997534 0.833657 + 0.999878 0.997534 0.911073 0.953075 0.999878 0.997534 0.953075 0.997904 0.997534 0.911073 0.953075 0.833657 + 0.911073 0.833657 0.997534 0.933033 0.995058 0.997904 1 0.833657 0.997534 0.997904 0.995058 0.833657 + 0.997904 0.995058 1 1 1 0.995058 1 1 0.995058 1 1 0.833657 + 0.997534 0.995058 1 0.833657 1 1 0.995058 1 1 0.995058 1 1 + 0.995058 1 1 0.833657 1 0.929575 1 0.833657 0.997534 0.833657 1 0.933033 + 1 0.929575 1 0.833657 0.853061 0.874235 0.996301 0.953075 0.874235 0.996301 0.953075 0.950777 + 0.853061 0.874235 0.991727 0.996301 0.874235 0.953075 0.853061 0.833657 0.874235 0.950777 0.953075 0.833657 + 0.874235 0.853061 0.632762 0.833657 0.853061 0.874235 0.808407 0.991727 0.874235 0.632762 0.879048 0.950777 + 0.808407 0.874235 0.879048 0.991727 0.874235 0.632762 0.808407 0.879048 0.88266 0.632762 0.853061 0.953075 + 0.88266 0.853061 0.808407 0.991727 0.88266 0.853061 0.632762 0.808407 0.874235 0.632762 0.853061 0.808407 + 0.632762 0.879048 0.950777 0.889425 0.632762 0.950777 0.874235 0.833657 0.950777 0.632762 0.889425 0.833657 + 0.687356 1 0.889425 0.833657 0.901757 0.879048 0.687356 0.889425 0.632762 0.687356 0.889425 0.833657 + 0.879048 0.632762 0.687356 0.889425 0.833657 0.853061 0.632762 0.953075 0.632762 0.953075 0.682278 0.833657 + 0.682278 0.88266 0.911073 0.953075 0.682278 0.953075 0.911073 0.833657 0.682278 0.833657 0.911073 0.933033 + 0.682278 0.632762 0.88266 0.953075 0.682278 0.88266 0.895251 0.911073 0.687356 0.929575 1 0.833657 + 0.643283 0.929575 0.687356 0.833657 0.682278 0.643283 0.833657 0.933033 1 0.929575 0.643283 0.833657 + 1 0.833657 0.643283 0.933033 0.632762 0.643283 0.687356 0.833657 0.632762 0.682278 0.643283 0.833657 + 0.976103 0.999997 0.999775 0.999907 1 0.999775 1 0.999907 1 0.976103 0.999775 0.999907 + 0.976103 0.889425 1 0.999775 0.889425 0.976103 1 0.929575 0.976103 0.999907 1 0.929575 + 0.999997 0.976103 1 0.999907 0.999997 0.976103 1 1 1 0.999997 1 1 + 0.976103 1 1 0.999907 0.976103 1 0.999907 0.929575 0.976103 1 1 0.929575 + 0.976103 1 1 1 0.999744 1 1 0.999907 1 1 0.999744 1 + 1 0.999744 1 0.929575 1 0.999907 0.999744 0.929575 0.999744 1 1 1 + 1 1 1 0.999744 0.999872 1 1 0.999744 1 0.999744 1 0.929575 + 0.999872 0.999744 0.999907 0.929575 1 0.999744 0.999872 0.929575 0.999872 0.999907 1 0.929575 + 1 1 1 0.999907 1 1 0.999872 0.999907 1 1 1 0.999872 + 1 1 0.999872 0.929575 0.687356 0.941025 0.889425 0.976103 0.889425 0.687356 0.976103 0.929575 + 0.889425 1 0.687356 0.929575 0.929575 0.999817 0.93262 0.976103 0.687356 0.93262 0.976103 0.929575 + 0.941025 0.901757 0.687356 0.889425 0.93262 0.941025 0.687356 0.976103 0.999817 0.976103 1 1 + 0.976103 1 1 1 1 0.999817 1 1 0.999817 1 0.976103 0.929575 + 1 0.999817 0.93262 0.929575 0.941025 0.93262 0.999817 0.976103 0.941025 0.999817 0.999917 1 + 0.941025 0.999817 0.93262 0.999917 0.999817 0.999917 1 1 1 0.93262 0.999817 0.999917 + 0.93262 1 1 1 1 0.999917 1 1 0.999917 0.93262 1 1 + 0.643283 0.93262 0.687356 0.929575 0.93262 0.643283 0.940307 0.929575 1 0.93262 1 0.929575 + 0.93262 1 1 0.929575 1 0.93262 1 1 1 0.93262 0.940307 0.929575 + 0.93262 1 1 0.940307 1 1 1 0.940307 0.999619 0.999878 0.997534 0.911073 + 0.999878 0.999619 0.997534 0.999927 0.999619 0.999878 1 0.999927 0.997534 0.999927 0.999619 0.933033 + 0.999619 0.911073 0.997534 0.933033 0.997534 1 0.999778 0.933033 0.999778 0.997534 0.995058 1 + 0.995058 0.999778 1 1 1 0.999778 1 1 0.999778 1 1 0.933033 + 0.997534 0.999778 0.999927 0.933033 0.999778 1 0.999927 0.933033 1 0.999778 1 1 + 0.999778 0.999927 1 1 0.999778 1 1 1 0.999778 1 1 0.933033 + 0.999879 0.999619 1 0.999927 1 1 1 1 1 0.999879 1 0.999927 + 1 0.999879 1 1 0.999879 0.999619 1 1 0.999879 0.999619 0.999927 0.933033 + 0.999619 0.999879 0.999784 0.933033 0.999927 1 1 1 1 1 0.999879 0.999927 + 1 0.999879 0.999927 1 0.999927 1 0.999879 0.933033 0.999879 1 0.999916 0.933033 + 0.999879 1 0.999916 1 0.946045 0.999619 0.916756 0.911073 0.999619 0.916756 0.911073 0.933033 + 0.999619 0.999784 0.916756 0.933033 0.946045 0.682278 0.895251 0.911073 0.682278 0.911073 0.916756 0.933033 + 0.682278 0.946045 0.916756 0.911073 1 0.951304 0.943172 0.933033 0.943172 0.951304 0.643283 0.933033 + 0.682278 0.916756 0.643283 0.933033 0.916756 0.943172 0.643283 0.933033 0.999879 0.99981 0.999784 0.933033 + 0.99981 0.916756 0.999784 0.933033 0.999619 0.999879 1 0.999784 0.999879 1 0.999784 0.99981 + 0.999784 1 0.999984 0.99981 0.946045 0.999619 0.999784 0.916756 0.946045 0.999784 0.999906 0.916756 + 0.999784 0.946045 0.999906 0.999984 0.999784 0.916756 0.99981 0.999906 0.999906 0.999784 0.999984 0.99981 + 0.999985 0.916756 0.99981 0.999879 0.999985 0.99981 0.916756 0.999906 0.999985 0.999906 0.999984 0.99981 + 0.999879 0.943172 0.916756 0.933033 0.933033 0.99981 0.916756 0.999879 0.943172 0.999916 1 0.933033 + 0.943172 0.999879 0.999916 0.933033 0.999879 0.999985 0.943172 0.999916 0.999985 0.999879 0.943172 0.916756 + 0.999985 0.943172 0.999916 0.999999 1 0.999872 1 0.999921 1 1 1 0.999921 + 1 0.999921 1 0.951304 1 0.999872 0.999921 0.951304 1 1 1 0.999921 + 1 1 0.999921 1 1 0.999921 1 0.999972 1 1 0.999921 0.951304 + 0.999872 0.999972 0.999921 0.951304 1 0.999921 0.999972 0.951304 1 0.951304 1 0.933033 + 1 0.929575 0.999872 0.951304 1 1 0.951304 0.933033 1 1 0.999872 0.999972 + 1 1 1 0.999872 1 0.999972 0.999872 0.951304 1 1 1 0.999972 + 1 0.999872 0.929575 0.951304 1 1 0.999872 0.951304 1 1 1 0.999972 + 1 0.999977 1 0.999972 1 1 0.999977 0.999972 0.999916 1 0.999977 0.951304 + 0.999977 1 0.999972 0.951304 0.999916 1 0.999977 1 0.999977 1 1 0.999972 + 1 1 1 0.999972 1 1 1 1 1 1 1 1 + 0.999977 0.999972 1 0.951304 0.999989 0.999977 1 0.951304 1 1 0.999977 1 + 0.643283 0.929575 1 0.951304 0.643283 0.951304 1 0.933033 0.940307 0.929575 0.643283 0.951304 + 0.940307 0.643283 0.974915 0.951304 0.643283 0.943172 0.974915 0.951304 1 0.929575 0.940307 0.951304 + 1 0.940307 1 0.951304 1 0.940307 1 1 0.940307 0.974915 1 0.951304 + 0.951304 1 0.974915 1 1 1 0.940307 1 1 0.940307 0.974915 1 + 0.943172 1 0.999916 0.951304 0.974915 0.999916 0.999977 0.951304 0.999989 0.974915 0.999977 0.951304 + 0.999916 0.999971 0.974915 0.999977 0.943172 0.999916 0.974915 0.951304 0.999971 0.943172 0.999916 0.974915 + 0.943172 0.999971 0.999916 0.999999 0.999989 1 1 0.951304 0.999989 1 0.974915 0.951304 + 1 0.999989 0.999977 1 1 0.999989 1 1 0.999989 1 1 1 + 0.999989 0.974915 1 1 1 0.974915 1 1 1 1 0.974915 1 + 1 1 1 1 0.999971 0.999989 0.974915 0.999977 0.999989 0.999971 0.974915 1 + 0.999971 0.999989 1 1 1 0.999989 1 1 + + + 108226 109810 108226 109810 109810 108226 109810 109810 109810 108226 109810 107522 + 109810 109810 108226 109810 109810 109810 108226 107522 109810 109810 109810 107522 + 109810 109810 109810 107522 108226 108226 109810 107490 108226 108226 107490 107522 + 109810 108226 107117 107522 108226 107490 107117 107522 108226 109810 107130 107522 + 107490 108226 107130 107522 109810 108226 108226 107522 109810 109810 109810 108504 + 109810 109810 107649 108504 109810 109810 107522 108504 109810 109810 109810 108504 + 109810 107117 107649 108504 107117 109810 107522 108504 107117 107649 108504 107589 + 107522 107117 108504 107589 109810 109810 107522 109810 107649 109810 109810 109810 + 107130 109810 109810 107522 109810 109810 107130 107649 107130 107486 109810 107649 + 109810 107486 107130 107522 109810 109810 109810 108504 108536 109810 107534 109810 + 108536 109810 109810 109810 108536 108504 109810 109810 109810 107534 107522 108504 + 107522 109810 107534 109810 108504 107534 108536 109810 107534 107522 108504 107589 + 108065 107534 108504 107589 107534 108536 109810 107486 107534 109810 107522 107486 + 108504 108536 107534 108065 107589 107593 108065 107534 107534 108536 107593 108065 + 107117 107490 105440 107522 105440 107490 107130 107522 105399 105440 107490 105443 + 105440 107490 107117 105399 107117 105413 105440 105399 105440 105413 107117 107522 + 106439 107117 107649 105182 106439 107117 107522 107589 107117 106439 107522 105413 + 107117 106439 107649 107589 107649 106439 105182 107589 105399 107117 106439 105182 + 107117 105399 106439 105413 105399 106439 105413 105182 105182 106439 105145 107589 + 106439 105413 105182 105145 107130 106450 107522 107486 107522 105440 106450 107130 + 107649 105360 107130 106450 107130 107649 106450 107486 107649 105360 106450 107486 + 105360 105440 107130 106450 107522 106450 105440 105413 105360 105440 106450 105413 + 105360 106450 107486 105339 105360 106450 105339 105413 107534 106439 106450 107522 + 107534 106439 107522 107589 106369 107534 106439 106450 107534 106369 106439 107589 + 106450 107534 107522 107486 107534 106450 107522 107486 107589 107593 107534 106369 + 106369 107534 107522 107593 106369 107534 106450 107522 106439 106450 107522 105413 + 106450 106439 105298 105413 106439 106369 105145 107589 106439 106369 106450 105298 + 106439 105298 105413 105145 106439 106369 105298 105145 106450 107522 105339 105298 + 105339 106450 105298 105413 106450 106369 107522 105298 106369 107522 105298 105144 + 105145 105144 106369 105298 109810 109810 109810 108504 109810 109810 107649 108504 + 109810 109810 109810 108504 109810 109810 108504 107432 107649 109810 108504 107006 + 108504 107649 107006 107589 107006 108504 107589 107432 109810 108504 107006 107432 + 109810 109810 108226 109810 109810 108226 109810 107432 108226 109810 109810 108226 + 109810 109810 109810 107432 109810 109810 107432 109810 109810 109810 109810 108226 + 107432 109810 109810 108226 109810 107006 108226 107432 107006 107358 108226 107432 + 107358 109810 108226 108226 107358 108226 107432 108226 108226 109810 107432 108226 + 106949 107432 109810 108226 106949 107358 107432 108226 109810 109810 109810 108504 + 108536 109810 109810 109810 108504 108536 109810 109810 108536 109810 107496 109810 + 108504 108536 107496 109810 108504 107496 107589 107432 107496 108065 108504 107589 + 109810 107496 108504 107432 107432 107496 109810 109810 108504 107496 108536 108065 + 107593 107496 107589 108065 107593 108536 107496 108065 107430 108536 109810 107496 + 107432 109810 107496 107430 109810 109810 107432 109810 109810 107649 107432 109810 + 107649 109810 109810 109810 107649 106949 107432 109810 107649 107430 109810 107432 + 107006 107649 105182 106339 107006 107649 106339 107589 107649 105182 106339 107589 + 106339 107006 107589 107432 107432 105048 106339 107006 105048 107006 105182 106339 + 105182 105145 106339 107589 105145 105182 106339 105063 107432 106339 105048 105063 + 105182 105048 106339 105063 107006 105048 107358 107432 106949 107358 104905 107432 + 107358 105048 104905 107432 105048 104905 107358 104905 104905 105048 105063 107432 + 106369 107496 106339 107589 107496 106339 107589 107432 106369 106229 106339 107496 + 107496 106229 106339 107432 107496 107593 107589 106369 107495 106369 107593 107496 + 107430 106229 107496 107432 106369 107495 107430 107496 106369 107430 106229 107496 + 105145 106369 106339 107589 106369 105138 105145 106339 106339 106229 105063 107432 + 106229 106369 106339 105138 105138 105145 106339 105063 106229 105138 106339 105063 + 105144 105138 105145 106369 106369 106222 105144 105138 107430 106369 106229 105138 + 106222 106369 107430 105138 106222 107430 106229 105138 106229 105071 105138 105063 + 105071 106222 106229 105138 106229 107432 107649 106949 104905 107432 106229 106949 + 107649 107432 106229 107430 104905 107649 106949 106229 104905 107430 107649 106229 + 106229 107432 104905 105063 106949 104905 106229 104905 104905 106229 104905 105063 + 104905 105071 106229 105063 107649 109810 109810 109810 107649 109810 109810 109810 + 109810 107486 107649 109810 109810 109810 107649 107495 107649 107486 109810 107495 + 109810 107649 107495 107096 109810 108536 109810 107522 108536 109810 109810 109810 + 108504 108536 109810 109810 109810 109810 108504 109810 109810 108536 107522 107486 + 109810 109810 107522 107486 108536 107534 107522 107486 107534 108536 107522 107593 + 108536 107522 107593 108064 107522 109810 107495 108504 109810 107522 107495 107486 + 108536 107522 108504 109810 108536 108504 107522 108064 107522 107588 107593 108064 + 107495 107522 108504 107588 107522 108504 107588 108064 108226 109810 109810 109810 + 108226 109810 109810 107495 109810 109810 109810 107495 109810 109810 109810 107495 + 108226 109810 108293 109810 109810 109810 108293 109810 109810 108293 109810 107495 + 108226 109810 107495 107096 107358 108226 107495 107096 108293 108226 109810 107495 + 107358 108226 109810 108293 107358 108226 108293 107495 109810 107061 108293 107495 + 107061 107358 108293 107495 109810 109810 107495 108504 109810 109810 109810 108504 + 109810 109810 109810 108504 109810 109810 107649 108504 107061 107495 108504 107588 + 109810 107061 107495 108504 107061 109810 107649 108504 107649 107061 108504 107588 + 105360 107649 107096 106397 107495 106397 107649 107486 105360 107649 106397 107486 + 107495 107649 106397 107096 107495 107096 106397 105262 106397 105360 107486 105339 + 106397 105360 105339 105262 107096 105360 106397 105274 106397 107096 105274 105262 + 105360 106397 105274 105262 106450 107522 107486 105339 107522 106397 107486 105339 + 106369 107522 105144 107593 107522 106369 105144 107593 107495 107522 106397 107486 + 107522 106389 107495 106397 107588 107522 107593 106369 106389 107522 107495 107588 + 107522 106389 106369 107588 107522 106397 105339 105252 105339 107522 105252 105298 + 105252 107522 106369 105144 107522 105252 105298 105144 107522 106389 106397 105252 + 106389 107495 106397 105262 106397 105339 105252 105262 106389 106397 105252 105262 + 107522 106389 105252 106369 107588 105143 106389 106369 105252 105143 105144 106369 + 105252 106389 105262 105143 106389 105252 106369 105143 107358 105199 107096 107495 + 107358 107061 105199 107495 107358 107096 105199 105274 105262 105199 107096 105274 + 105262 107096 105199 107495 105219 107358 105199 105274 107061 106389 107495 107588 + 107495 105199 106389 107061 106389 107061 107649 107588 105107 106389 107649 107588 + 106389 107061 105107 107649 107495 106389 105199 105262 107588 105143 105107 106389 + 106389 105107 105262 105143 107061 106389 105107 105199 106389 105107 105199 105262 + 109810 108536 109810 109810 108536 108504 109810 109810 107495 108536 109810 109810 + 108504 109810 109810 109810 108536 107495 107593 107496 107495 108536 107593 108064 + 108536 107495 107430 109810 107495 108536 107430 107496 109810 107427 107495 107430 + 108536 108504 107495 109810 108536 107495 108504 108064 107593 107588 107495 108064 + 108504 107495 107588 108064 107495 108504 107588 107427 109810 107495 107427 109810 + 108504 107495 109810 107427 109810 107649 109810 109810 107649 107427 109810 109810 + 107427 109810 109810 109810 107649 107430 107427 109810 106949 107649 107427 109810 + 109810 109810 108504 109810 109810 108504 109810 107427 109810 109810 109810 108504 + 109810 109810 107649 108504 108504 106993 107588 107427 109810 106993 107649 108504 + 106993 107649 108504 107588 109810 106993 108504 107427 109810 109810 107427 109810 + 109810 109810 109810 107427 109810 109810 108226 109810 109810 108226 107427 109810 + 109810 109810 108226 109810 108226 109810 109810 107427 109810 108226 109810 108226 + 108226 109810 108226 107427 108226 106949 107427 109810 106949 107358 108226 107427 + 106993 109810 108226 107427 106993 108226 107358 107427 108226 109810 107358 108226 + 107358 108226 108226 107427 106369 105144 107495 107593 105144 106369 107495 107593 + 106222 106369 107495 107430 107593 107588 106369 107495 106369 106321 107495 107588 + 107495 106222 107430 107427 106321 107495 107588 107427 106222 106369 106321 107495 + 106321 106222 107495 107427 106222 106369 105144 107495 106369 106222 105144 107495 + 106222 106369 105144 105124 106222 105071 105144 105138 105071 106222 105144 105124 + 107588 105143 106369 106321 105144 105143 105124 106369 106369 105124 106321 105143 + 106222 106369 105124 106321 106222 106321 105040 107427 105071 106222 105124 105040 + 105124 106321 105143 105040 105124 106222 106321 105040 107427 107649 106222 107430 + 104905 106222 107430 106229 106222 104905 107430 107649 106949 104905 106222 107649 + 107427 106222 107649 106949 107427 104905 106222 106949 104905 105071 106222 106229 + 105071 104905 106222 105040 107427 106222 104905 105040 104905 104905 106949 106222 + 104905 104905 106222 105040 106993 106321 107588 107427 106993 106321 107649 107588 + 106321 105107 107649 107588 106321 105107 106993 107649 105009 107427 106321 106993 + 105143 107588 105107 106321 106321 105107 105143 105040 106321 107427 105009 105040 + 105107 105009 106321 106993 105009 105107 106321 105040 106949 104905 107358 107427 + 105009 106993 107358 107427 104905 105009 107358 107427 105009 104905 105040 107427 + 104905 105009 104905 107358 105440 105399 103524 105443 105399 105440 103888 105413 + 105399 105440 103524 103888 105399 103888 103828 105413 103524 105399 103888 103828 + 103888 103828 105413 103678 103828 105399 105413 105182 105413 104167 105182 105145 + 103828 105413 104167 105182 103093 103828 104167 105182 103828 104167 105413 103678 + 103828 103093 104167 103678 105440 105360 103888 105413 103888 105413 105339 103678 + 105360 105339 103267 103888 105360 105339 103888 105413 105339 103267 103888 103678 + 103267 103678 105339 103362 105298 105413 104167 103678 105339 105413 105298 103678 + 105413 105298 104167 105145 104167 105298 104654 105145 105298 104167 104654 103678 + 105339 105298 104164 103678 105145 105144 105298 104654 104654 105298 104164 105144 + 105298 104654 104164 103678 104167 103153 104654 103678 105339 103678 104164 103362 + 104654 103153 104164 103678 102941 102934 103524 103888 102934 103524 103888 103828 + 102941 102934 101439 103524 102934 103888 102941 103678 102934 103828 103888 103678 + 102934 102941 101950 103678 102941 102934 101747 101439 102934 101950 101658 103828 + 101747 102934 101658 101439 102934 101950 101747 101658 101644 101950 102941 103888 + 101644 102941 101747 101439 101644 102941 101950 101747 102934 101950 102941 101747 + 101950 101658 103828 103093 101950 103828 102934 103678 103828 101950 103093 103678 + 101605 104167 103093 103678 101269 101658 101605 103093 101950 101605 103093 103678 + 101658 101950 101605 103093 103678 102941 101950 103888 101950 103888 101628 103678 + 101628 101644 103267 103888 101628 103888 103267 103678 101628 103678 103267 103362 + 101628 101950 101644 103888 101628 101644 101390 103267 101605 103153 104167 103678 + 101463 103153 101605 103678 101628 101463 103678 103362 104164 103153 101463 103678 + 104164 103678 101463 103362 101950 101463 101605 103678 101950 101628 101463 103678 + 103169 105048 105182 105063 104167 105182 105145 105063 104167 103169 105182 105063 + 103169 103093 104167 105182 103093 103169 104167 103153 103169 105063 104167 103153 + 105048 103169 104905 105063 105048 103169 102452 104905 104905 105048 102452 104905 + 103169 102861 104905 105063 103169 102861 105063 103153 103169 101584 102861 103153 + 103169 102861 102452 104905 105138 104167 105145 105063 104167 104654 105138 105145 + 104167 105138 104654 103153 104167 105063 105138 103153 105138 105144 105145 104654 + 104164 104654 105144 105138 105071 104164 105144 105138 104654 105138 104164 103153 + 105071 105138 105063 103153 104164 105138 105071 103153 105071 105063 102861 103153 + 102861 104905 104905 105063 104905 102861 105071 105063 102861 102161 104905 105071 + 102861 102161 105071 103153 101605 100484 103093 103169 103093 101605 103169 103153 + 103093 104167 101605 103153 103153 101784 100658 103169 101605 100658 103169 103153 + 100484 101269 101605 103093 100658 100484 101605 103169 101784 103169 101584 102452 + 103169 102861 101584 102452 100000 101784 101584 102452 101784 101584 103169 103153 + 101584 101784 100658 103153 100484 100658 101784 103169 100484 101784 100315 100000 + 100484 101784 100658 100315 101784 100315 100000 101584 101584 100658 101784 100315 + 100658 102861 100000 101584 100000 100315 100000 101584 100315 100658 100000 101584 + 101463 100658 101605 103153 100658 101463 100460 103153 102861 100658 102161 103153 + 100658 102861 101584 103153 102861 100658 100000 102161 102161 100658 100460 103153 + 100658 100000 102161 100460 102161 100000 100000 100460 103496 105360 105339 103267 + 105360 103496 105339 105262 103496 105360 105274 105262 105339 105262 103496 103362 + 103496 103267 105339 103362 105339 104164 105252 103362 105252 105339 105298 104164 + 105298 105252 104164 105144 104164 105252 104653 105144 105252 104164 104653 103362 + 105339 105252 105262 103362 105252 104164 105262 103362 105143 105252 105144 104653 + 105252 105262 104164 105143 105252 104164 104653 105143 105252 104653 104164 103362 + 103289 103496 105274 105262 105219 105199 102987 105274 105199 103289 105274 105262 + 105199 103289 102987 105274 103289 103496 102987 105274 103289 103496 105262 103362 + 103496 103289 102241 103362 105262 105107 104164 105143 105199 105107 103289 105262 + 105107 103289 105262 104164 105262 104164 103289 103362 103289 104164 102522 103362 + 103289 105107 102522 104164 100811 103496 100993 103267 103496 100993 103267 103362 + 103496 102241 100993 103362 100811 101628 101390 103267 101628 103267 100993 103362 + 101628 100811 100993 103267 104164 103052 100722 103362 100722 103052 101463 103362 + 101628 100993 101463 103362 100993 100722 101463 103362 103289 102141 102241 103362 + 102141 100993 102241 103362 103496 103289 102987 102241 103289 102987 102241 102141 + 102241 102987 100660 102141 100811 103496 102241 100993 100811 102241 100775 100993 + 102241 100811 100775 100660 102241 100993 102141 100775 100775 102241 100660 102141 + 100655 100993 102141 103289 100655 102141 100993 100775 100655 100775 100660 102141 + 103289 100722 100993 103362 103362 102141 100993 103289 100722 102522 104164 103362 + 100722 103289 102522 103362 103289 100655 100722 102522 100655 103289 100722 100993 + 100655 100722 102522 100510 104164 105071 105144 105124 104653 104164 105144 105124 + 104164 105124 104653 103052 104164 105071 105124 103052 105144 105143 104653 105124 + 104653 104164 105124 105143 104164 105124 105143 105040 104164 104653 105124 103052 + 105071 105040 105124 103052 104164 105124 105040 103052 104164 103052 104653 103362 + 104164 103153 105071 103052 104164 104653 103052 103362 102861 104905 105071 105040 + 102161 102861 104905 105071 102861 105040 105071 103052 102861 104905 104905 105040 + 102161 105071 103153 103052 102161 102861 105071 103052 105107 104164 105143 105040 + 105107 103062 104164 105040 105107 105009 103062 105040 102522 104164 103062 103052 + 103062 104164 105040 103052 102522 105107 103062 104164 103062 105009 102861 105040 + 105009 104905 102861 105040 104905 102452 105009 102861 102452 104905 105009 104905 + 103062 105040 102861 103052 101708 103062 102861 103052 105009 102452 103062 102861 + 101463 103153 104164 103052 101463 103052 104164 103362 100460 103153 101463 103052 + 100460 101463 100431 103052 101463 100722 100431 103052 102161 103153 100460 103052 + 102161 100460 102861 103052 102161 100460 100000 102861 100460 100431 102861 103052 + 103052 101491 100431 102861 100000 102161 100460 100000 100000 100460 100431 102861 + 100722 104164 102522 103052 100431 102522 103062 103052 101708 100431 103062 103052 + 102522 100237 100431 103062 100722 102522 100431 103052 100237 100722 102522 100431 + 100722 100237 102522 100510 101708 102861 101491 103052 101708 101491 100431 103052 + 102452 101708 103062 102861 101491 101708 102452 102861 101708 100000 101491 102452 + 101708 100431 101491 100205 100000 100431 101491 102861 100000 101491 100431 100205 + 100000 100000 101491 100205 100237 101708 100431 103062 101708 100237 100431 100205 + 100237 101708 100000 100205 100000 101708 101491 100205 + + + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 + + + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 999.863 1000 999.863 1000 1000 1000 999.679 999.863 1000 1000 + 999.863 1000 1000 999.679 1000 989.813 999.863 999.679 999.863 989.813 1000 1000 + 1000 1000 1000 998.902 1000 1000 1000 1000 1000 1000 1000 989.813 + 1000 1000 1000 1000 1000 1000 998.902 1000 999.679 1000 1000 998.902 + 1000 999.679 1000 989.813 999.679 1000 989.813 998.902 998.902 1000 1000 1000 + 1000 989.813 998.902 1000 1000 1000 1000 1000 1000 999.863 1000 1000 + 1000 999.405 1000 1000 1000 1000 1000 1000 1000 999.405 1000 1000 + 999.405 999.863 1000 1000 1000 1000 999.863 989.813 999.405 999.863 1000 989.813 + 999.405 1000 1000 988.025 999.405 1000 988.025 989.813 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 998.902 1000 1000 1000 1000 1000 1000 998.902 1000 1000 + 1000 1000 1000 1000 1000 999.987 1000 1000 999.987 1000 998.902 1000 + 998.902 1000 1000 1000 1000 998.902 1000 999.546 1000 1000 999.987 999.546 + 998.902 999.987 1000 999.546 1000 999.987 1000 1000 1000 1000 1000 1000 + 1000 999.987 1000 1000 999.987 1000 1000 1000 1000 999.987 999.546 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 999.546 1000 1000 1000 1000 1000 1000 1000 999.546 + 1000 999.375 1000 999.546 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 999.405 1000 1000 1000 1000 1000 1000 1000 999.405 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 999.642 1000 999.405 1000 988.025 + 1000 999.405 988.025 999.642 1000 999.405 1000 1000 1000 1000 1000 999.642 + 999.405 1000 1000 999.642 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 999.642 1000 1000 1000 + 999.642 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 999.642 1000 1000 1000 1000 + 1000 1000 999.642 1000 1000 1000 1000 1000 1000 1000 1000 999.642 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 999.375 1000 1000 + 999.375 1000 1000 999.864 1000 1000 1000 999.864 1000 1000 1000 1000 + 1000 1000 1000 999.864 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 999.864 1000 1000 1000 999.864 + 1000 1000 1000 1000 1000 1000 1000 999.864 1000 1000 1000 1000 + 1000 1000 1000 1000 1000 1000 1000 1000 1000 1000 999.864 1000 + 1000 1000 1000 1000 999.863 999.679 982.079 1000 999.679 999.863 790.007 989.813 + 999.679 999.863 982.079 790.007 999.679 790.007 780.657 989.813 982.079 999.679 790.007 780.657 + 790.007 780.657 989.813 403.779 780.657 999.679 989.813 998.902 989.813 1000 998.902 1000 + 780.657 989.813 1000 998.902 560.234 780.657 1000 998.902 780.657 1000 989.813 403.779 + 780.657 560.234 1000 403.779 999.863 999.405 790.007 989.813 790.007 989.813 988.025 403.779 + 999.405 988.025 631.811 790.007 999.405 988.025 790.007 989.813 988.025 631.811 790.007 403.779 + 631.811 403.779 988.025 711.214 976.109 989.813 1000 403.779 988.025 989.813 976.109 403.779 + 989.813 976.109 1000 1000 1000 976.109 1000 1000 976.109 1000 1000 403.779 + 988.025 976.109 1000 403.779 1000 1000 976.109 1000 1000 976.109 1000 1000 + 976.109 1000 1000 403.779 1000 698.24 1000 403.779 988.025 403.779 1000 711.214 + 1000 698.24 1000 403.779 453.902 513.773 982.079 790.007 513.773 982.079 790.007 780.657 + 453.902 513.773 960.253 982.079 513.773 790.007 453.902 403.779 513.773 780.657 790.007 403.779 + 513.773 453.902 92.9451 403.779 453.902 513.773 344.912 960.253 513.773 92.9451 528.17 780.657 + 344.912 513.773 528.17 960.253 513.773 92.9451 344.912 528.17 539.168 92.9451 453.902 790.007 + 539.168 453.902 344.912 960.253 539.168 453.902 92.9451 344.912 513.773 92.9451 453.902 344.912 + 92.9451 528.17 780.657 560.234 92.9451 780.657 513.773 403.779 780.657 92.9451 560.234 403.779 + 146.553 1000 560.234 403.779 600.218 528.17 146.553 560.234 92.9451 146.553 560.234 403.779 + 528.17 92.9451 146.553 560.234 403.779 453.902 92.9451 790.007 92.9451 790.007 140.774 403.779 + 140.774 539.168 631.811 790.007 140.774 790.007 631.811 403.779 140.774 403.779 631.811 711.214 + 140.774 92.9451 539.168 790.007 140.774 539.168 578.866 631.811 146.553 698.24 1000 403.779 + 101.89 698.24 146.553 403.779 140.774 101.89 403.779 711.214 1000 698.24 101.89 403.779 + 1000 403.779 101.89 711.214 92.9451 101.89 146.553 403.779 92.9451 140.774 101.89 403.779 + 888.427 999.987 998.902 999.546 1000 998.902 1000 999.546 1000 888.427 998.902 999.546 + 888.427 560.234 1000 998.902 560.234 888.427 1000 698.24 888.427 999.546 1000 698.24 + 999.987 888.427 1000 999.546 999.987 888.427 1000 1000 1000 999.987 1000 1000 + 888.427 1000 1000 999.546 888.427 1000 999.546 698.24 888.427 1000 1000 698.24 + 888.427 1000 1000 1000 998.75 1000 1000 999.546 1000 1000 998.75 1000 + 1000 998.75 1000 698.24 1000 999.546 998.75 698.24 998.75 1000 1000 1000 + 1000 1000 1000 998.75 999.375 1000 1000 998.75 1000 998.75 1000 698.24 + 999.375 998.75 999.546 698.24 1000 998.75 999.375 698.24 999.375 999.546 1000 698.24 + 1000 1000 1000 999.546 1000 1000 999.375 999.546 1000 1000 1000 999.375 + 1000 1000 999.375 698.24 146.553 741.891 560.234 888.427 560.234 146.553 888.427 698.24 + 560.234 1000 146.553 698.24 698.24 999.107 709.657 888.427 146.553 709.657 888.427 698.24 + 741.891 600.218 146.553 560.234 709.657 741.891 146.553 888.427 999.107 888.427 1000 1000 + 888.427 1000 1000 1000 1000 999.107 1000 1000 999.107 1000 888.427 698.24 + 1000 999.107 709.657 698.24 741.891 709.657 999.107 888.427 741.891 999.107 999.594 1000 + 741.891 999.107 709.657 999.594 999.107 999.594 1000 1000 1000 709.657 999.107 999.594 + 709.657 1000 1000 1000 1000 999.594 1000 1000 999.594 709.657 1000 1000 + 101.89 709.657 146.553 698.24 709.657 101.89 739.096 698.24 1000 709.657 1000 698.24 + 709.657 1000 1000 698.24 1000 709.657 1000 1000 1000 709.657 739.096 698.24 + 709.657 1000 1000 739.096 1000 1000 1000 739.096 998.142 999.405 988.025 631.811 + 999.405 998.142 988.025 999.642 998.142 999.405 1000 999.642 988.025 999.642 998.142 711.214 + 998.142 631.811 988.025 711.214 988.025 1000 998.919 711.214 998.919 988.025 976.109 1000 + 976.109 998.919 1000 1000 1000 998.919 1000 1000 998.919 1000 1000 711.214 + 988.025 998.919 999.642 711.214 998.919 1000 999.642 711.214 1000 998.919 1000 1000 + 998.919 999.642 1000 1000 998.919 1000 1000 1000 998.919 1000 1000 711.214 + 999.409 998.142 1000 999.642 1000 1000 1000 1000 1000 999.409 1000 999.642 + 1000 999.409 1000 1000 999.409 998.142 1000 1000 999.409 998.142 999.642 711.214 + 998.142 999.409 998.948 711.214 999.642 1000 1000 1000 1000 1000 999.409 999.642 + 1000 999.409 999.642 1000 999.642 1000 999.409 711.214 999.409 1000 999.59 711.214 + 999.409 1000 999.59 1000 761.663 998.142 651.689 631.811 998.142 651.689 631.811 711.214 + 998.142 998.948 651.689 711.214 761.663 140.774 578.866 631.811 140.774 631.811 651.689 711.214 + 140.774 761.663 651.689 631.811 1000 782.795 750.299 711.214 750.299 782.795 101.89 711.214 + 140.774 651.689 101.89 711.214 651.689 750.299 101.89 711.214 999.409 999.073 998.948 711.214 + 999.073 651.689 998.948 711.214 998.142 999.409 1000 998.948 999.409 1000 998.948 999.073 + 998.948 1000 999.924 999.073 761.663 998.142 998.948 651.689 761.663 998.948 999.541 651.689 + 998.948 761.663 999.541 999.924 998.948 651.689 999.073 999.541 999.541 998.948 999.924 999.073 + 999.926 651.689 999.073 999.409 999.926 999.073 651.689 999.541 999.926 999.541 999.924 999.073 + 999.409 750.299 651.689 711.214 711.214 999.073 651.689 999.409 750.299 999.59 1000 711.214 + 750.299 999.409 999.59 711.214 999.409 999.926 750.299 999.59 999.926 999.409 750.299 651.689 + 999.926 750.299 999.59 999.994 1000 999.375 1000 999.613 1000 1000 1000 999.613 + 1000 999.613 1000 782.795 1000 999.375 999.613 782.795 1000 1000 1000 999.613 + 1000 1000 999.613 1000 1000 999.613 1000 999.864 1000 1000 999.613 782.795 + 999.375 999.864 999.613 782.795 1000 999.613 999.864 782.795 1000 782.795 1000 711.214 + 1000 698.24 999.375 782.795 1000 1000 782.795 711.214 1000 1000 999.375 999.864 + 1000 1000 1000 999.375 1000 999.864 999.375 782.795 1000 1000 1000 999.864 + 1000 999.375 698.24 782.795 1000 1000 999.375 782.795 1000 1000 1000 999.864 + 1000 999.888 1000 999.864 1000 1000 999.888 999.864 999.59 1000 999.888 782.795 + 999.888 1000 999.864 782.795 999.59 1000 999.888 1000 999.888 1000 1000 999.864 + 1000 1000 1000 999.864 1000 1000 1000 1000 1000 1000 1000 1000 + 999.888 999.864 1000 782.795 999.946 999.888 1000 782.795 1000 1000 999.888 1000 + 101.89 698.24 1000 782.795 101.89 782.795 1000 711.214 739.096 698.24 101.89 782.795 + 739.096 101.89 883.135 782.795 101.89 750.299 883.135 782.795 1000 698.24 739.096 782.795 + 1000 739.096 1000 782.795 1000 739.096 1000 1000 739.096 883.135 1000 782.795 + 782.795 1000 883.135 1000 1000 1000 739.096 1000 1000 739.096 883.135 1000 + 750.299 1000 999.59 782.795 883.135 999.59 999.888 782.795 999.946 883.135 999.888 782.795 + 999.59 999.858 883.135 999.888 750.299 999.59 883.135 782.795 999.858 750.299 999.59 883.135 + 750.299 999.858 999.59 999.994 999.946 1000 1000 782.795 999.946 1000 883.135 782.795 + 1000 999.946 999.888 1000 1000 999.946 1000 1000 999.946 1000 1000 1000 + 999.946 883.135 1000 1000 1000 883.135 1000 1000 1000 1000 883.135 1000 + 1000 1000 1000 1000 999.858 999.946 883.135 999.888 999.946 999.858 883.135 1000 + 999.858 999.946 1000 1000 1000 999.946 1000 1000 + + + 0 0 0 0 0 0 0 0 0 0 0 3.29259e-10 + 0 0 0 0 0 0 0 3.29259e-10 0 0 0 3.29259e-10 + 0 0 0 3.29259e-10 0 0 0 1.70586e-14 0 0 1.70586e-14 3.29259e-10 + 0 0 4.22744e-10 3.29259e-10 0 1.70586e-14 4.22744e-10 3.29259e-10 0 0 6.31175e-14 3.29259e-10 + 1.70586e-14 0 6.31175e-14 3.29259e-10 0 0 0 3.29259e-10 0 0 0 0 + 0 0 0 0 0 0 3.29259e-10 0 0 0 0 0 + 0 4.22744e-10 0 0 4.22744e-10 0 3.29259e-10 0 4.22744e-10 0 0 0 + 3.29259e-10 4.22744e-10 0 0 0 0 3.29259e-10 0 0 0 0 0 + 6.31175e-14 0 0 3.29259e-10 0 0 6.31175e-14 0 6.31175e-14 5.07764e-10 0 0 + 0 5.07764e-10 6.31175e-14 3.29259e-10 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 3.29259e-10 0 + 3.29259e-10 0 0 0 0 0 0 0 0 3.29259e-10 0 0 + 0 0 0 0 0 0 0 5.07764e-10 0 0 3.29259e-10 5.07764e-10 + 0 0 0 0 0 0 0 0 0 0 0 0 + 4.22744e-10 1.70586e-14 2.80521e-05 3.29259e-10 2.80521e-05 1.70586e-14 6.31175e-14 3.29259e-10 6.57621e-05 2.80521e-05 1.70586e-14 9.95143e-09 + 2.80521e-05 1.70586e-14 4.22744e-10 6.57621e-05 4.22744e-10 0.00209633 2.80521e-05 6.57621e-05 2.80521e-05 0.00209633 4.22744e-10 3.29259e-10 + 1.14194e-09 4.22744e-10 0 0.000225198 1.14194e-09 4.22744e-10 3.29259e-10 0 4.22744e-10 1.14194e-09 3.29259e-10 0.00209633 + 4.22744e-10 1.14194e-09 0 0 0 1.14194e-09 0.000225198 0 6.57621e-05 4.22744e-10 1.14194e-09 0.000225198 + 4.22744e-10 6.57621e-05 1.14194e-09 0.00209633 6.57621e-05 1.14194e-09 0.00209633 0.000225198 0.000225198 1.14194e-09 0 0 + 1.14194e-09 0.00209633 0.000225198 0 6.31175e-14 1.94835e-09 3.29259e-10 5.07764e-10 3.29259e-10 2.80521e-05 1.94835e-09 6.31175e-14 + 0 0.000122032 6.31175e-14 1.94835e-09 6.31175e-14 0 1.94835e-09 5.07764e-10 0 0.000122032 1.94835e-09 5.07764e-10 + 0.000122032 2.80521e-05 6.31175e-14 1.94835e-09 3.29259e-10 1.94835e-09 2.80521e-05 0.00209633 0.000122032 2.80521e-05 1.94835e-09 0.00209633 + 0.000122032 1.94835e-09 5.07764e-10 0.00246593 0.000122032 1.94835e-09 0.00246593 0.00209633 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 1.77636e-14 0 0 0 4.43657e-13 + 0 0 4.43657e-13 0 4.43657e-13 0 0 1.77636e-14 0 0 4.43657e-13 1.77636e-14 + 0 0 0 0 0 0 0 1.77636e-14 0 0 0 0 + 0 0 0 1.77636e-14 0 0 1.77636e-14 0 0 0 0 0 + 1.77636e-14 0 0 0 0 4.43657e-13 0 1.77636e-14 4.43657e-13 0 0 1.77636e-14 + 0 0 0 0 0 0 1.77636e-14 0 0 0 1.77636e-14 0 + 0 1.77636e-14 0 0 0 0 1.77636e-14 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 1.77636e-14 0 0 0 0 + 0 0 0 1.77636e-14 1.77636e-14 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 1.77636e-14 0 0 0 0 0 1.77636e-14 0 0 0 1.77636e-14 0 + 0 0 0 0 0 0 1.77636e-14 0 0 0 0 1.77636e-14 + 4.43657e-13 0 0.000225198 1.23557e-12 4.43657e-13 0 1.23557e-12 0 0 0.000225198 1.23557e-12 0 + 1.23557e-12 4.43657e-13 0 1.77636e-14 1.77636e-14 2.74158e-06 1.23557e-12 4.43657e-13 2.74158e-06 4.43657e-13 0.000225198 1.23557e-12 + 0.000225198 0 1.23557e-12 0 0 0.000225198 1.23557e-12 9.30127e-05 1.77636e-14 1.23557e-12 2.74158e-06 9.30127e-05 + 0.000225198 2.74158e-06 1.23557e-12 9.30127e-05 4.43657e-13 2.74158e-06 0 1.77636e-14 0 0 0 1.77636e-14 + 0 2.74158e-06 0 1.77636e-14 2.74158e-06 0 0 0 0 2.74158e-06 9.30127e-05 1.77636e-14 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 1.9329e-13 1.77636e-14 0 0 0 1.77636e-14 1.9329e-13 0 + 0 1.77636e-14 1.9329e-13 0 0 0 0 1.9329e-13 0 0 0 1.9329e-13 + 1.9329e-13 1.77636e-14 0 9.30127e-05 0 0 1.9329e-13 0 0 1.9329e-13 0 9.30127e-05 + 0 0.000128076 1.9329e-13 9.30127e-05 0 0 0 0 0 0 0 0 + 0 5.07764e-10 0 0 0 0 0 1.15463e-14 0 5.07764e-10 0 1.15463e-14 + 0 0 1.15463e-14 7.94704e-14 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 5.07764e-10 + 0 0 0 5.07764e-10 0 0 0 5.07764e-10 0 0 0 0 + 0 0 0 0 0 0 1.15463e-14 0 0 0 1.15463e-14 5.07764e-10 + 0 0 0 0 0 0 0 0 0 0 0 0 + 1.15463e-14 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 1.15463e-14 0 0 0 1.15463e-14 0 0 0 1.15463e-14 + 0 0 0 0 0 0 0 0 0 0 0 1.15463e-14 + 0 0 1.15463e-14 7.94704e-14 0 0 1.15463e-14 7.94704e-14 0 0 0 1.15463e-14 + 0 0 0 0 0 0 0 1.15463e-14 0 -1.69806e-37 0 1.15463e-14 + -1.69806e-37 0 0 1.15463e-14 0 0 1.15463e-14 0 0 0 0 0 + 0 0 0 0 0 0 0 0 -1.69806e-37 1.15463e-14 0 0 + 0 -1.69806e-37 1.15463e-14 0 -1.69806e-37 0 0 0 0 -1.69806e-37 0 0 + 0.000122032 0 7.94704e-14 8.5049e-10 1.15463e-14 8.5049e-10 0 5.07764e-10 0.000122032 0 8.5049e-10 5.07764e-10 + 1.15463e-14 0 8.5049e-10 7.94704e-14 1.15463e-14 7.94704e-14 8.5049e-10 7.34978e-05 8.5049e-10 0.000122032 5.07764e-10 0.00246593 + 8.5049e-10 0.000122032 0.00246593 7.34978e-05 7.94704e-14 0.000122032 8.5049e-10 5.07155e-12 8.5049e-10 7.94704e-14 5.07155e-12 7.34978e-05 + 0.000122032 8.5049e-10 5.07155e-12 7.34978e-05 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1.37299e-13 7.94704e-14 1.15463e-14 + 0 -1.69806e-37 1.37299e-13 1.15463e-14 0 7.94704e-14 1.37299e-13 5.07155e-12 7.34978e-05 1.37299e-13 7.94704e-14 5.07155e-12 + 7.34978e-05 7.94704e-14 1.37299e-13 1.15463e-14 5.59701e-36 0 1.37299e-13 5.07155e-12 -1.69806e-37 3.67484e-14 1.15463e-14 0 + 1.15463e-14 1.37299e-13 3.67484e-14 -1.69806e-37 3.67484e-14 -1.69806e-37 0 0 9.30149e-14 3.67484e-14 0 0 + 3.67484e-14 -1.69806e-37 9.30149e-14 0 1.15463e-14 3.67484e-14 1.37299e-13 7.34978e-05 0 0 9.30149e-14 3.67484e-14 + 3.67484e-14 9.30149e-14 7.34978e-05 0 -1.69806e-37 3.67484e-14 9.30149e-14 1.37299e-13 3.67484e-14 9.30149e-14 1.37299e-13 7.34978e-05 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 6.66134e-16 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 6.66134e-16 0 0 6.66134e-16 0 + 0 0 0 6.66134e-16 0 0 0 0 0 6.66134e-16 0 0 + 6.66134e-16 0 0 0 0 0 6.66134e-16 0 0 0 6.66134e-16 0 + 0 0 0 0 0 0 0 6.66134e-16 0 0 0 0 + 0 0 0 0 0 -1.60189e-38 0 6.66134e-16 0 -1.60189e-38 0 0 + -1.60189e-38 0 0 0 0 -1.60189e-38 0 6.66134e-16 0 0 6.66134e-16 0 + 0 0 0 6.66134e-16 0 0 0 0 0 0 6.66134e-16 0 + 0 0 0 0 0 0 0 6.66134e-16 0 0 0 0 + 0 0 0 6.66134e-16 0 0 6.66134e-16 0 0 0 0 6.66134e-16 + -1.60189e-38 0 0 6.66134e-16 -1.60189e-38 0 0 6.66134e-16 0 0 0 0 + 0 0 0 6.66134e-16 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 6.66134e-16 0 1.28453e-13 0 + 0 1.28453e-13 0 1.9329e-13 1.28453e-13 0 0 0 0 0 1.28453e-13 0 + 6.66134e-16 1.28453e-13 0 0 6.66134e-16 0 1.28453e-13 0 0 0.000128076 1.28453e-13 1.9329e-13 + 0.000128076 0 1.28453e-13 2.79397e-05 6.66134e-16 1.28453e-13 0 2.79397e-05 0 0 0 1.28453e-13 + 0 0 1.28453e-13 2.79397e-05 -1.60189e-38 1.77636e-15 0 6.66134e-16 -1.60189e-38 1.77636e-15 0 0 + 1.77636e-15 9.30149e-14 0 0 1.77636e-15 9.30149e-14 -1.60189e-38 0 1.84935e-15 6.66134e-16 1.77636e-15 -1.60189e-38 + 0 0 9.30149e-14 1.77636e-15 1.77636e-15 9.30149e-14 0 2.79397e-05 1.77636e-15 6.66134e-16 1.84935e-15 2.79397e-05 + 9.30149e-14 1.84935e-15 1.77636e-15 -1.60189e-38 1.84935e-15 9.30149e-14 1.77636e-15 2.79397e-05 0 0 0 6.66134e-16 + 1.84935e-15 -1.60189e-38 0 6.66134e-16 0 1.84935e-15 0 6.66134e-16 1.84935e-15 0 2.79397e-05 6.66134e-16 + 0 1.84935e-15 0 0 2.80521e-05 6.57621e-05 0.00369868 9.95143e-09 6.57621e-05 2.80521e-05 0.0469252 0.00209633 + 6.57621e-05 2.80521e-05 0.00369868 0.0469252 6.57621e-05 0.0469252 0.0492227 0.00209633 0.00369868 6.57621e-05 0.0469252 0.0492227 + 0.0469252 0.0492227 0.00209633 0.166343 0.0492227 6.57621e-05 0.00209633 0.000225198 0.00209633 0 0.000225198 0 + 0.0492227 0.00209633 0 0.000225198 0.110575 0.0492227 0 0.000225198 0.0492227 0 0.00209633 0.166343 + 0.0492227 0.110575 0 0.166343 2.80521e-05 0.000122032 0.0469252 0.00209633 0.0469252 0.00209633 0.00246593 0.166343 + 0.000122032 0.00246593 0.0889272 0.0469252 0.000122032 0.00246593 0.0469252 0.00209633 0.00246593 0.0889272 0.0469252 0.166343 + 0.0889272 0.166343 0.00246593 0.0669671 0.00494207 0.00209633 0 0.166343 0.00246593 0.00209633 0.00494207 0.166343 + 0.00209633 0.00494207 0 0 0 0.00494207 0 0 0.00494207 0 0 0.166343 + 0.00246593 0.00494207 0 0.166343 0 0 0.00494207 0 0 0.00494207 0 0 + 0.00494207 0 0 0.166343 0 0.0704251 0 0.166343 0.00246593 0.166343 0 0.0669671 + 0 0.0704251 0 0.166343 0.146939 0.125765 0.00369868 0.0469252 0.125765 0.00369868 0.0469252 0.0492227 + 0.146939 0.125765 0.00827255 0.00369868 0.125765 0.0469252 0.146939 0.166343 0.125765 0.0492227 0.0469252 0.166343 + 0.125765 0.146939 0.367238 0.166343 0.146939 0.125765 0.191593 0.00827255 0.125765 0.367238 0.120952 0.0492227 + 0.191593 0.125765 0.120952 0.00827255 0.125765 0.367238 0.191593 0.120952 0.11734 0.367238 0.146939 0.0469252 + 0.11734 0.146939 0.191593 0.00827255 0.11734 0.146939 0.367238 0.191593 0.125765 0.367238 0.146939 0.191593 + 0.367238 0.120952 0.0492227 0.110575 0.367238 0.0492227 0.125765 0.166343 0.0492227 0.367238 0.110575 0.166343 + 0.312644 0 0.110575 0.166343 0.0982427 0.120952 0.312644 0.110575 0.367238 0.312644 0.110575 0.166343 + 0.120952 0.367238 0.312644 0.110575 0.166343 0.146939 0.367238 0.0469252 0.367238 0.0469252 0.317722 0.166343 + 0.317722 0.11734 0.0889272 0.0469252 0.317722 0.0469252 0.0889272 0.166343 0.317722 0.166343 0.0889272 0.0669671 + 0.317722 0.367238 0.11734 0.0469252 0.317722 0.11734 0.104749 0.0889272 0.312644 0.0704251 0 0.166343 + 0.356717 0.0704251 0.312644 0.166343 0.317722 0.356717 0.166343 0.0669671 0 0.0704251 0.356717 0.166343 + 0 0.166343 0.356717 0.0669671 0.367238 0.356717 0.312644 0.166343 0.367238 0.317722 0.356717 0.166343 + 0.0238969 2.74158e-06 0.000225198 9.30127e-05 0 0.000225198 0 9.30127e-05 0 0.0238969 0.000225198 9.30127e-05 + 0.0238969 0.110575 0 0.000225198 0.110575 0.0238969 0 0.0704251 0.0238969 9.30127e-05 0 0.0704251 + 2.74158e-06 0.0238969 0 9.30127e-05 2.74158e-06 0.0238969 0 0 0 2.74158e-06 0 0 + 0.0238969 0 0 9.30127e-05 0.0238969 0 9.30127e-05 0.0704251 0.0238969 0 0 0.0704251 + 0.0238969 0 0 0 0.000256306 0 0 9.30127e-05 0 0 0.000256306 0 + 0 0.000256306 0 0.0704251 0 9.30127e-05 0.000256306 0.0704251 0.000256306 0 0 0 + 0 0 0 0.000256306 0.000128076 0 0 0.000256306 0 0.000256306 0 0.0704251 + 0.000128076 0.000256306 9.30127e-05 0.0704251 0 0.000256306 0.000128076 0.0704251 0.000128076 9.30127e-05 0 0.0704251 + 0 0 0 9.30127e-05 0 0 0.000128076 9.30127e-05 0 0 0 0.000128076 + 0 0 0.000128076 0.0704251 0.312644 0.0589752 0.110575 0.0238969 0.110575 0.312644 0.0238969 0.0704251 + 0.110575 0 0.312644 0.0704251 0.0704251 0.000183164 0.0673795 0.0238969 0.312644 0.0673795 0.0238969 0.0704251 + 0.0589752 0.0982427 0.312644 0.110575 0.0673795 0.0589752 0.312644 0.0238969 0.000183164 0.0238969 0 0 + 0.0238969 0 0 0 0 0.000183164 0 0 0.000183164 0 0.0238969 0.0704251 + 0 0.000183164 0.0673795 0.0704251 0.0589752 0.0673795 0.000183164 0.0238969 0.0589752 0.000183164 8.33492e-05 0 + 0.0589752 0.000183164 0.0673795 8.33492e-05 0.000183164 8.33492e-05 0 0 0 0.0673795 0.000183164 8.33492e-05 + 0.0673795 0 0 0 0 8.33492e-05 0 0 8.33492e-05 0.0673795 0 0 + 0.356717 0.0673795 0.312644 0.0704251 0.0673795 0.356717 0.0596928 0.0704251 0 0.0673795 0 0.0704251 + 0.0673795 0 0 0.0704251 0 0.0673795 0 0 0 0.0673795 0.0596928 0.0704251 + 0.0673795 0 0 0.0596928 0 0 0 0.0596928 0.000381188 0.000122032 0.00246593 0.0889272 + 0.000122032 0.000381188 0.00246593 7.34978e-05 0.000381188 0.000122032 5.07155e-12 7.34978e-05 0.00246593 7.34978e-05 0.000381188 0.0669671 + 0.000381188 0.0889272 0.00246593 0.0669671 0.00246593 0 0.000221771 0.0669671 0.000221771 0.00246593 0.00494207 0 + 0.00494207 0.000221771 0 0 0 0.000221771 0 0 0.000221771 0 0 0.0669671 + 0.00246593 0.000221771 7.34978e-05 0.0669671 0.000221771 0 7.34978e-05 0.0669671 0 0.000221771 0 0 + 0.000221771 7.34978e-05 0 0 0.000221771 0 0 0 0.000221771 0 0 0.0669671 + 0.000121082 0.000381188 5.07155e-12 7.34978e-05 5.59701e-36 1.37299e-13 2.67526e-12 5.07155e-12 1.37299e-13 0.000121082 5.07155e-12 7.34978e-05 + 1.37299e-13 0.000121082 2.67526e-12 5.07155e-12 0.000121082 0.000381188 2.67526e-12 5.07155e-12 0.000121082 0.000381188 7.34978e-05 0.0669671 + 0.000381188 0.000121082 0.000215738 0.0669671 7.34978e-05 9.30149e-14 0 0 1.37299e-13 9.30149e-14 0.000121082 7.34978e-05 + 9.30149e-14 0.000121082 7.34978e-05 0 7.34978e-05 0 0.000121082 0.0669671 0.000121082 0 8.41314e-05 0.0669671 + 0.000121082 9.30149e-14 8.41314e-05 0 0.0539545 0.000381188 0.0832436 0.0889272 0.000381188 0.0832436 0.0889272 0.0669671 + 0.000381188 0.000215738 0.0832436 0.0669671 0.0539545 0.317722 0.104749 0.0889272 0.317722 0.0889272 0.0832436 0.0669671 + 0.317722 0.0539545 0.0832436 0.0889272 0 0.0486956 0.0568279 0.0669671 0.0568279 0.0486956 0.356717 0.0669671 + 0.317722 0.0832436 0.356717 0.0669671 0.0832436 0.0568279 0.356717 0.0669671 0.000121082 0.000190162 0.000215738 0.0669671 + 0.000190162 0.0832436 0.000215738 0.0669671 0.000381188 0.000121082 2.67526e-12 0.000215738 0.000121082 2.67526e-12 0.000215738 0.000190162 + 0.000215738 2.67526e-12 1.56068e-05 0.000190162 0.0539545 0.000381188 0.000215738 0.0832436 0.0539545 0.000215738 9.41005e-05 0.0832436 + 0.000215738 0.0539545 9.41005e-05 1.56068e-05 0.000215738 0.0832436 0.000190162 9.41005e-05 9.41005e-05 0.000215738 1.56068e-05 0.000190162 + 1.52696e-05 0.0832436 0.000190162 0.000121082 1.52696e-05 0.000190162 0.0832436 9.41005e-05 1.52696e-05 9.41005e-05 1.56068e-05 0.000190162 + 0.000121082 0.0568279 0.0832436 0.0669671 0.0669671 0.000190162 0.0832436 0.000121082 0.0568279 8.41314e-05 0 0.0669671 + 0.0568279 0.000121082 8.41314e-05 0.0669671 0.000121082 1.52696e-05 0.0568279 8.41314e-05 1.52696e-05 0.000121082 0.0568279 0.0832436 + 1.52696e-05 0.0568279 8.41314e-05 1.25864e-06 0 0.000128076 0 7.92922e-05 0 0 0 7.92922e-05 + 0 7.92922e-05 0 0.0486956 0 0.000128076 7.92922e-05 0.0486956 0 0 0 7.92922e-05 + 0 0 7.92922e-05 0 0 7.92922e-05 0 2.79397e-05 0 0 7.92922e-05 0.0486956 + 0.000128076 2.79397e-05 7.92922e-05 0.0486956 0 7.92922e-05 2.79397e-05 0.0486956 0 0.0486956 0 0.0669671 + 0 0.0704251 0.000128076 0.0486956 0 0 0.0486956 0.0669671 0 0 0.000128076 2.79397e-05 + 0 0 0 0.000128076 0 2.79397e-05 0.000128076 0.0486956 0 0 0 2.79397e-05 + 0 0.000128076 0.0704251 0.0486956 0 0 0.000128076 0.0486956 9.30149e-14 0 0 2.79397e-05 + 9.30149e-14 2.29974e-05 0 2.79397e-05 9.30149e-14 1.84935e-15 2.29974e-05 2.79397e-05 8.41314e-05 0 2.29974e-05 0.0486956 + 2.29974e-05 0 2.79397e-05 0.0486956 8.41314e-05 9.30149e-14 2.29974e-05 0 2.29974e-05 1.84935e-15 0 2.79397e-05 + 1.84935e-15 0 0 2.79397e-05 0 0 1.84935e-15 0 0 0 1.84935e-15 0 + 2.29974e-05 2.79397e-05 0 0.0486956 1.11179e-05 2.29974e-05 0 0.0486956 1.84935e-15 0 2.29974e-05 0 + 0.356717 0.0704251 0 0.0486956 0.356717 0.0486956 0 0.0669671 0.0596928 0.0704251 0.356717 0.0486956 + 0.0596928 0.356717 0.0250851 0.0486956 0.356717 0.0568279 0.0250851 0.0486956 0 0.0704251 0.0596928 0.0486956 + 0 0.0596928 0 0.0486956 0 0.0596928 0 0 0.0596928 0.0250851 0 0.0486956 + 0.0486956 0 0.0250851 0 0 0 0.0596928 0 0 0.0596928 0.0250851 0 + 0.0568279 0 8.41314e-05 0.0486956 0.0250851 8.41314e-05 2.29974e-05 0.0486956 1.11179e-05 0.0250851 2.29974e-05 0.0486956 + 8.41314e-05 2.91793e-05 0.0250851 2.29974e-05 0.0568279 8.41314e-05 0.0250851 0.0486956 2.91793e-05 0.0568279 8.41314e-05 0.0250851 + 0.0568279 2.91793e-05 8.41314e-05 1.25864e-06 1.11179e-05 0 0 0.0486956 1.11179e-05 0 0.0250851 0.0486956 + 0 1.11179e-05 2.29974e-05 0 0 1.11179e-05 0 0 1.11179e-05 0 0 0 + 1.11179e-05 0.0250851 0 9.02857e-16 0 0.0250851 0 0 0 0 0.0250851 9.02857e-16 + 0 0 0 9.02857e-16 2.91793e-05 1.11179e-05 0.0250851 2.29974e-05 1.11179e-05 2.91793e-05 0.0250851 9.02857e-16 + 2.91793e-05 1.11179e-05 0 9.02857e-16 0 1.11179e-05 0 9.02857e-16 + + + 118226 119810 118226 119810 119810 118226 119810 119810 119810 118226 119810 117522 + 119810 119810 118226 119810 119810 119810 118226 117522 119810 119810 119810 117522 + 119810 119810 119810 117522 118226 118226 119810 117490 118226 118226 117490 117522 + 119810 118226 117117 117522 118226 117490 117117 117522 118226 119810 117130 117522 + 117490 118226 117130 117522 119810 118226 118226 117522 119810 119810 119810 118504 + 119810 119810 117649 118504 119810 119810 117522 118504 119810 119810 119810 118504 + 119810 117117 117649 118504 117117 119810 117522 118504 117117 117649 118504 117589 + 117522 117117 118504 117589 119810 119810 117522 119810 117649 119810 119810 119810 + 117130 119810 119810 117522 119810 119810 117130 117649 117130 117486 119810 117649 + 119810 117486 117130 117522 119810 119810 119810 118504 118536 119810 117534 119810 + 118536 119810 119810 119810 118536 118504 119810 119810 119810 117534 117522 118504 + 117522 119810 117534 119810 118504 117534 118536 119810 117534 117522 118504 117589 + 118065 117534 118504 117589 117534 118536 119810 117486 117534 119810 117522 117486 + 118504 118536 117534 118065 117589 117593 118065 117534 117534 118536 117593 118065 + 117117 117490 115440 117522 115440 117490 117130 117522 115400 115440 117490 115443 + 115440 117490 117117 115400 117117 115425 115440 115400 115440 115425 117117 117522 + 116439 117117 117649 115183 116439 117117 117522 117589 117117 116439 117522 115425 + 117117 116439 117649 117589 117649 116439 115183 117589 115400 117117 116439 115183 + 117117 115400 116439 115425 115400 116439 115425 115183 115183 116439 115145 117589 + 116439 115425 115183 115145 117130 116450 117522 117486 117522 115440 116450 117130 + 117649 115361 117130 116450 117130 117649 116450 117486 117649 115361 116450 117486 + 115361 115440 117130 116450 117522 116450 115440 115425 115361 115440 116450 115425 + 115361 116450 117486 115354 115361 116450 115354 115425 157534 156439 156450 157522 + 157534 156439 157522 157589 156369 157534 156439 156450 157534 156369 156439 157589 + 156450 157534 157522 157486 157534 156450 157522 157486 157589 157593 157534 156369 + 156369 157534 157522 157593 156369 157534 156450 157522 156439 156450 157522 155413 + 156450 156439 155298 155413 156439 156369 155145 157589 156439 156369 156450 155298 + 156439 155298 155413 155145 156439 156369 155298 155145 156450 157522 155339 155298 + 155339 156450 155298 155413 156450 156369 157522 155298 156369 157522 155298 155144 + 155145 155144 156369 155298 119810 119810 119810 118504 119810 119810 117649 118504 + 119810 119810 119810 118504 119810 119810 118504 117432 117649 119810 118504 117006 + 118504 117649 117006 117589 117006 118504 117589 117432 119810 118504 117006 117432 + 119810 119810 118226 119810 119810 118226 119810 117432 118226 119810 119810 118226 + 119810 119810 119810 117432 119810 119810 117432 119810 119810 119810 119810 118226 + 117432 119810 119810 118226 119810 117006 118226 117432 117006 117358 118226 117432 + 117358 119810 118226 118226 117358 118226 117432 118226 118226 119810 117432 118226 + 116949 117432 119810 118226 116949 117358 117432 118226 119810 119810 119810 118504 + 118536 119810 119810 119810 118504 118536 119810 119810 118536 119810 117496 119810 + 118504 118536 117496 119810 118504 117496 117589 117432 117496 118065 118504 117589 + 119810 117496 118504 117432 117432 117496 119810 119810 118504 117496 118536 118065 + 117593 117496 117589 118065 117593 118536 117496 118065 117430 118536 119810 117496 + 117432 119810 117496 117430 119810 119810 117432 119810 119810 117649 117432 119810 + 117649 119810 119810 119810 117649 116949 117432 119810 117649 117430 119810 117432 + 117006 117649 115183 116339 117006 117649 116339 117589 117649 115183 116339 117589 + 116339 117006 117589 117432 117432 115048 116339 117006 115048 117006 115183 116339 + 115183 115145 116339 117589 115145 115183 116339 115064 117432 116339 115048 115064 + 115183 115048 116339 115064 117006 115048 117358 117432 116949 117358 114905 117432 + 117358 115048 114905 117432 115048 114905 117358 114905 114905 115048 115064 117432 + 156369 157496 156339 157589 157496 156339 157589 157432 156369 156229 156339 157496 + 157496 156229 156339 157432 157496 157593 157589 156369 157495 156369 157593 157496 + 157430 156229 157496 157432 156369 157495 157430 157496 156369 157430 156229 157496 + 155145 156369 156339 157589 156369 155138 155145 156339 156339 156229 155063 157432 + 156229 156369 156339 155138 155138 155145 156339 155063 156229 155138 156339 155063 + 155144 155138 155145 156369 156369 156222 155144 155138 157430 156369 156229 155138 + 156222 156369 157430 155138 156222 157430 156229 155138 156229 155071 155138 155063 + 155071 156222 156229 155138 116229 117432 117649 116949 114905 117432 116229 116949 + 117649 117432 116229 117430 114905 117649 116949 116229 114905 117430 117649 116229 + 116229 117432 114905 115064 116949 114905 116229 114905 114905 116229 114905 115064 + 114905 115072 116229 115064 117649 119810 119810 119810 117649 119810 119810 119810 + 119810 117486 117649 119810 119810 119810 117649 117495 117649 117486 119810 117495 + 119810 117649 117495 117096 119810 118536 119810 117522 118536 119810 119810 119810 + 118504 118536 119810 119810 119810 119810 118504 119810 119810 118536 117522 117486 + 119810 119810 117522 117486 118536 117534 117522 117486 117534 118536 117522 117593 + 118536 117522 117593 118064 117522 119810 117495 118504 119810 117522 117495 117486 + 118536 117522 118504 119810 118536 118504 117522 118064 117522 117588 117593 118064 + 117495 117522 118504 117588 117522 118504 117588 118064 118226 119810 119810 119810 + 118226 119810 119810 117495 119810 119810 119810 117495 119810 119810 119810 117495 + 118226 119810 118293 119810 119810 119810 118293 119810 119810 118293 119810 117495 + 118226 119810 117495 117096 117358 118226 117495 117096 118293 118226 119810 117495 + 117358 118226 119810 118293 117358 118226 118293 117495 119810 117061 118293 117495 + 117061 117358 118293 117495 119810 119810 117495 118504 119810 119810 119810 118504 + 119810 119810 119810 118504 119810 119810 117649 118504 117061 117495 118504 117588 + 119810 117061 117495 118504 117061 119810 117649 118504 117649 117061 118504 117588 + 115361 117649 117096 116397 117495 116397 117649 117486 115361 117649 116397 117486 + 117495 117649 116397 117096 117495 117096 116397 115263 116397 115361 117486 115354 + 116397 115361 115354 115263 117096 115361 116397 115274 116397 117096 115274 115263 + 115361 116397 115274 115263 156450 157522 157486 155339 157522 156397 157486 155339 + 156369 157522 155144 157593 157522 156369 155144 157593 157495 157522 156397 157486 + 157522 156389 157495 156397 157588 157522 157593 156369 156389 157522 157495 157588 + 157522 156389 156369 157588 157522 156397 155339 155252 155339 157522 155252 155298 + 155252 157522 156369 155144 157522 155252 155298 155144 157522 156389 156397 155252 + 156389 157495 156397 155262 156397 155339 155252 155262 156389 156397 155252 155262 + 157522 156389 155252 156369 157588 155143 156389 156369 155252 155143 155144 156369 + 155252 156389 155262 155143 156389 155252 156369 155143 117358 115199 117096 117495 + 117358 117061 115199 117495 117358 117096 115199 115274 115263 115199 117096 115274 + 115263 117096 115199 117495 115219 117358 115199 115274 117061 116389 117495 117588 + 117495 115199 116389 117061 116389 117061 117649 117588 115107 116389 117649 117588 + 116389 117061 115107 117649 117495 116389 115199 115263 117588 115143 115107 116389 + 116389 115107 115263 115143 117061 116389 115107 115199 116389 115107 115199 115263 + 119810 118536 119810 119810 118536 118504 119810 119810 117495 118536 119810 119810 + 118504 119810 119810 119810 118536 117495 117593 117496 117495 118536 117593 118064 + 118536 117495 117430 119810 117495 118536 117430 117496 119810 117427 117495 117430 + 118536 118504 117495 119810 118536 117495 118504 118064 117593 117588 117495 118064 + 118504 117495 117588 118064 117495 118504 117588 117427 119810 117495 117427 119810 + 118504 117495 119810 117427 119810 117649 119810 119810 117649 117427 119810 119810 + 117427 119810 119810 119810 117649 117430 117427 119810 116949 117649 117427 119810 + 119810 119810 118504 119810 119810 118504 119810 117427 119810 119810 119810 118504 + 119810 119810 117649 118504 118504 116993 117588 117427 119810 116993 117649 118504 + 116993 117649 118504 117588 119810 116993 118504 117427 119810 119810 117427 119810 + 119810 119810 119810 117427 119810 119810 118226 119810 119810 118226 117427 119810 + 119810 119810 118226 119810 118226 119810 119810 117427 119810 118226 119810 118226 + 118226 119810 118226 117427 118226 116949 117427 119810 116949 117358 118226 117427 + 116993 119810 118226 117427 116993 118226 117358 117427 118226 119810 117358 118226 + 117358 118226 118226 117427 156369 155144 157495 157593 155144 156369 157495 157593 + 156222 156369 157495 157430 157593 157588 156369 157495 156369 156321 157495 157588 + 157495 156222 157430 157427 156321 157495 157588 157427 156222 156369 156321 157495 + 156321 156222 157495 157427 156222 156369 155144 157495 156369 156222 155144 157495 + 156222 156369 155144 155124 156222 155071 155144 155138 155071 156222 155144 155124 + 157588 155143 156369 156321 155144 155143 155124 156369 156369 155124 156321 155143 + 156222 156369 155124 156321 156222 156321 155040 157427 155071 156222 155124 155040 + 155124 156321 155143 155040 155124 156222 156321 155040 117427 117649 116222 117430 + 114905 116222 117430 116229 116222 114905 117430 117649 116949 114905 116222 117649 + 117427 116222 117649 116949 117427 114905 116222 116949 114905 115072 116222 116229 + 115072 114905 116222 115040 117427 116222 114905 115040 114905 114905 116949 116222 + 114905 114905 116222 115040 116993 116321 117588 117427 116993 116321 117649 117588 + 116321 115107 117649 117588 116321 115107 116993 117649 115009 117427 116321 116993 + 115143 117588 115107 116321 116321 115107 115143 115040 116321 117427 115009 115040 + 115107 115009 116321 116993 115009 115107 116321 115040 116949 114905 117358 117427 + 115009 116993 117358 117427 114905 115009 117358 117427 115009 114905 115040 117427 + 114905 115009 114905 117358 115440 115400 113546 115443 115400 115440 114187 115425 + 115400 115440 113546 114187 115400 114187 114142 115425 113546 115400 114187 114142 + 114187 114142 115425 114879 114142 115400 115425 115183 115425 114167 115183 115145 + 114142 115425 114167 115183 113844 114142 114167 115183 114142 114167 115425 114879 + 114142 113844 114167 114879 115440 115361 114187 115425 114187 115425 115354 114879 + 115361 115354 113858 114187 115361 115354 114187 115425 115354 113858 114187 114879 + 113858 114879 115354 113797 115328 115425 114167 114879 115354 115425 115328 114879 + 115425 115328 114167 115145 114167 115328 114654 115145 115328 114167 114654 114879 + 115354 115328 114164 114879 115145 115144 115328 114654 114654 115328 114164 115144 + 115328 114654 114164 114879 114167 113612 114654 114879 115354 114879 114164 113797 + 114654 113612 114164 114879 113979 113802 113546 114187 113802 113546 114187 114142 + 113979 113802 111490 113546 113802 114187 113979 114879 113802 114142 114187 114879 + 113802 113979 115408 114879 113979 113802 113171 111490 113802 115408 112488 114142 + 113171 113802 112488 111490 113802 115408 113171 112488 112447 115408 113979 114187 + 112447 113979 113171 111490 112447 113979 115408 113171 113802 115408 113979 113171 + 115408 112488 114142 113844 115408 114142 113802 114879 114142 115408 113844 114879 + 114319 114167 113844 114879 111928 112488 114319 113844 115408 114319 113844 114879 + 112488 115408 114319 113844 114879 113979 115408 114187 115408 114187 114405 114879 + 114405 112447 113858 114187 114405 114187 113858 114879 114405 114879 113858 113797 + 114405 115408 112447 114187 114405 112447 112098 113858 114319 113612 114167 114879 + 114767 113612 114319 114879 114405 114767 114879 113797 114164 113612 114767 114879 + 114164 114879 114767 113797 115408 114767 114319 114879 115408 114405 114767 114879 + 113318 115048 115183 115064 114167 115183 115145 115064 114167 113318 115183 115064 + 113318 113844 114167 115183 113844 113318 114167 113612 113318 115064 114167 113612 + 115048 113318 114905 115064 115048 113318 112452 114905 114905 115048 112452 114905 + 113318 112861 114905 115064 113318 112861 115064 113612 113318 111584 112861 113612 + 113318 112861 112452 114905 115140 114167 115145 115064 114167 114654 115140 115145 + 114167 115140 114654 113612 114167 115064 115140 113612 115140 115144 115145 114654 + 114164 114654 115144 115140 115072 114164 115144 115140 114654 115140 114164 113612 + 115072 115140 115064 113612 114164 115140 115072 113612 115072 115064 112861 113612 + 112861 114905 114905 115064 114905 112861 115072 115064 112861 112161 114905 115072 + 112861 112161 115072 113612 114319 110864 113844 113318 113844 114319 113318 113612 + 113844 114167 114319 113612 113612 111785 111096 113318 114319 111096 113318 113612 + 110864 111928 114319 113844 111096 110864 114319 113318 111785 113318 111584 112452 + 113318 112861 111584 112452 110000 111785 111584 112452 111785 111584 113318 113612 + 111584 111785 111096 113612 110864 111096 111785 113318 110864 111785 110315 110000 + 110864 111785 111096 110315 111785 110315 110000 111584 111584 111096 111785 110315 + 111096 112861 110000 111584 110000 110315 110000 111584 110315 111096 110000 111584 + 114767 111096 114319 113612 111096 114767 110846 113612 112861 111096 112161 113612 + 111096 112861 111584 113612 112861 111096 110000 112161 112161 111096 110846 113612 + 111096 110000 112161 110846 112161 110000 110000 110846 113498 115361 115354 113858 + 115361 113498 115354 115263 113498 115361 115274 115263 115354 115263 113498 113797 + 113498 113858 115354 113797 115354 114164 115253 113797 115253 115354 115328 114164 + 115328 115253 114164 115144 114164 115253 114653 115144 115253 114164 114653 113797 + 115354 115253 115263 113797 115253 114164 115263 113797 115143 115253 115144 114653 + 115253 115263 114164 115143 115253 114164 114653 115143 115253 114653 114164 113797 + 113290 113498 115274 115263 115219 115199 112987 115274 115199 113290 115274 115263 + 115199 113290 112987 115274 113290 113498 112987 115274 113290 113498 115263 113797 + 113498 113290 112242 113797 115263 115107 114164 115143 115199 115107 113290 115263 + 115107 113290 115263 114164 115263 114164 113290 113797 113290 114164 112522 113797 + 113290 115107 112522 114164 111157 113498 111543 113858 113498 111543 113858 113797 + 113498 112242 111543 113797 111157 114405 112098 113858 114405 113858 111543 113797 + 114405 111157 111543 113858 114164 113363 111088 113797 111088 113363 114767 113797 + 114405 111543 114767 113797 111543 111088 114767 113797 113290 112142 112242 113797 + 112142 111543 112242 113797 113498 113290 112987 112242 113290 112987 112242 112142 + 112242 112987 110660 112142 111157 113498 112242 111543 111157 112242 110775 111543 + 112242 111157 110775 110660 112242 111543 112142 110775 110775 112242 110660 112142 + 110655 111543 112142 113290 110655 112142 111543 110775 110655 110775 110660 112142 + 113290 111088 111543 113797 113797 112142 111543 113290 111088 112522 114164 113797 + 111088 113290 112522 113797 113290 110655 111088 112522 110655 113290 111088 111543 + 110655 111088 112522 110510 114164 115072 115144 115124 114653 114164 115144 115124 + 114164 115124 114653 113363 114164 115072 115124 113363 115144 115143 114653 115124 + 114653 114164 115124 115143 114164 115124 115143 115040 114164 114653 115124 113363 + 115072 115040 115124 113363 114164 115124 115040 113363 114164 113363 114653 113797 + 114164 113612 115072 113363 114164 114653 113363 113797 112861 114905 115072 115040 + 112161 112861 114905 115072 112861 115040 115072 113363 112861 114905 114905 115040 + 112161 115072 113612 113363 112161 112861 115072 113363 115107 114164 115143 115040 + 115107 113062 114164 115040 115107 115009 113062 115040 112522 114164 113062 113363 + 113062 114164 115040 113363 112522 115107 113062 114164 113062 115009 112861 115040 + 115009 114905 112861 115040 114905 112452 115009 112861 112452 114905 115009 114905 + 113062 115040 112861 113363 111708 113062 112861 113363 115009 112452 113062 112861 + 114767 113612 114164 113363 114767 113363 114164 113797 110846 113612 114767 113363 + 110846 114767 110587 113363 114767 111088 110587 113363 112161 113612 110846 113363 + 112161 110846 112861 113363 112161 110846 110000 112861 110846 110587 112861 113363 + 113363 111491 110587 112861 110000 112161 110846 110000 110000 110846 110587 112861 + 111088 114164 112522 113363 110587 112522 113062 113363 111708 110587 113062 113363 + 112522 110238 110587 113062 111088 112522 110587 113363 110238 111088 112522 110587 + 111088 110238 112522 110510 111708 112861 111491 113363 111708 111491 110587 113363 + 112452 111708 113062 112861 111491 111708 112452 112861 111708 110000 111491 112452 + 111708 110587 111491 110205 110000 110587 111491 112861 110000 111491 110587 110205 + 110000 110000 111491 110205 110238 111708 110587 113062 111708 110238 110587 110205 + 110238 111708 110000 110205 110000 111708 111491 110205 + + + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 1460 + 1460 1460 1460 1460 1460 1460 1460 1460 + + + 0 0 0 0 0 0 0 0 0 0 0 2.27158e-25 + 0 0 0 0 0 0 0 2.27158e-25 0 0 0 2.27158e-25 + 0 0 0 2.27158e-25 0 0 0 3.1905e-38 0 0 3.1905e-38 2.27158e-25 + 0 0 4.80778e-25 2.27158e-25 0 3.1905e-38 4.80778e-25 2.27158e-25 0 0 1.61191e-36 2.27158e-25 + 3.1905e-38 0 1.61191e-36 2.27158e-25 0 0 0 2.27158e-25 0 0 0 0 + 0 0 0 0 0 0 2.27158e-25 0 0 0 0 0 + 0 4.80778e-25 0 0 4.80778e-25 0 2.27158e-25 0 4.80778e-25 0 0 0 + 2.27158e-25 4.80778e-25 0 0 0 0 2.27158e-25 0 0 0 0 0 + 1.61191e-36 0 0 2.27158e-25 0 0 1.61191e-36 0 1.61191e-36 8.33107e-25 0 0 + 0 8.33107e-25 1.61191e-36 2.27158e-25 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 2.27158e-25 0 + 2.27158e-25 0 0 0 0 0 0 0 0 2.27158e-25 0 0 + 0 0 0 0 0 0 0 8.33107e-25 0 0 2.27158e-25 8.33107e-25 + 0 0 0 0 0 0 0 0 0 0 0 0 + 4.80778e-25 3.1905e-38 1.40477e-10 2.27158e-25 1.40477e-10 3.1905e-38 1.61191e-36 2.27158e-25 1.80977e-09 1.40477e-10 3.1905e-38 6.27148e-21 + 1.40477e-10 3.1905e-38 4.80778e-25 1.80977e-09 4.80778e-25 5.85511e-05 1.40477e-10 1.80977e-09 1.40477e-10 5.85511e-05 4.80778e-25 2.27158e-25 + 9.4764e-24 4.80778e-25 0 7.26687e-08 9.4764e-24 4.80778e-25 2.27158e-25 0 4.80778e-25 9.4764e-24 2.27158e-25 5.85511e-05 + 4.80778e-25 9.4764e-24 0 0 0 9.4764e-24 7.26687e-08 0 1.80977e-09 4.80778e-25 9.4764e-24 7.26687e-08 + 4.80778e-25 1.80977e-09 9.4764e-24 5.85511e-05 1.80977e-09 9.4764e-24 5.85511e-05 7.26687e-08 7.26687e-08 9.4764e-24 0 0 + 9.4764e-24 5.85511e-05 7.26687e-08 0 1.61191e-36 4.70669e-23 2.27158e-25 8.33107e-25 2.27158e-25 1.40477e-10 4.70669e-23 1.61191e-36 + 0 1.15638e-08 1.61191e-36 4.70669e-23 1.61191e-36 0 4.70669e-23 8.33107e-25 0 1.15638e-08 4.70669e-23 8.33107e-25 + 1.15638e-08 1.40477e-10 1.61191e-36 4.70669e-23 2.27158e-25 4.70669e-23 1.40477e-10 5.85511e-05 1.15638e-08 1.40477e-10 4.70669e-23 5.85511e-05 + 1.15638e-08 4.70669e-23 8.33107e-25 9.52806e-05 1.15638e-08 4.70669e-23 9.52806e-05 5.85511e-05 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 3.56033e-38 0 0 0 5.55616e-34 + 0 0 5.55616e-34 0 5.55616e-34 0 0 3.56033e-38 0 0 5.55616e-34 3.56033e-38 + 0 0 0 0 0 0 0 3.56033e-38 0 0 0 0 + 0 0 0 3.56033e-38 0 0 3.56033e-38 0 0 0 0 0 + 3.56033e-38 0 0 0 0 5.55616e-34 0 3.56033e-38 5.55616e-34 0 0 3.56033e-38 + 0 0 0 0 0 0 3.56033e-38 0 0 0 3.56033e-38 0 + 0 3.56033e-38 0 0 0 0 3.56033e-38 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 3.56033e-38 0 0 0 0 + 0 0 0 3.56033e-38 3.56033e-38 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 3.56033e-38 0 0 0 0 0 3.56033e-38 0 0 0 3.56033e-38 0 + 0 0 0 0 0 0 3.56033e-38 0 0 0 0 3.56033e-38 + 5.55616e-34 0 7.26687e-08 1.20064e-32 5.55616e-34 0 1.20064e-32 0 0 7.26687e-08 1.20064e-32 0 + 1.20064e-32 5.55616e-34 0 3.56033e-38 3.56033e-38 1.31135e-13 1.20064e-32 5.55616e-34 1.31135e-13 5.55616e-34 7.26687e-08 1.20064e-32 + 7.26687e-08 0 1.20064e-32 0 0 7.26687e-08 1.20064e-32 5.12054e-09 3.56033e-38 1.20064e-32 1.31135e-13 5.12054e-09 + 7.26687e-08 1.31135e-13 1.20064e-32 5.12054e-09 5.55616e-34 1.31135e-13 0 3.56033e-38 0 0 0 3.56033e-38 + 0 1.31135e-13 0 3.56033e-38 1.31135e-13 0 0 0 0 1.31135e-13 5.12054e-09 3.56033e-38 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 4.60097e-35 3.56033e-38 0 0 0 3.56033e-38 4.60097e-35 0 + 0 3.56033e-38 4.60097e-35 0 0 0 0 4.60097e-35 0 0 0 4.60097e-35 + 4.60097e-35 3.56033e-38 0 5.12054e-09 0 0 4.60097e-35 0 0 4.60097e-35 0 5.12054e-09 + 0 1.33684e-08 4.60097e-35 5.12054e-09 0 0 0 0 0 0 0 0 + 0 8.33107e-25 0 0 0 0 0 9.83551e-39 0 8.33107e-25 0 9.83551e-39 + 0 0 9.83551e-39 3.19469e-36 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 8.33107e-25 + 0 0 0 8.33107e-25 0 0 0 8.33107e-25 0 0 0 0 + 0 0 0 0 0 0 9.83551e-39 0 0 0 9.83551e-39 8.33107e-25 + 0 0 0 0 0 0 0 0 0 0 0 0 + 9.83551e-39 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 9.83551e-39 0 0 0 9.83551e-39 0 0 0 9.83551e-39 + 0 0 0 0 0 0 0 0 0 0 0 9.83551e-39 + 0 0 9.83551e-39 3.19469e-36 0 0 9.83551e-39 3.19469e-36 0 0 0 9.83551e-39 + 0 0 0 0 0 0 0 9.83551e-39 0 0 0 9.83551e-39 + 0 0 0 9.83551e-39 0 0 9.83551e-39 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 9.83551e-39 0 0 + 0 0 9.83551e-39 0 0 0 0 0 0 0 0 0 + 1.15638e-08 0 3.19469e-36 3.91491e-24 9.83551e-39 3.91491e-24 0 8.33107e-25 1.15638e-08 0 3.91491e-24 8.33107e-25 + 9.83551e-39 0 3.91491e-24 3.19469e-36 9.83551e-39 3.19469e-36 3.91491e-24 2.52649e-09 3.91491e-24 1.15638e-08 8.33107e-25 9.52806e-05 + 3.91491e-24 1.15638e-08 9.52806e-05 2.52649e-09 3.19469e-36 1.15638e-08 3.91491e-24 8.30205e-31 3.91491e-24 3.19469e-36 8.30205e-31 2.52649e-09 + 1.15638e-08 3.91491e-24 8.30205e-31 2.52649e-09 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1.65317e-35 3.19469e-36 9.83551e-39 + 0 0 1.65317e-35 9.83551e-39 0 3.19469e-36 1.65317e-35 8.30205e-31 2.52649e-09 1.65317e-35 3.19469e-36 8.30205e-31 + 2.52649e-09 3.19469e-36 1.65317e-35 9.83551e-39 0 0 1.65317e-35 8.30205e-31 0 3.18971e-37 9.83551e-39 0 + 9.83551e-39 1.65317e-35 3.18971e-37 0 3.18971e-37 0 0 0 5.12553e-36 3.18971e-37 0 0 + 3.18971e-37 0 5.12553e-36 0 9.83551e-39 3.18971e-37 1.65317e-35 2.52649e-09 0 0 5.12553e-36 3.18971e-37 + 3.18971e-37 5.12553e-36 2.52649e-09 0 0 3.18971e-37 5.12553e-36 1.65317e-35 3.18971e-37 5.12553e-36 1.65317e-35 2.52649e-09 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 1.64653e-42 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 1.64653e-42 0 0 1.64653e-42 0 + 0 0 0 1.64653e-42 0 0 0 0 0 1.64653e-42 0 0 + 1.64653e-42 0 0 0 0 0 1.64653e-42 0 0 0 1.64653e-42 0 + 0 0 0 0 0 0 0 1.64653e-42 0 0 0 0 + 0 0 0 0 0 0 0 1.64653e-42 0 0 0 0 + 0 0 0 0 0 0 0 1.64653e-42 0 0 1.64653e-42 0 + 0 0 0 1.64653e-42 0 0 0 0 0 0 1.64653e-42 0 + 0 0 0 0 0 0 0 1.64653e-42 0 0 0 0 + 0 0 0 1.64653e-42 0 0 1.64653e-42 0 0 0 0 1.64653e-42 + 0 0 0 1.64653e-42 0 0 0 1.64653e-42 0 0 0 0 + 0 0 0 1.64653e-42 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 1.64653e-42 0 1.35173e-35 0 + 0 1.35173e-35 0 4.60097e-35 1.35173e-35 0 0 0 0 0 1.35173e-35 0 + 1.64653e-42 1.35173e-35 0 0 1.64653e-42 0 1.35173e-35 0 0 1.33684e-08 1.35173e-35 4.60097e-35 + 1.33684e-08 0 1.35173e-35 1.38795e-10 1.64653e-42 1.35173e-35 0 1.38795e-10 0 0 0 1.35173e-35 + 0 0 1.35173e-35 1.38795e-10 0 3.84124e-41 0 1.64653e-42 0 3.84124e-41 0 0 + 3.84124e-41 5.12553e-36 0 0 3.84124e-41 5.12553e-36 0 0 5.11278e-41 1.64653e-42 3.84124e-41 0 + 0 0 5.12553e-36 3.84124e-41 3.84124e-41 5.12553e-36 0 1.38795e-10 3.84124e-41 1.64653e-42 5.11278e-41 1.38795e-10 + 5.12553e-36 5.11278e-41 3.84124e-41 0 5.11278e-41 5.12553e-36 3.84124e-41 1.38795e-10 0 0 0 1.64653e-42 + 5.11278e-41 0 0 1.64653e-42 0 5.11278e-41 0 1.64653e-42 5.11278e-41 0 1.38795e-10 1.64653e-42 + 0 5.11278e-41 0 0 1.40477e-10 1.80977e-09 0.000321273 6.27148e-21 1.80977e-09 1.40477e-10 0.63874 5.85511e-05 + 1.80977e-09 1.40477e-10 0.000321273 0.63874 1.80977e-09 0.63874 0.736164 5.85511e-05 0.000321273 1.80977e-09 0.63874 0.736164 + 0.63874 0.736164 5.85511e-05 26.3197 0.736164 1.80977e-09 5.85511e-05 7.26687e-08 5.85511e-05 0 7.26687e-08 0 + 0.736164 5.85511e-05 0 7.26687e-08 8.02366 0.736164 0 7.26687e-08 0.736164 0 5.85511e-05 26.3197 + 0.736164 8.02366 0 26.3197 1.40477e-10 1.15638e-08 0.63874 5.85511e-05 0.63874 5.85511e-05 9.52806e-05 26.3197 + 1.15638e-08 9.52806e-05 4.23258 0.63874 1.15638e-08 9.52806e-05 0.63874 5.85511e-05 9.52806e-05 4.23258 0.63874 26.3197 + 4.23258 26.3197 9.52806e-05 1.83313 0.000765824 5.85511e-05 0 26.3197 9.52806e-05 5.85511e-05 0.000765824 26.3197 + 5.85511e-05 0.000765824 0 0 0 0.000765824 0 0 0.000765824 0 0 26.3197 + 9.52806e-05 0.000765824 0 26.3197 0 0 0.000765824 0 0 0.000765824 0 0 + 0.000765824 0 0 26.3197 0 2.12733 0 26.3197 9.52806e-05 26.3197 0 1.83313 + 0 2.12733 0 26.3197 18.3805 11.688 0.000321273 0.63874 11.688 0.000321273 0.63874 0.736164 + 18.3805 11.688 0.00358455 0.000321273 11.688 0.63874 18.3805 26.3197 11.688 0.736164 0.63874 26.3197 + 11.688 18.3805 244.601 26.3197 18.3805 11.688 39.5275 0.00358455 11.688 244.601 10.4298 0.736164 + 39.5275 11.688 10.4298 0.00358455 11.688 244.601 39.5275 10.4298 9.54588 244.601 18.3805 0.63874 + 9.54588 18.3805 39.5275 0.00358455 9.54588 18.3805 244.601 39.5275 11.688 244.601 18.3805 39.5275 + 244.601 10.4298 0.736164 8.02366 244.601 0.736164 11.688 26.3197 0.736164 244.601 8.02366 26.3197 + 157.401 0 8.02366 26.3197 5.67266 10.4298 157.401 8.02366 244.601 157.401 8.02366 26.3197 + 10.4298 244.601 157.401 8.02366 26.3197 18.3805 244.601 0.63874 244.601 0.63874 164.564 26.3197 + 164.564 9.54588 4.23258 0.63874 164.564 0.63874 4.23258 26.3197 164.564 26.3197 4.23258 1.83313 + 164.564 244.601 9.54588 0.63874 164.564 9.54588 6.84702 4.23258 157.401 2.12733 0 26.3197 + 226.028 2.12733 157.401 26.3197 164.564 226.028 26.3197 1.83313 0 2.12733 226.028 26.3197 + 0 26.3197 226.028 1.83313 244.601 226.028 157.401 26.3197 244.601 164.564 226.028 26.3197 + 0.0855784 1.31135e-13 7.26687e-08 5.12054e-09 0 7.26687e-08 0 5.12054e-09 0 0.0855784 7.26687e-08 5.12054e-09 + 0.0855784 8.02366 0 7.26687e-08 8.02366 0.0855784 0 2.12733 0.0855784 5.12054e-09 0 2.12733 + 1.31135e-13 0.0855784 0 5.12054e-09 1.31135e-13 0.0855784 0 0 0 1.31135e-13 0 0 + 0.0855784 0 0 5.12054e-09 0.0855784 0 5.12054e-09 2.12733 0.0855784 0 0 2.12733 + 0.0855784 0 0 0 1.07133e-07 0 0 5.12054e-09 0 0 1.07133e-07 0 + 0 1.07133e-07 0 2.12733 0 5.12054e-09 1.07133e-07 2.12733 1.07133e-07 0 0 0 + 0 0 0 1.07133e-07 1.33684e-08 0 0 1.07133e-07 0 1.07133e-07 0 2.12733 + 1.33684e-08 1.07133e-07 5.12054e-09 2.12733 0 1.07133e-07 1.33684e-08 2.12733 1.33684e-08 5.12054e-09 0 2.12733 + 0 0 0 5.12054e-09 0 0 1.33684e-08 5.12054e-09 0 0 0 1.33684e-08 + 0 0 1.33684e-08 2.12733 157.401 1.25839 8.02366 0.0855784 8.02366 157.401 0.0855784 2.12733 + 8.02366 0 157.401 2.12733 2.12733 3.91009e-08 1.86671 0.0855784 157.401 1.86671 0.0855784 2.12733 + 1.25839 5.67266 157.401 8.02366 1.86671 1.25839 157.401 0.0855784 3.91009e-08 0.0855784 0 0 + 0.0855784 0 0 0 0 3.91009e-08 0 0 3.91009e-08 0 0.0855784 2.12733 + 0 3.91009e-08 1.86671 2.12733 1.25839 1.86671 3.91009e-08 0.0855784 1.25839 3.91009e-08 3.68464e-09 0 + 1.25839 3.91009e-08 1.86671 3.68464e-09 3.91009e-08 3.68464e-09 0 0 0 1.86671 3.91009e-08 3.68464e-09 + 1.86671 0 0 0 0 3.68464e-09 0 0 3.68464e-09 1.86671 0 0 + 226.028 1.86671 157.401 2.12733 1.86671 226.028 1.3043 2.12733 0 1.86671 0 2.12733 + 1.86671 0 0 2.12733 0 1.86671 0 0 0 1.86671 1.3043 2.12733 + 1.86671 0 0 1.3043 0 0 0 1.3043 3.52395e-07 1.15638e-08 9.52806e-05 4.23258 + 1.15638e-08 3.52395e-07 9.52806e-05 2.52649e-09 3.52395e-07 1.15638e-08 8.30205e-31 2.52649e-09 9.52806e-05 2.52649e-09 3.52395e-07 1.83313 + 3.52395e-07 4.23258 9.52806e-05 1.83313 9.52806e-05 0 6.94018e-08 1.83313 6.94018e-08 9.52806e-05 0.000765824 0 + 0.000765824 6.94018e-08 0 0 0 6.94018e-08 0 0 6.94018e-08 0 0 1.83313 + 9.52806e-05 6.94018e-08 2.52649e-09 1.83313 6.94018e-08 0 2.52649e-09 1.83313 0 6.94018e-08 0 0 + 6.94018e-08 2.52649e-09 0 0 6.94018e-08 0 0 0 6.94018e-08 0 0 1.83313 + 1.1296e-08 3.52395e-07 8.30205e-31 2.52649e-09 0 1.65317e-35 1.2187e-31 8.30205e-31 1.65317e-35 1.1296e-08 8.30205e-31 2.52649e-09 + 1.65317e-35 1.1296e-08 1.2187e-31 8.30205e-31 1.1296e-08 3.52395e-07 1.2187e-31 8.30205e-31 1.1296e-08 3.52395e-07 2.52649e-09 1.83313 + 3.52395e-07 1.1296e-08 6.38901e-08 1.83313 2.52649e-09 5.12553e-36 0 0 1.65317e-35 5.12553e-36 1.1296e-08 2.52649e-09 + 5.12553e-36 1.1296e-08 2.52649e-09 0 2.52649e-09 0 1.1296e-08 1.83313 1.1296e-08 0 3.78935e-09 1.83313 + 1.1296e-08 5.12553e-36 3.78935e-09 0 0.966649 3.52395e-07 3.48452 4.23258 3.52395e-07 3.48452 4.23258 1.83313 + 3.52395e-07 6.38901e-08 3.48452 1.83313 0.966649 164.564 6.84702 4.23258 164.564 4.23258 3.48452 1.83313 + 164.564 0.966649 3.48452 4.23258 0 0.713004 1.12741 1.83313 1.12741 0.713004 226.028 1.83313 + 164.564 3.48452 226.028 1.83313 3.48452 1.12741 226.028 1.83313 1.1296e-08 4.37555e-08 6.38901e-08 1.83313 + 4.37555e-08 3.48452 6.38901e-08 1.83313 3.52395e-07 1.1296e-08 1.2187e-31 6.38901e-08 1.1296e-08 1.2187e-31 6.38901e-08 4.37555e-08 + 6.38901e-08 1.2187e-31 2.41908e-11 4.37555e-08 0.966649 3.52395e-07 6.38901e-08 3.48452 0.966649 6.38901e-08 5.3023e-09 3.48452 + 6.38901e-08 0.966649 5.3023e-09 2.41908e-11 6.38901e-08 3.48452 4.37555e-08 5.3023e-09 5.3023e-09 6.38901e-08 2.41908e-11 4.37555e-08 + 2.26565e-11 3.48452 4.37555e-08 1.1296e-08 2.26565e-11 4.37555e-08 3.48452 5.3023e-09 2.26565e-11 5.3023e-09 2.41908e-11 4.37555e-08 + 1.1296e-08 1.12741 3.48452 1.83313 1.83313 4.37555e-08 3.48452 1.1296e-08 1.12741 3.78935e-09 0 1.83313 + 1.12741 1.1296e-08 3.78935e-09 1.83313 1.1296e-08 2.26565e-11 1.12741 3.78935e-09 2.26565e-11 1.1296e-08 1.12741 3.48452 + 2.26565e-11 1.12741 3.78935e-09 1.26888e-14 0 1.33684e-08 0 3.17237e-09 0 0 0 3.17237e-09 + 0 3.17237e-09 0 0.713004 0 1.33684e-08 3.17237e-09 0.713004 0 0 0 3.17237e-09 + 0 0 3.17237e-09 0 0 3.17237e-09 0 1.38795e-10 0 0 3.17237e-09 0.713004 + 1.33684e-08 1.38795e-10 3.17237e-09 0.713004 0 3.17237e-09 1.38795e-10 0.713004 0 0.713004 0 1.83313 + 0 2.12733 1.33684e-08 0.713004 0 0 0.713004 1.83313 0 0 1.33684e-08 1.38795e-10 + 0 0 0 1.33684e-08 0 1.38795e-10 1.33684e-08 0.713004 0 0 0 1.38795e-10 + 0 1.33684e-08 2.12733 0.713004 0 0 1.33684e-08 0.713004 5.12553e-36 0 0 1.38795e-10 + 5.12553e-36 7.74005e-11 0 1.38795e-10 5.12553e-36 5.11278e-41 7.74005e-11 1.38795e-10 3.78935e-09 0 7.74005e-11 0.713004 + 7.74005e-11 0 1.38795e-10 0.713004 3.78935e-09 5.12553e-36 7.74005e-11 0 7.74005e-11 5.11278e-41 0 1.38795e-10 + 5.11278e-41 0 0 1.38795e-10 0 0 5.11278e-41 0 0 0 5.11278e-41 0 + 7.74005e-11 1.38795e-10 0 0.713004 8.7454e-12 7.74005e-11 0 0.713004 5.11278e-41 0 7.74005e-11 0 + 226.028 2.12733 0 0.713004 226.028 0.713004 0 1.83313 1.3043 2.12733 226.028 0.713004 + 1.3043 226.028 0.0989163 0.713004 226.028 1.12741 0.0989163 0.713004 0 2.12733 1.3043 0.713004 + 0 1.3043 0 0.713004 0 1.3043 0 0 1.3043 0.0989163 0 0.713004 + 0.713004 0 0.0989163 0 0 0 1.3043 0 0 1.3043 0.0989163 0 + 1.12741 0 3.78935e-09 0.713004 0.0989163 3.78935e-09 7.74005e-11 0.713004 8.7454e-12 0.0989163 7.74005e-11 0.713004 + 3.78935e-09 1.58099e-10 0.0989163 7.74005e-11 1.12741 3.78935e-09 0.0989163 0.713004 1.58099e-10 1.12741 3.78935e-09 0.0989163 + 1.12741 1.58099e-10 3.78935e-09 1.26888e-14 8.7454e-12 0 0 0.713004 8.7454e-12 0 0.0989163 0.713004 + 0 8.7454e-12 7.74005e-11 0 0 8.7454e-12 0 0 8.7454e-12 0 0 0 + 8.7454e-12 0.0989163 0 4.80225e-42 0 0.0989163 0 0 0 0 0.0989163 4.80225e-42 + 0 0 0 4.80225e-42 1.58099e-10 8.7454e-12 0.0989163 7.74005e-11 8.7454e-12 1.58099e-10 0.0989163 4.80225e-42 + 1.58099e-10 8.7454e-12 0 4.80225e-42 0 8.7454e-12 0 4.80225e-42 + + + + + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 + + + + + 0 0.161458 0.161458 0.154679 0.154679 0 0.161458 0 0.161458 0 0 0 + 0.154679 0.154679 0 0.161458 0 0.161458 0 0 0 0.25 0 0 + 0.154679 0.154679 0 0.161458 0 0.161458 0.25 0 0 0.25 0.25 0.25 + 0 0.25 0 0.154679 0.154679 0 0 0.161458 0.161458 0 0 0 + 0.154679 0.154679 0 0 0.25 0 0 0.161458 0.161458 0.25 0.25 0.25 + 0.154679 0.154679 0 0.25 0 0 0.291667 0.291667 0 0.25 0.25 0.25 + 0 0.25 0 0.154679 0.154679 0 0.291667 0.291667 0 0.25 0.25 0.25 + 0.161458 0 0.161458 0 0.161458 0.161458 0 0 0 0 0 0.25 + 0.161458 0 0.161458 0 0.161458 0.161458 0 0 0.25 0.25 0.25 0.25 + 0.25 0 0 0.161458 0 0.161458 0.291667 0 0.291667 0.25 0.25 0.25 + 0.161458 0 0.161458 0 0 0.25 0.291667 0 0.291667 0.25 0.25 0.25 + 0 0.161458 0.161458 0 0.25 0 0 0.291667 0.291667 0.25 0.25 0.25 + 0 0 0.25 0 0.161458 0.161458 0 0.291667 0.291667 0.25 0.25 0.25 + 0.154679 0.154679 0 0 0.161458 0.161458 0.161458 0 0.161458 0.25 0.25 0.25 + 0.25 0 0 0.5 0 0 0.5 0.220238 0 0.5 0.25 0.15 + 0.5 0 0 0.25 0 0 0.5 0 0.220238 0.5 0.25 0.15 + 0.25 0 0 0.291667 0.291667 0 0.25 0.25 0.25 0.5 0.25 0.15 + 0.291667 0.291667 0 0.25 0 0 0.5 0.220238 0 0.5 0.25 0.15 + 0.25 0 0 0.291667 0 0.291667 0.5 0 0.220238 0.5 0.25 0.15 + 0.291667 0 0.291667 0.25 0 0 0.25 0.25 0.25 0.5 0.25 0.15 + 0.291667 0 0.291667 0.5 0 0.220238 0.5 0.25 0.15 0.5 0.25 0.25 + 0.25 0.25 0.25 0.291667 0 0.291667 0.5 0.25 0.15 0.5 0.25 0.25 + 0.291667 0.291667 0 0 0.25 0 0.25 0.25 0.25 0.220238 0.5 0 + 0 0.5 0.220238 0 0.25 0 0 0.5 0 0.220238 0.5 0 + 0 0.291667 0.291667 0 0.25 0 0.220238 0.5 0 0.25 0.25 0.25 + 0.220238 0.5 0 0 0.25 0 0 0.291667 0.291667 0 0.5 0.220238 + 0 0.291667 0.291667 0.25 0.5 0.25 0.220238 0.5 0 0 0.5 0.220238 + 0.220238 0.5 0 0.25 0.5 0.25 0 0.291667 0.291667 0.25 0.25 0.25 + 0.5 0.5 0 0.291667 0.291667 0 0.5 0.220238 0 0.5 0.25 0.15 + 0.5 0.5 0.15 0.291667 0.291667 0 0.375 0.375 0.25 0.220238 0.5 0 + 0.5 0.5 0.15 0.291667 0.291667 0 0.220238 0.5 0 0.5 0.5 0 + 0.5 0.5 0.15 0.5 0.25 0.15 0.291667 0.291667 0 0.5 0.5 0 + 0.291667 0.291667 0 0.375 0.375 0.25 0.25 0.25 0.25 0.5 0.25 0.15 + 0.25 0.25 0.25 0.220238 0.5 0 0.375 0.375 0.25 0.291667 0.291667 0 + 0.5 0.25 0.15 0.375 0.375 0.25 0.5 0.5 0.15 0.291667 0.291667 0 + 0.375 0.375 0.25 0.25 0.25 0.25 0.5 0.25 0.15 0.5 0.25 0.25 + 0.5 0.375 0.2 0.375 0.375 0.25 0.5 0.25 0.15 0.5 0.25 0.25 + 0.375 0.375 0.25 0.5 0.5 0.15 0.220238 0.5 0 0.25 0.5 0.25 + 0.375 0.375 0.25 0.220238 0.5 0 0.25 0.25 0.25 0.25 0.5 0.25 + 0.5 0.25 0.15 0.5 0.5 0.15 0.375 0.375 0.25 0.5 0.375 0.2 + 0.5 0.25 0.25 0.5 0.5 0.25 0.5 0.375 0.2 0.375 0.375 0.25 + 0.375 0.375 0.25 0.5 0.5 0.15 0.5 0.5 0.25 0.5 0.375 0.2 + 0.291667 0 0.291667 0 0 0.25 0 0.220238 0.5 0.25 0.25 0.25 + 0 0.220238 0.5 0 0 0.25 0 0.291667 0.291667 0.25 0.25 0.25 + 0.220238 0 0.5 0 0.220238 0.5 0 0 0.25 0 0 0.5 + 0 0.220238 0.5 0 0 0.25 0.291667 0 0.291667 0.220238 0 0.5 + 0.291667 0 0.291667 0.25 0.25 0.5 0 0.220238 0.5 0.220238 0 0.5 + 0 0.220238 0.5 0.25 0.25 0.5 0.291667 0 0.291667 0.25 0.25 0.25 + 0.375 0.25 0.375 0.291667 0 0.291667 0.5 0 0.220238 0.5 0 0.5 + 0.375 0.25 0.375 0.291667 0 0.291667 0.25 0.25 0.25 0.5 0.25 0.25 + 0.291667 0 0.291667 0.375 0.25 0.375 0.25 0.25 0.25 0.25 0.25 0.5 + 0.291667 0 0.291667 0.375 0.25 0.375 0.5 0 0.220238 0.5 0.25 0.25 + 0.5 0 0.220238 0.375 0.25 0.375 0.5 0 0.5 0.5 0.25 0.25 + 0.220238 0 0.5 0.291667 0 0.291667 0.375 0.25 0.375 0.5 0 0.5 + 0.291667 0 0.291667 0.220238 0 0.5 0.375 0.25 0.375 0.25 0.25 0.5 + 0.220238 0 0.5 0.375 0.25 0.375 0.25 0.25 0.5 0.5 0 0.5 + 0.5 0 0.5 0.375 0.25 0.375 0.5 0.25 0.5 0.5 0.25 0.25 + 0.375 0.25 0.375 0.25 0.25 0.5 0.5 0 0.5 0.5 0.25 0.5 + 0 0.291667 0.291667 0.25 0.375 0.375 0.25 0.25 0.25 0.25 0.5 0.25 + 0.25 0.25 0.25 0 0.220238 0.5 0.25 0.375 0.375 0 0.291667 0.291667 + 0 0.5 0.220238 0 0.5 0.5 0 0.291667 0.291667 0.25 0.375 0.375 + 0 0.291667 0.291667 0 0.5 0.220238 0.25 0.375 0.375 0.25 0.5 0.25 + 0 0.5 0.220238 0 0.5 0.5 0.25 0.375 0.375 0.25 0.5 0.25 + 0 0.5 0.5 0 0.220238 0.5 0 0.291667 0.291667 0.25 0.375 0.375 + 0.25 0.25 0.25 0.25 0.375 0.375 0 0.220238 0.5 0.25 0.25 0.5 + 0 0.5 0.5 0 0.220238 0.5 0.25 0.375 0.375 0.25 0.25 0.5 + 0 0.5 0.5 0.25 0.375 0.375 0.25 0.5 0.25 0.25 0.5 0.5 + 0 0.5 0.5 0.25 0.375 0.375 0.25 0.5 0.5 0.25 0.25 0.5 + 0.375 0.375 0.25 0.375 0.25 0.375 0.25 0.375 0.375 0.25 0.25 0.25 + 0.375 0.375 0.25 0.375 0.25 0.375 0.25 0.25 0.25 0.5 0.25 0.25 + 0.5 0.375 0.375 0.375 0.375 0.25 0.375 0.25 0.375 0.25 0.375 0.375 + 0.375 0.375 0.25 0.5 0.375 0.375 0.375 0.25 0.375 0.5 0.25 0.25 + 0.25 0.375 0.375 0.375 0.375 0.25 0.25 0.25 0.25 0.25 0.5 0.25 + 0.375 0.375 0.25 0.25 0.375 0.375 0.375 0.625 0.25 0.25 0.5 0.25 + 0.5 0.25 0.25 0.5 0.5 0.25 0.375 0.375 0.25 0.5 0.375 0.375 + 0.5 0.375 0.375 0.375 0.375 0.25 0.375 0.625 0.25 0.5 0.5 0.25 + 0.5 0.375 0.375 0.375 0.375 0.25 0.25 0.375 0.375 0.375 0.625 0.25 + 0.375 0.25 0.375 0.25 0.375 0.375 0.25 0.25 0.25 0.25 0.25 0.5 + 0.25 0.375 0.375 0.375 0.25 0.375 0.375 0.375 0.5 0.25 0.25 0.5 + 0.375 0.25 0.375 0.5 0.375 0.375 0.5 0.25 0.5 0.5 0.25 0.25 + 0.375 0.25 0.375 0.5 0.375 0.375 0.25 0.375 0.375 0.375 0.375 0.5 + 0.375 0.25 0.375 0.375 0.375 0.5 0.25 0.25 0.5 0.5 0.25 0.5 + 0.375 0.25 0.375 0.5 0.375 0.375 0.375 0.375 0.5 0.5 0.25 0.5 + 0.25 0.375 0.375 0.375 0.625 0.25 0.25 0.5 0.5 0.375 0.375 0.5 + 0.25 0.5 0.5 0.25 0.375 0.375 0.375 0.375 0.5 0.25 0.25 0.5 + 0.25 0.375 0.375 0.5 0.375 0.375 0.375 0.625 0.25 0.375 0.375 0.5 + 0.5 0.375 0.375 0.375 0.625 0.25 0.375 0.375 0.5 0.5 0.5 0.5 + 0.5 0.25 0.5 0.5 0.5 0.5 0.5 0.375 0.375 0.375 0.375 0.5 + 0.5 0.220238 0 0.5 0 0 0.75 0 0 0.5 0.25 0.15 + 0.75 0 0 0.5 0 0 0.5 0 0.220238 0.5 0.25 0.15 + 0.708333 0.291667 0 0.5 0.220238 0 0.75 0 0 0.5 0.25 0.15 + 0.75 0 0 0.708333 0.291667 0 0.5 0.25 0.15 0.75 0.25 0.25 + 0.5 0 0.220238 0.75 0 0 0.5 0.25 0.15 0.708333 0 0.291667 + 0.5 0.25 0.15 0.5 0 0.220238 0.708333 0 0.291667 0.5 0.25 0.25 + 0.708333 0 0.291667 0.5 0.25 0.15 0.5 0.25 0.25 0.75 0.25 0.25 + 0.75 0 0 0.5 0.25 0.15 0.708333 0 0.291667 0.75 0.25 0.25 + 1 0 0 0.75 0 0 0.838542 0 0.161458 0.838542 0.161458 0 + 0.75 0 0 0.838542 0 0.161458 0.838542 0.161458 0 0.75 0.25 0.25 + 0.838542 0 0.161458 1 0 0 0.838542 0.161458 0 1 0.161458 0.161458 + 0.708333 0.291667 0 0.75 0 0 0.838542 0.161458 0 0.75 0.25 0.25 + 0.838542 0.161458 0 0.708333 0.291667 0 0.75 0.25 0.25 1 0.25 0 + 0.838542 0.161458 0 1 0 0 1 0.25 0 1 0.161458 0.161458 + 0.75 0.25 0.25 0.838542 0.161458 0 1 0.25 0 1 0.161458 0.161458 + 0.75 0 0 0.708333 0 0.291667 0.838542 0 0.161458 0.75 0.25 0.25 + 0.708333 0 0.291667 1 0 0.25 0.838542 0 0.161458 0.75 0.25 0.25 + 1 0 0.25 1 0 0 0.838542 0 0.161458 1 0.161458 0.161458 + 1 0 0.25 0.838542 0 0.161458 0.75 0.25 0.25 1 0.161458 0.161458 + 0.838542 0 0.161458 0.838542 0.161458 0 0.75 0.25 0.25 1 0.161458 0.161458 + 1 0.291667 0.291667 0.75 0.25 0.25 1 0.25 0 1 0.161458 0.161458 + 1 0.291667 0.291667 1 0 0.25 0.75 0.25 0.25 1 0.161458 0.161458 + 0.708333 0.291667 0 0.5 0.5 0 0.5 0.220238 0 0.5 0.25 0.15 + 0.5 0.5 0.15 0.5 0.5 0 0.779762 0.5 0 0.708333 0.291667 0 + 0.5 0.25 0.15 0.5 0.5 0.15 0.708333 0.291667 0 0.5 0.5 0 + 0.5 0.5 0.15 0.779762 0.5 0 0.625 0.375 0.25 0.708333 0.291667 0 + 0.5 0.25 0.15 0.5 0.5 0.15 0.625 0.375 0.25 0.708333 0.291667 0 + 0.5 0.25 0.15 0.625 0.375 0.25 0.5 0.25 0.25 0.75 0.25 0.25 + 0.625 0.375 0.25 0.5 0.375 0.2 0.5 0.25 0.15 0.5 0.25 0.25 + 0.708333 0.291667 0 0.625 0.375 0.25 0.5 0.25 0.15 0.75 0.25 0.25 + 0.75 0.25 0.25 0.625 0.375 0.25 0.779762 0.5 0 0.708333 0.291667 0 + 0.5 0.25 0.15 0.625 0.375 0.25 0.5 0.5 0.15 0.5 0.375 0.2 + 0.5 0.5 0.25 0.625 0.375 0.25 0.5 0.25 0.25 0.5 0.375 0.2 + 0.5 0.5 0.25 0.5 0.5 0.15 0.625 0.375 0.25 0.5 0.375 0.2 + 0.75 0.5 0.25 0.5 0.5 0.15 0.779762 0.5 0 0.625 0.375 0.25 + 0.75 0.25 0.25 0.779762 0.5 0 0.625 0.375 0.25 0.75 0.5 0.25 + 0.708333 0.291667 0 0.779762 0.5 0 0.75 0.25 0.25 1 0.25 0 + 0.779762 0.5 0 1 0.5 0.220238 0.75 0.25 0.25 1 0.25 0 + 1 0.5 0.220238 0.779762 0.5 0 1 0.5 0 1 0.25 0 + 1 0.5 0.220238 1 0.291667 0.291667 0.75 0.25 0.25 1 0.25 0 + 1 0.5 0.220238 0.75 0.5 0.25 0.779762 0.5 0 0.75 0.25 0.25 + 0.708333 0 0.291667 0.5 0 0.220238 0.5 0 0.5 0.625 0.25 0.375 + 0.708333 0 0.291667 0.5 0 0.220238 0.625 0.25 0.375 0.5 0.25 0.25 + 0.5 0 0.220238 0.5 0 0.5 0.625 0.25 0.375 0.5 0.25 0.25 + 0.625 0.25 0.375 0.708333 0 0.291667 0.5 0.25 0.25 0.75 0.25 0.25 + 0.75 0.25 0.25 0.779762 0 0.5 0.625 0.25 0.375 0.708333 0 0.291667 + 0.779762 0 0.5 0.708333 0 0.291667 0.5 0 0.5 0.625 0.25 0.375 + 0.5 0 0.5 0.5 0.25 0.5 0.625 0.25 0.375 0.5 0.25 0.25 + 0.5 0.25 0.5 0.5 0 0.5 0.625 0.25 0.375 0.75 0.25 0.5 + 0.75 0.25 0.25 0.625 0.25 0.375 0.779762 0 0.5 0.75 0.25 0.5 + 0.5 0 0.5 0.779762 0 0.5 0.625 0.25 0.375 0.75 0.25 0.5 + 0.708333 0 0.291667 0.779762 0 0.5 1 0 0.25 0.75 0.25 0.25 + 1 0.291667 0.291667 1 0 0.25 1 0.220238 0.5 0.75 0.25 0.25 + 1 0 0.25 0.779762 0 0.5 1 0.220238 0.5 0.75 0.25 0.25 + 0.779762 0 0.5 1 0 0.5 1 0 0.25 1 0.220238 0.5 + 1 0.220238 0.5 0.779762 0 0.5 0.75 0.25 0.5 0.75 0.25 0.25 + 0.5 0.375 0.375 0.625 0.375 0.25 0.625 0.25 0.375 0.5 0.25 0.25 + 0.625 0.375 0.25 0.625 0.25 0.375 0.5 0.25 0.25 0.75 0.25 0.25 + 0.5 0.375 0.375 0.75 0.375 0.375 0.625 0.25 0.375 0.625 0.375 0.25 + 0.625 0.375 0.25 0.75 0.375 0.375 0.625 0.25 0.375 0.75 0.25 0.25 + 0.625 0.375 0.25 0.5 0.5 0.25 0.5 0.25 0.25 0.5 0.375 0.375 + 0.625 0.625 0.25 0.5 0.375 0.375 0.5 0.5 0.25 0.625 0.375 0.25 + 0.75 0.5 0.25 0.75 0.375 0.375 0.625 0.375 0.25 0.75 0.25 0.25 + 0.5 0.375 0.375 0.625 0.625 0.25 0.75 0.5 0.25 0.625 0.375 0.25 + 0.5 0.375 0.375 0.75 0.5 0.25 0.75 0.375 0.375 0.625 0.375 0.25 + 0.5 0.25 0.5 0.5 0.375 0.375 0.625 0.25 0.375 0.5 0.25 0.25 + 0.5 0.375 0.375 0.625 0.375 0.5 0.5 0.25 0.5 0.625 0.25 0.375 + 0.625 0.25 0.375 0.75 0.375 0.375 0.75 0.25 0.5 0.75 0.25 0.25 + 0.75 0.375 0.375 0.5 0.375 0.375 0.625 0.25 0.375 0.625 0.375 0.5 + 0.625 0.375 0.5 0.5 0.25 0.5 0.625 0.25 0.375 0.75 0.25 0.5 + 0.75 0.375 0.375 0.625 0.375 0.5 0.625 0.25 0.375 0.75 0.25 0.5 + 0.5 0.5 0.5 0.625 0.375 0.5 0.5 0.25 0.5 0.5 0.375 0.375 + 0.5 0.375 0.375 0.75 0.625 0.375 0.5 0.5 0.5 0.625 0.375 0.5 + 0.75 0.5 0.25 0.5 0.375 0.375 0.75 0.375 0.375 0.625 0.375 0.5 + 0.75 0.625 0.375 0.5 0.375 0.375 0.75 0.5 0.25 0.625 0.375 0.5 + 0.75 0.625 0.375 0.75 0.5 0.25 0.75 0.375 0.375 0.625 0.375 0.5 + 0.75 0.375 0.375 0.75 0.5 0.5 0.625 0.375 0.5 0.75 0.25 0.5 + 0.75 0.5 0.5 0.75 0.625 0.375 0.75 0.375 0.375 0.625 0.375 0.5 + 0.75 0.375 0.375 0.75 0.25 0.25 1 0.5 0.220238 1 0.291667 0.291667 + 1 0.220238 0.5 0.75 0.25 0.25 0.75 0.375 0.375 1 0.291667 0.291667 + 1 0.5 0.220238 0.75 0.25 0.25 0.75 0.375 0.375 0.75 0.5 0.25 + 1 0.5 0.5 1 0.5 0.220238 1 0.291667 0.291667 0.75 0.375 0.375 + 1 0.5 0.5 0.75 0.5 0.25 1 0.5 0.220238 0.75 0.375 0.375 + 0.75 0.375 0.375 0.75 0.25 0.25 1 0.220238 0.5 0.75 0.25 0.5 + 1 0.291667 0.291667 1 0.5 0.5 0.75 0.375 0.375 1 0.220238 0.5 + 1 0.5 0.5 0.75 0.375 0.375 1 0.220238 0.5 0.75 0.25 0.5 + 1 0.5 0.5 0.75 0.5 0.5 0.75 0.375 0.375 0.75 0.25 0.5 + 0 0.5 0.220238 0 0.5 0 0 0.75 0 0.220238 0.5 0 + 0 0.5 0.220238 0 0.75 0 0.291667 0.708333 0 0.220238 0.5 0 + 0.291667 0.708333 0 0.25 0.5 0.25 0 0.5 0.220238 0.220238 0.5 0 + 0.291667 0.708333 0 0 0.75 0 0 0.5 0.220238 0.25 0.75 0.25 + 0 0.5 0.220238 0.25 0.5 0.25 0.291667 0.708333 0 0.25 0.75 0.25 + 0 0.75 0 0 0.5 0.220238 0.25 0.75 0.25 0 0.708333 0.291667 + 0.220238 0.5 0 0.5 0.5 0.15 0.291667 0.708333 0 0.375 0.625 0.25 + 0.5 0.5 0.15 0.220238 0.5 0 0.291667 0.708333 0 0.5 0.5 0 + 0.5 0.75 0.15 0.5 0.5 0.15 0.291667 0.708333 0 0.5 0.5 0 + 0.291667 0.708333 0 0.5 0.779762 0 0.5 0.75 0.15 0.5 0.5 0 + 0.220238 0.5 0 0.5 0.5 0.15 0.375 0.625 0.25 0.25 0.5 0.25 + 0.291667 0.708333 0 0.220238 0.5 0 0.375 0.625 0.25 0.25 0.5 0.25 + 0.5 0.5 0.15 0.375 0.375 0.25 0.375 0.625 0.25 0.25 0.5 0.25 + 0.375 0.375 0.25 0.5 0.5 0.15 0.375 0.625 0.25 0.5 0.5 0.25 + 0.5 0.5 0.15 0.375 0.625 0.25 0.5 0.5 0.25 0.5 0.625 0.2 + 0.375 0.625 0.25 0.291667 0.708333 0 0.25 0.75 0.25 0.5 0.75 0.15 + 0.291667 0.708333 0 0.375 0.625 0.25 0.25 0.75 0.25 0.25 0.5 0.25 + 0.5 0.5 0.15 0.375 0.625 0.25 0.5 0.75 0.15 0.291667 0.708333 0 + 0.5 0.5 0.15 0.5 0.75 0.15 0.375 0.625 0.25 0.5 0.625 0.2 + 0.375 0.625 0.25 0.5 0.75 0.25 0.5 0.5 0.25 0.5 0.625 0.2 + 0.25 0.75 0.25 0.375 0.625 0.25 0.5 0.75 0.15 0.5 0.75 0.25 + 0.375 0.625 0.25 0.5 0.75 0.15 0.5 0.75 0.25 0.5 0.625 0.2 + 0 0.838542 0.161458 0 0.75 0 0 1 0 0.161458 0.838542 0 + 0 0.838542 0.161458 0 0.75 0 0.161458 0.838542 0 0.25 0.75 0.25 + 0 0.75 0 0.291667 0.708333 0 0.161458 0.838542 0 0.25 0.75 0.25 + 0.291667 0.708333 0 0.25 1 0 0.161458 0.838542 0 0.25 0.75 0.25 + 0 0.838542 0.161458 0 1 0 0.154679 1 0.154679 0.161458 0.838542 0 + 0 1 0 0.25 1 0 0.154679 1 0.154679 0.161458 0.838542 0 + 0.25 1 0 0.154679 1 0.154679 0.161458 0.838542 0 0.25 0.75 0.25 + 0 0.838542 0.161458 0 0.75 0 0.25 0.75 0.25 0 0.708333 0.291667 + 0 1 0.25 0 0.838542 0.161458 0.25 0.75 0.25 0 0.708333 0.291667 + 0.154679 1 0.154679 0 0.838542 0.161458 0.161458 0.838542 0 0.25 0.75 0.25 + 0 1 0.25 0 0.838542 0.161458 0 1 0 0.154679 1 0.154679 + 0 1 0.25 0 0.838542 0.161458 0.154679 1 0.154679 0.25 0.75 0.25 + 0.25 1 0 0.291667 1 0.291667 0.154679 1 0.154679 0.25 0.75 0.25 + 0.291667 1 0.291667 0 1 0.25 0.154679 1 0.154679 0.25 0.75 0.25 + 0.291667 0.708333 0 0.25 1 0 0.25 0.75 0.25 0.5 0.75 0.15 + 0.25 1 0 0.291667 0.708333 0 0.5 0.779762 0 0.5 0.75 0.15 + 0.5 1 0 0.25 1 0 0.5 0.779762 0 0.5 0.75 0.15 + 0.25 1 0 0.5 1 0 0.5 1 0.220238 0.5 0.75 0.15 + 0.291667 1 0.291667 0.25 0.75 0.25 0.5 0.75 0.15 0.5 0.75 0.25 + 0.25 1 0 0.291667 1 0.291667 0.25 0.75 0.25 0.5 0.75 0.15 + 0.291667 1 0.291667 0.25 1 0 0.5 1 0.220238 0.5 0.75 0.15 + 0.5 1 0.220238 0.291667 1 0.291667 0.5 0.75 0.15 0.5 0.75 0.25 + 0 0.5 0.5 0 0.5 0.220238 0 0.708333 0.291667 0.25 0.625 0.375 + 0.25 0.75 0.25 0.25 0.625 0.375 0 0.5 0.220238 0.25 0.5 0.25 + 0 0.5 0.5 0 0.5 0.220238 0.25 0.625 0.375 0.25 0.5 0.25 + 0.25 0.75 0.25 0 0.5 0.220238 0.25 0.625 0.375 0 0.708333 0.291667 + 0.25 0.75 0.25 0 0.708333 0.291667 0.25 0.625 0.375 0.25 0.75 0.5 + 0.25 0.625 0.375 0 0.5 0.5 0.25 0.5 0.25 0.25 0.5 0.5 + 0.25 0.625 0.375 0 0.5 0.5 0.25 0.5 0.5 0.25 0.75 0.5 + 0 0.708333 0.291667 0 0.5 0.5 0.25 0.625 0.375 0 0.779762 0.5 + 0.25 0.625 0.375 0 0.708333 0.291667 0 0.779762 0.5 0.25 0.75 0.5 + 0 0.5 0.5 0.25 0.625 0.375 0 0.779762 0.5 0.25 0.75 0.5 + 0.25 0.375 0.375 0.375 0.625 0.25 0.25 0.5 0.25 0.25 0.5 0.5 + 0.375 0.625 0.25 0.25 0.625 0.375 0.25 0.5 0.25 0.25 0.5 0.5 + 0.5 0.375 0.375 0.375 0.625 0.25 0.5 0.5 0.5 0.5 0.5 0.25 + 0.375 0.625 0.25 0.5 0.625 0.375 0.5 0.5 0.5 0.5 0.5 0.25 + 0.25 0.75 0.25 0.375 0.625 0.25 0.25 0.625 0.375 0.25 0.5 0.25 + 0.375 0.625 0.25 0.375 0.75 0.375 0.25 0.75 0.25 0.25 0.625 0.375 + 0.5 0.75 0.25 0.375 0.625 0.25 0.5 0.5 0.25 0.5 0.625 0.375 + 0.375 0.75 0.375 0.375 0.625 0.25 0.25 0.75 0.25 0.5 0.75 0.25 + 0.375 0.625 0.25 0.375 0.75 0.375 0.5 0.625 0.375 0.5 0.75 0.25 + 0.375 0.625 0.25 0.25 0.625 0.375 0.25 0.5 0.5 0.375 0.625 0.5 + 0.25 0.5 0.5 0.375 0.625 0.25 0.375 0.625 0.5 0.375 0.375 0.5 + 0.375 0.625 0.5 0.375 0.625 0.25 0.5 0.625 0.375 0.5 0.5 0.5 + 0.375 0.625 0.25 0.375 0.625 0.5 0.375 0.375 0.5 0.5 0.5 0.5 + 0.375 0.625 0.25 0.375 0.75 0.375 0.25 0.625 0.375 0.375 0.625 0.5 + 0.375 0.75 0.375 0.25 0.75 0.25 0.25 0.625 0.375 0.25 0.75 0.5 + 0.25 0.625 0.375 0.25 0.5 0.5 0.375 0.625 0.5 0.25 0.75 0.5 + 0.375 0.75 0.375 0.25 0.625 0.375 0.375 0.625 0.5 0.25 0.75 0.5 + 0.375 0.625 0.25 0.375 0.75 0.375 0.375 0.625 0.5 0.5 0.625 0.375 + 0.5 0.75 0.25 0.5 0.75 0.5 0.375 0.75 0.375 0.5 0.625 0.375 + 0.375 0.625 0.5 0.5 0.75 0.5 0.5 0.5 0.5 0.5 0.625 0.375 + 0.375 0.625 0.5 0.375 0.75 0.375 0.25 0.75 0.5 0.5 0.75 0.5 + 0.375 0.75 0.375 0.375 0.625 0.5 0.5 0.625 0.375 0.5 0.75 0.5 + 0 1 0.25 0.220238 1 0.5 0 0.708333 0.291667 0.25 0.75 0.25 + 0 1 0.25 0.291667 1 0.291667 0.220238 1 0.5 0.25 0.75 0.25 + 0 1 0.25 0 0.708333 0.291667 0.220238 1 0.5 0 0.779762 0.5 + 0.25 0.75 0.5 0.220238 1 0.5 0 0.708333 0.291667 0 0.779762 0.5 + 0.25 0.75 0.5 0 0.708333 0.291667 0.220238 1 0.5 0.25 0.75 0.25 + 0 1 0.5 0 1 0.25 0.220238 1 0.5 0 0.779762 0.5 + 0.291667 1 0.291667 0.375 0.75 0.375 0.25 0.75 0.25 0.5 0.75 0.25 + 0.25 0.75 0.25 0.220238 1 0.5 0.375 0.75 0.375 0.291667 1 0.291667 + 0.375 0.75 0.375 0.291667 1 0.291667 0.5 1 0.220238 0.5 0.75 0.25 + 0.5 1 0.5 0.375 0.75 0.375 0.5 1 0.220238 0.5 0.75 0.25 + 0.375 0.75 0.375 0.291667 1 0.291667 0.5 1 0.5 0.5 1 0.220238 + 0.25 0.75 0.25 0.375 0.75 0.375 0.220238 1 0.5 0.25 0.75 0.5 + 0.5 0.75 0.25 0.5 0.75 0.5 0.5 1 0.5 0.375 0.75 0.375 + 0.375 0.75 0.375 0.5 1 0.5 0.25 0.75 0.5 0.5 0.75 0.5 + 0.291667 1 0.291667 0.375 0.75 0.375 0.5 1 0.5 0.220238 1 0.5 + 0.375 0.75 0.375 0.5 1 0.5 0.220238 1 0.5 0.25 0.75 0.5 + 0.708333 0.708333 0 0.5 0.5 0.15 0.5 0.5 0 0.779762 0.5 0 + 0.5 0.5 0.15 0.5 0.75 0.15 0.708333 0.708333 0 0.5 0.5 0 + 0.625 0.625 0.25 0.5 0.5 0.15 0.708333 0.708333 0 0.779762 0.5 0 + 0.5 0.75 0.15 0.5 0.779762 0 0.708333 0.708333 0 0.5 0.5 0 + 0.5 0.5 0.15 0.625 0.625 0.25 0.5 0.5 0.25 0.625 0.375 0.25 + 0.625 0.625 0.25 0.5 0.5 0.15 0.5 0.5 0.25 0.5 0.625 0.2 + 0.5 0.5 0.15 0.625 0.625 0.25 0.75 0.5 0.25 0.779762 0.5 0 + 0.625 0.625 0.25 0.5 0.5 0.15 0.75 0.5 0.25 0.625 0.375 0.25 + 0.779762 0.5 0 0.75 0.75 0.25 0.625 0.625 0.25 0.75 0.5 0.25 + 0.5 0.5 0.15 0.5 0.75 0.15 0.625 0.625 0.25 0.708333 0.708333 0 + 0.5 0.5 0.15 0.625 0.625 0.25 0.5 0.75 0.15 0.5 0.625 0.2 + 0.5 0.5 0.25 0.5 0.75 0.25 0.625 0.625 0.25 0.5 0.625 0.2 + 0.5 0.75 0.15 0.625 0.625 0.25 0.5 0.75 0.25 0.5 0.625 0.2 + 0.625 0.625 0.25 0.5 0.75 0.15 0.5 0.75 0.25 0.75 0.75 0.25 + 0.779762 0.5 0 0.625 0.625 0.25 0.75 0.75 0.25 0.708333 0.708333 0 + 0.5 0.75 0.15 0.625 0.625 0.25 0.708333 0.708333 0 0.75 0.75 0.25 + 1 0.75 0 1 0.5 0.220238 0.779762 0.5 0 1 0.5 0 + 1 0.5 0.220238 0.75 0.75 0.25 1 0.75 0 0.779762 0.5 0 + 0.75 0.75 0.25 0.708333 0.708333 0 1 0.75 0 0.779762 0.5 0 + 1 0.5 0.220238 0.75 0.5 0.25 0.75 0.75 0.25 0.779762 0.5 0 + 1 0.708333 0.291667 1 0.5 0.220238 0.75 0.75 0.25 1 0.75 0 + 0.5 0.779762 0 0.75 1 0 0.5 0.75 0.15 0.708333 0.708333 0 + 0.75 1 0 0.5 0.75 0.15 0.708333 0.708333 0 0.75 0.75 0.25 + 0.75 1 0 0.5 1 0 0.5 0.779762 0 0.5 0.75 0.15 + 0.5 1 0 0.75 1 0 0.5 1 0.220238 0.5 0.75 0.15 + 0.5 0.75 0.15 0.708333 1 0.291667 0.5 0.75 0.25 0.75 0.75 0.25 + 0.75 1 0 0.708333 1 0.291667 0.5 1 0.220238 0.5 0.75 0.15 + 0.708333 1 0.291667 0.5 1 0.220238 0.5 0.75 0.15 0.5 0.75 0.25 + 0.75 1 0 0.708333 1 0.291667 0.5 0.75 0.15 0.75 0.75 0.25 + 0.708333 0.708333 0 0.848032 0.848032 0 0.75 0.75 0.25 1 0.75 0 + 0.848032 0.848032 0 0.75 1 0 0.708333 0.708333 0 0.75 0.75 0.25 + 0.848032 0.848032 0 1 1 0 1 0.838542 0.161458 1 0.75 0 + 0.848032 0.848032 0 1 0.838542 0.161458 0.75 0.75 0.25 1 0.75 0 + 0.75 1 0 1 1 0 0.838542 1 0.161458 0.848032 0.848032 0 + 0.838542 1 0.161458 0.75 1 0 0.848032 0.848032 0 0.75 0.75 0.25 + 1 1 0 0.838542 1 0.161458 0.848032 0.848032 0 1 0.838542 0.161458 + 0.838542 1 0.161458 0.848032 0.848032 0 1 0.838542 0.161458 0.75 0.75 0.25 + 1 0.838542 0.161458 1 0.708333 0.291667 0.75 0.75 0.25 1 0.75 0 + 1 0.708333 0.291667 1 1 0.25 1 0.838542 0.161458 0.75 0.75 0.25 + 0.708333 1 0.291667 0.75 1 0 0.838542 1 0.161458 0.75 0.75 0.25 + 0.708333 1 0.291667 0.838542 1 0.161458 1 1 0.25 0.75 0.75 0.25 + 0.838542 1 0.161458 1 1 0 1 1 0.25 1 0.838542 0.161458 + 1 1 0.25 0.838542 1 0.161458 1 0.838542 0.161458 0.75 0.75 0.25 + 0.5 0.375 0.375 0.5 0.5 0.5 0.625 0.625 0.25 0.5 0.5 0.25 + 0.5 0.5 0.5 0.5 0.625 0.375 0.625 0.625 0.25 0.5 0.5 0.25 + 0.75 0.625 0.375 0.5 0.375 0.375 0.625 0.625 0.25 0.75 0.5 0.25 + 0.5 0.5 0.25 0.5 0.75 0.25 0.5 0.625 0.375 0.625 0.625 0.25 + 0.5 0.625 0.375 0.625 0.75 0.375 0.625 0.625 0.25 0.5 0.75 0.25 + 0.625 0.625 0.25 0.75 0.625 0.375 0.75 0.5 0.25 0.75 0.75 0.25 + 0.625 0.75 0.375 0.625 0.625 0.25 0.5 0.75 0.25 0.75 0.75 0.25 + 0.75 0.625 0.375 0.5 0.625 0.375 0.625 0.75 0.375 0.625 0.625 0.25 + 0.625 0.75 0.375 0.75 0.625 0.375 0.625 0.625 0.25 0.75 0.75 0.25 + 0.75 0.625 0.375 0.5 0.375 0.375 0.5 0.5 0.5 0.625 0.625 0.25 + 0.5 0.625 0.375 0.75 0.625 0.375 0.5 0.5 0.5 0.625 0.625 0.25 + 0.75 0.625 0.375 0.5 0.625 0.375 0.5 0.5 0.5 0.625 0.625 0.5 + 0.75 0.625 0.375 0.75 0.5 0.5 0.5 0.5 0.5 0.625 0.375 0.5 + 0.75 0.5 0.5 0.75 0.625 0.375 0.5 0.5 0.5 0.625 0.625 0.5 + 0.5 0.75 0.25 0.5 0.75 0.5 0.5 0.625 0.375 0.625 0.75 0.375 + 0.5 0.5 0.5 0.5 0.75 0.5 0.625 0.625 0.5 0.5 0.625 0.375 + 0.5 0.625 0.375 0.625 0.625 0.5 0.625 0.75 0.375 0.5 0.75 0.5 + 0.75 0.625 0.375 0.5 0.625 0.375 0.625 0.625 0.5 0.625 0.75 0.375 + 0.75 0.625 0.375 0.625 0.75 0.375 0.75 0.75 0.5 0.75 0.75 0.25 + 0.75 0.5 0.5 0.75 0.625 0.375 0.625 0.625 0.5 0.75 0.75 0.5 + 0.625 0.625 0.5 0.625 0.75 0.375 0.5 0.75 0.5 0.75 0.75 0.5 + 0.625 0.625 0.5 0.75 0.625 0.375 0.625 0.75 0.375 0.75 0.75 0.5 + 0.75 0.75 0.25 1 0.5 0.220238 0.75 0.625 0.375 0.75 0.5 0.25 + 1 0.5 0.5 0.75 0.625 0.375 0.75 0.5 0.25 0.75 0.375 0.375 + 0.75 0.625 0.375 1 0.5 0.5 0.75 0.5 0.25 1 0.5 0.220238 + 1 0.708333 0.291667 1 0.5 0.5 0.75 0.625 0.375 1 0.5 0.220238 + 0.75 0.75 0.25 0.75 0.625 0.375 1 0.5 0.220238 1 0.708333 0.291667 + 0.75 0.75 0.25 1 0.779762 0.5 0.75 0.625 0.375 1 0.708333 0.291667 + 1 0.5 0.5 0.75 0.5 0.5 0.75 0.625 0.375 0.75 0.375 0.375 + 0.75 0.5 0.5 1 0.5 0.5 0.75 0.625 0.375 0.75 0.75 0.5 + 0.75 0.75 0.25 0.75 0.625 0.375 1 0.779762 0.5 0.75 0.75 0.5 + 1 0.5 0.5 1 0.779762 0.5 1 0.708333 0.291667 0.75 0.625 0.375 + 1 0.5 0.5 1 0.779762 0.5 0.75 0.625 0.375 0.75 0.75 0.5 + 0.708333 1 0.291667 0.625 0.75 0.375 0.5 0.75 0.25 0.75 0.75 0.25 + 0.708333 1 0.291667 0.625 0.75 0.375 0.5 1 0.220238 0.5 0.75 0.25 + 0.625 0.75 0.375 0.5 1 0.5 0.5 1 0.220238 0.5 0.75 0.25 + 0.625 0.75 0.375 0.5 1 0.5 0.708333 1 0.291667 0.5 1 0.220238 + 0.779762 1 0.5 0.75 0.75 0.25 0.625 0.75 0.375 0.708333 1 0.291667 + 0.5 0.75 0.5 0.5 0.75 0.25 0.5 1 0.5 0.625 0.75 0.375 + 0.625 0.75 0.375 0.5 1 0.5 0.5 0.75 0.5 0.75 0.75 0.5 + 0.625 0.75 0.375 0.75 0.75 0.25 0.779762 1 0.5 0.75 0.75 0.5 + 0.5 1 0.5 0.779762 1 0.5 0.625 0.75 0.375 0.708333 1 0.291667 + 0.779762 1 0.5 0.5 1 0.5 0.625 0.75 0.375 0.75 0.75 0.5 + 1 0.708333 0.291667 1 0.779762 0.5 1 1 0.25 0.75 0.75 0.25 + 0.779762 1 0.5 0.708333 1 0.291667 1 1 0.25 0.75 0.75 0.25 + 1 0.779762 0.5 0.779762 1 0.5 1 1 0.25 0.75 0.75 0.25 + 0.779762 1 0.5 1 0.779762 0.5 0.75 0.75 0.5 0.75 0.75 0.25 + 1 0.779762 0.5 0.779762 1 0.5 1 1 0.5 1 1 0.25 + 0 0.220238 0.5 0.220238 0 0.5 0 0 0.75 0 0 0.5 + 0.220238 0 0.5 0 0.220238 0.5 0 0.291667 0.708333 0.25 0.25 0.5 + 0.220238 0 0.5 0 0.220238 0.5 0 0 0.75 0 0.291667 0.708333 + 0.220238 0 0.5 0 0.291667 0.708333 0.291667 0 0.708333 0.25 0.25 0.5 + 0 0 0.75 0.220238 0 0.5 0 0.291667 0.708333 0.291667 0 0.708333 + 0 0.291667 0.708333 0.291667 0 0.708333 0.25 0.25 0.5 0.314392 0.330902 0.762922 + 0.291667 0 0.708333 0.220238 0 0.5 0.25 0.25 0.5 0.5 0 0.5 + 0.25 0.25 0.5 0.5 0.25 0.6 0.5 0 0.5 0.5 0.25 0.5 + 0.291667 0 0.708333 0.25 0.25 0.5 0.5 0.25 0.6 0.5 0 0.5 + 0.5 0 0.779762 0.291667 0 0.708333 0.5 0.25 0.6 0.5 0 0.5 + 0.291667 0 0.708333 0.5 0.25 0.6 0.25 0.25 0.5 0.314392 0.330902 0.762922 + 0.291667 0 0.708333 0.5 0 0.779762 0.5 0.25 0.6 0.314392 0.330902 0.762922 + 0 0.220238 0.5 0 0.5 0.5 0 0.291667 0.708333 0.25 0.25 0.5 + 0 0.291667 0.708333 0.25 0.25 0.5 0.25 0.5 0.5 0.314392 0.330902 0.762922 + 0 0.5 0.5 0.25 0.5 0.5 0 0.5 0.779762 0 0.291667 0.708333 + 0 0.5 0.5 0.25 0.5 0.5 0 0.291667 0.708333 0.25 0.25 0.5 + 0.25 0.5 0.5 0 0.5 0.779762 0 0.291667 0.708333 0.314392 0.330902 0.762922 + 0 0.5 0.779762 0.314392 0.330902 0.762922 0.25 0.5 0.5 0.355 0.625 0.73125 + 0.375 0.375 0.5 0.25 0.25 0.5 0.5 0.25 0.6 0.314392 0.330902 0.762922 + 0.25 0.5 0.5 0.25 0.25 0.5 0.375 0.375 0.5 0.314392 0.330902 0.762922 + 0.25 0.25 0.5 0.375 0.375 0.5 0.5 0.25 0.6 0.5 0.25 0.5 + 0.5 0.25 0.6 0.375 0.375 0.5 0.5 0.375 0.55 0.5 0.25 0.5 + 0.375 0.375 0.5 0.5 0.25 0.6 0.5 0.375 0.55 0.314392 0.330902 0.762922 + 0.25 0.5 0.5 0.375 0.375 0.5 0.5 0.5 0.6 0.314392 0.330902 0.762922 + 0.5 0.25 0.5 0.5 0.5 0.5 0.375 0.375 0.5 0.5 0.375 0.55 + 0.5 0.375 0.55 0.375 0.375 0.5 0.5 0.5 0.6 0.5 0.5 0.5 + 0.375 0.375 0.5 0.5 0.375 0.55 0.5 0.5 0.6 0.314392 0.330902 0.762922 + 0.5 0.25 0.6 0.645 0.375 0.73125 0.5 0.375 0.55 0.314392 0.330902 0.762922 + 0.25 0.5 0.5 0.314392 0.330902 0.762922 0.5 0.5 0.6 0.355 0.625 0.73125 + 0.5 0.375 0.55 0.645 0.375 0.73125 0.5 0.5 0.6 0.314392 0.330902 0.762922 + 0 0.161458 0.838542 0.161458 0 0.838542 0 0 0.75 0 0.291667 0.708333 + 0.161458 0 0.838542 0 0 0.75 0 0.291667 0.708333 0.291667 0 0.708333 + 0 0.161458 0.838542 0.161458 0 0.838542 0 0 1 0 0 0.75 + 0.161458 0 0.838542 0 0.291667 0.708333 0 0.161458 0.838542 0.314392 0.330902 0.762922 + 0.161458 0 0.838542 0.291667 0 0.708333 0 0.291667 0.708333 0.314392 0.330902 0.762922 + 0.161458 0 0.838542 0 0.161458 0.838542 0.291667 0.291667 1 0.314392 0.330902 0.762922 + 0 0.161458 0.838542 0.161458 0 0.838542 0.161458 0.161458 1 0 0 1 + 0.161458 0 0.838542 0.291667 0.291667 1 0.25 0 1 0.291667 0 0.708333 + 0.161458 0.161458 1 0.161458 0 0.838542 0.25 0 1 0 0 1 + 0.161458 0 0.838542 0.291667 0.291667 1 0.161458 0.161458 1 0.25 0 1 + 0 0.25 1 0.291667 0.291667 1 0 0.161458 0.838542 0 0.291667 0.708333 + 0 0.25 1 0 0.161458 0.838542 0.161458 0.161458 1 0 0 1 + 0 0.25 1 0 0.161458 0.838542 0.291667 0.291667 1 0.161458 0.161458 1 + 0.161458 0 0.838542 0.291667 0.291667 1 0 0.161458 0.838542 0.161458 0.161458 1 + 0.291667 0.291667 1 0.25 0 1 0.291667 0 0.708333 0.5 0 0.779762 + 0.291667 0.291667 1 0.291667 0 0.708333 0.161458 0 0.838542 0.314392 0.330902 0.762922 + 0.291667 0 0.708333 0.291667 0.291667 1 0.5 0 0.779762 0.314392 0.330902 0.762922 + 0.5 0.220238 1 0.5 0.25 0.6 0.5 0 0.779762 0.314392 0.330902 0.762922 + 0.5 0 1 0.25 0 1 0.5 0.220238 1 0.5 0 0.779762 + 0.291667 0.291667 1 0.5 0.220238 1 0.5 0 0.779762 0.314392 0.330902 0.762922 + 0.25 0 1 0.291667 0.291667 1 0.5 0.220238 1 0.5 0 0.779762 + 0.314392 0.330902 0.762922 0 0.161458 0.838542 0.291667 0.291667 1 0 0.291667 0.708333 + 0.291667 0.291667 1 0 0.291667 0.708333 0.220238 0.5 1 0.314392 0.330902 0.762922 + 0.220238 0.5 1 0 0.25 1 0 0.5 0.779762 0 0.291667 0.708333 + 0.220238 0.5 1 0 0.291667 0.708333 0 0.5 0.779762 0.314392 0.330902 0.762922 + 0.220238 0.5 1 0.314392 0.330902 0.762922 0 0.5 0.779762 0.355 0.625 0.73125 + 0.220238 0.5 1 0.291667 0.291667 1 0 0.25 1 0 0.291667 0.708333 + 0.220238 0.5 1 0 0.25 1 0 0.5 1 0 0.5 0.779762 + 0.5 0.220238 1 0.645 0.375 0.73125 0.5 0.25 0.6 0.314392 0.330902 0.762922 + 0.5 0.5 1 0.645 0.375 0.73125 0.5 0.220238 1 0.314392 0.330902 0.762922 + 0.220238 0.5 1 0.5 0.5 1 0.314392 0.330902 0.762922 0.355 0.625 0.73125 + 0.5 0.5 0.6 0.645 0.375 0.73125 0.5 0.5 1 0.314392 0.330902 0.762922 + 0.5 0.5 0.6 0.314392 0.330902 0.762922 0.5 0.5 1 0.355 0.625 0.73125 + 0.291667 0.291667 1 0.5 0.5 1 0.5 0.220238 1 0.314392 0.330902 0.762922 + 0.291667 0.291667 1 0.220238 0.5 1 0.5 0.5 1 0.314392 0.330902 0.762922 + 0.708333 0 0.708333 0.779762 0 0.5 0.5 0 0.5 0.75 0.25 0.5 + 0.5 0.25 0.6 0.5 0 0.5 0.5 0.25 0.5 0.75 0.25 0.5 + 0.5 0.25 0.6 0.708333 0 0.708333 0.5 0 0.5 0.75 0.25 0.5 + 0.708333 0 0.708333 0.5 0 0.779762 0.5 0.25 0.6 0.5 0 0.5 + 0.5 0 0.779762 0.708333 0 0.708333 0.5 0.25 0.6 0.645 0.375 0.73125 + 0.708333 0 0.708333 0.75 0.25 0.5 0.5 0.25 0.6 0.645 0.375 0.73125 + 0.779762 0 0.5 0.708333 0 0.708333 1 0.220238 0.5 0.75 0.25 0.5 + 0.779762 0 0.5 0.708333 0 0.708333 1 0 0.75 1 0.220238 0.5 + 1 0 0.5 0.779762 0 0.5 1 0 0.75 1 0.220238 0.5 + 0.708333 0 0.708333 1 0.291667 0.708333 1 0.220238 0.5 0.75 0.25 0.5 + 0.708333 0 0.708333 1 0.291667 0.708333 0.75 0.25 0.5 0.645 0.375 0.73125 + 0.708333 0 0.708333 1 0.161458 0.838542 1 0.291667 0.708333 0.645 0.375 0.73125 + 0.708333 0 0.708333 1 0.291667 0.708333 1 0 0.75 1 0.220238 0.5 + 0.625 0.375 0.5 0.5 0.25 0.6 0.5 0.25 0.5 0.75 0.25 0.5 + 0.5 0.25 0.6 0.5 0.375 0.55 0.625 0.375 0.5 0.5 0.25 0.5 + 0.5 0.25 0.6 0.625 0.375 0.5 0.5 0.375 0.55 0.645 0.375 0.73125 + 0.5 0.25 0.6 0.75 0.25 0.5 0.625 0.375 0.5 0.645 0.375 0.73125 + 0.625 0.375 0.5 0.5 0.5 0.5 0.5 0.25 0.5 0.5 0.375 0.55 + 0.5 0.5 0.6 0.5 0.375 0.55 0.5 0.5 0.5 0.625 0.375 0.5 + 0.75 0.5 0.5 0.5 0.5 0.6 0.5 0.5 0.5 0.625 0.375 0.5 + 0.5 0.375 0.55 0.625 0.375 0.5 0.5 0.5 0.6 0.645 0.375 0.73125 + 0.75 0.5 0.5 0.625 0.375 0.5 0.75 0.25 0.5 0.645 0.375 0.73125 + 0.5 0.5 0.6 0.625 0.375 0.5 0.75 0.5 0.5 0.645 0.375 0.73125 + 0.75 0.5 0.5 0.75 0.25 0.5 1 0.291667 0.708333 0.645 0.375 0.73125 + 1 0.291667 0.708333 1 0.5 0.5 1 0.220238 0.5 0.75 0.25 0.5 + 1 0.5 0.5 1 0.291667 0.708333 0.75 0.5 0.5 0.75 0.25 0.5 + 1 0.291667 0.708333 1 0.5 0.779762 1 0.5 0.5 0.75 0.5 0.5 + 1 0.291667 0.708333 1 0.5 0.779762 0.75 0.5 0.5 0.645 0.375 0.73125 + 0.5 0.220238 1 0.75 0 1 0.5 0 0.779762 0.708333 0 0.708333 + 0.5 0 0.779762 0.5 0.220238 1 0.708333 0 0.708333 0.645 0.375 0.73125 + 0.5 0 0.779762 0.5 0.25 0.6 0.5 0.220238 1 0.645 0.375 0.73125 + 0.645 0.375 0.73125 0.838542 0 0.838542 0.708333 0.291667 1 0.708333 0 0.708333 + 0.5 0.220238 1 0.708333 0.291667 1 0.708333 0 0.708333 0.645 0.375 0.73125 + 0.75 0 1 0.5 0 1 0.5 0.220238 1 0.5 0 0.779762 + 0.708333 0.291667 1 0.75 0 1 0.5 0.220238 1 0.708333 0 0.708333 + 0.838542 0 0.838542 0.708333 0 0.708333 1 0.161458 0.838542 1 0 0.75 + 0.708333 0 0.708333 1 0.291667 0.708333 1 0.161458 0.838542 1 0 0.75 + 1 0 1 0.838542 0 0.838542 1 0.161458 0.838542 1 0 0.75 + 0.838542 0 0.838542 1 0.161458 0.838542 0.708333 0 0.708333 0.645 0.375 0.73125 + 1 0.161458 0.838542 0.838542 0 0.838542 0.708333 0.291667 1 0.645 0.375 0.73125 + 0.75 0 1 0.708333 0.291667 1 0.838542 0 0.838542 0.708333 0 0.708333 + 0.75 0 1 0.838542 0 0.838542 0.838542 0.161458 1 1 0 1 + 0.75 0 1 0.838542 0 0.838542 0.708333 0.291667 1 0.838542 0.161458 1 + 0.838542 0 0.838542 0.838542 0.161458 1 1 0 1 1 0.161458 0.838542 + 1 0.161458 0.838542 0.708333 0.291667 1 0.838542 0 0.838542 0.838542 0.161458 1 + 0.708333 0.291667 1 1 0.291667 0.708333 1 0.25 1 1 0.161458 0.838542 + 1 0 1 0.838542 0.161458 1 1 0.25 1 1 0.161458 0.838542 + 0.838542 0.161458 1 0.708333 0.291667 1 1 0.25 1 1 0.161458 0.838542 + 0.5 0.5 1 0.708333 0.291667 1 0.5 0.220238 1 0.645 0.375 0.73125 + 0.708333 0.291667 1 0.5 0.5 1 0.779762 0.5 1 0.645 0.375 0.73125 + 1 0.291667 0.708333 0.708333 0.291667 1 1 0.5 0.779762 0.645 0.375 0.73125 + 0.708333 0.291667 1 1 0.291667 0.708333 1 0.161458 0.838542 0.645 0.375 0.73125 + 1 0.291667 0.708333 0.708333 0.291667 1 1 0.25 1 1 0.5 0.779762 + 1 0.5 0.779762 0.708333 0.291667 1 0.779762 0.5 1 0.645 0.375 0.73125 + 0.708333 0.291667 1 1 0.25 1 1 0.5 0.779762 0.779762 0.5 1 + 1 0.5 0.779762 1 0.25 1 1 0.5 1 0.779762 0.5 1 + 0 0.708333 0.708333 0 0.5 0.5 0.25 0.5 0.5 0 0.5 0.779762 + 0 0.5 0.5 0 0.708333 0.708333 0.25 0.5 0.5 0.25 0.75 0.5 + 0 0.708333 0.708333 0 0.5 0.5 0 0.779762 0.5 0.25 0.75 0.5 + 0.25 0.5 0.5 0.25 0.75 0.5 0 0.708333 0.708333 0.355 0.625 0.73125 + 0 0.708333 0.708333 0 0.5 0.779762 0.25 0.5 0.5 0.355 0.625 0.73125 + 0.25 0.5 0.5 0.5 0.5 0.6 0.375 0.625 0.5 0.355 0.625 0.73125 + 0.375 0.625 0.5 0.25 0.5 0.5 0.375 0.375 0.5 0.5 0.5 0.6 + 0.375 0.375 0.5 0.375 0.625 0.5 0.5 0.5 0.6 0.5 0.5 0.5 + 0.5 0.5 0.6 0.375 0.625 0.5 0.5 0.625 0.55 0.5 0.5 0.5 + 0.375 0.625 0.5 0.5 0.5 0.6 0.5 0.625 0.55 0.355 0.625 0.73125 + 0.25 0.5 0.5 0.375 0.625 0.5 0.25 0.75 0.5 0.355 0.625 0.73125 + 0.375 0.625 0.5 0.5 0.75 0.6 0.25 0.75 0.5 0.355 0.625 0.73125 + 0.5 0.75 0.5 0.375 0.625 0.5 0.5 0.5 0.5 0.5 0.625 0.55 + 0.375 0.625 0.5 0.25 0.75 0.5 0.5 0.75 0.6 0.5 0.75 0.5 + 0.375 0.625 0.5 0.5 0.75 0.6 0.5 0.625 0.55 0.5 0.75 0.5 + 0.375 0.625 0.5 0.5 0.625 0.55 0.5 0.75 0.6 0.355 0.625 0.73125 + 0.291667 1 0.708333 0 0.708333 0.708333 0 0.779762 0.5 0.25 0.75 0.5 + 0 1 0.5 0.220238 1 0.5 0 1 0.75 0 0.779762 0.5 + 0.220238 1 0.5 0.291667 1 0.708333 0 0.779762 0.5 0.25 0.75 0.5 + 0.220238 1 0.5 0.291667 1 0.708333 0 1 0.75 0 0.779762 0.5 + 0.291667 1 0.708333 0 0.708333 0.708333 0 1 0.75 0 0.779762 0.5 + 0.291667 1 0.708333 0 0.708333 0.708333 0.25 0.75 0.5 0.355 0.625 0.73125 + 0 0.708333 0.708333 0.291667 1 0.708333 0 0.838542 0.838542 0.355 0.625 0.73125 + 0.25 0.75 0.5 0.5 1 0.5 0.5 0.75 0.6 0.5 0.75 0.5 + 0.220238 1 0.5 0.5 1 0.5 0.291667 1 0.708333 0.25 0.75 0.5 + 0.5 1 0.5 0.291667 1 0.708333 0.25 0.75 0.5 0.5 0.75 0.6 + 0.25 0.75 0.5 0.5 0.75 0.6 0.291667 1 0.708333 0.355 0.625 0.73125 + 0.291667 1 0.708333 0.5 0.75 0.6 0.5 1 0.779762 0.355 0.625 0.73125 + 0.291667 1 0.708333 0.5 1 0.5 0.5 1 0.779762 0.5 0.75 0.6 + 0 0.75 1 0 0.708333 0.708333 0.291667 0.708333 1 0 0.5 0.779762 + 0 0.708333 0.708333 0.291667 0.708333 1 0 0.5 0.779762 0.355 0.625 0.73125 + 0 0.708333 0.708333 0 0.838542 0.838542 0.291667 0.708333 1 0.355 0.625 0.73125 + 0 0.75 1 0.220238 0.5 1 0 0.5 1 0 0.5 0.779762 + 0.220238 0.5 1 0 0.5 0.779762 0.291667 0.708333 1 0.355 0.625 0.73125 + 0.220238 0.5 1 0 0.75 1 0.291667 0.708333 1 0 0.5 0.779762 + 0.5 0.75 0.6 0.645 0.625 0.73125 0.5 0.779762 1 0.355 0.625 0.73125 + 0.5 0.779762 1 0.645 0.625 0.73125 0.5 0.5 1 0.355 0.625 0.73125 + 0.220238 0.5 1 0.291667 0.708333 1 0.5 0.5 1 0.355 0.625 0.73125 + 0.291667 0.708333 1 0.5 0.779762 1 0.5 0.5 1 0.355 0.625 0.73125 + 0.291667 1 0.708333 0.161458 1 0.838542 0 0.838542 0.838542 0.355 0.625 0.73125 + 0.161458 1 0.838542 0.291667 0.708333 1 0 0.838542 0.838542 0.355 0.625 0.73125 + 0 0.708333 0.708333 0.291667 1 0.708333 0 1 0.75 0 0.838542 0.838542 + 0.291667 1 0.708333 0 1 0.75 0 0.838542 0.838542 0.161458 1 0.838542 + 0 0.838542 0.838542 0 1 0.75 0 1 1 0.161458 1 0.838542 + 0 0.75 1 0 0.708333 0.708333 0 0.838542 0.838542 0.291667 0.708333 1 + 0 0.75 1 0 0.838542 0.838542 0.161458 0.838542 1 0.291667 0.708333 1 + 0 0.838542 0.838542 0 0.75 1 0.161458 0.838542 1 0 1 1 + 0 0.838542 0.838542 0.291667 0.708333 1 0.161458 1 0.838542 0.161458 0.838542 1 + 0.161458 0.838542 1 0 0.838542 0.838542 0 1 1 0.161458 1 0.838542 + 0.25 1 1 0.291667 0.708333 1 0.161458 1 0.838542 0.291667 1 0.708333 + 0.25 1 1 0.161458 1 0.838542 0.291667 0.708333 1 0.161458 0.838542 1 + 0.25 1 1 0.161458 0.838542 1 0 1 1 0.161458 1 0.838542 + 0.291667 1 0.708333 0.5 0.779762 1 0.291667 0.708333 1 0.355 0.625 0.73125 + 0.355 0.625 0.73125 0.161458 1 0.838542 0.291667 0.708333 1 0.291667 1 0.708333 + 0.5 0.779762 1 0.5 1 0.779762 0.5 0.75 0.6 0.355 0.625 0.73125 + 0.5 0.779762 1 0.291667 1 0.708333 0.5 1 0.779762 0.355 0.625 0.73125 + 0.291667 1 0.708333 0.25 1 1 0.5 0.779762 1 0.5 1 0.779762 + 0.25 1 1 0.291667 1 0.708333 0.5 0.779762 1 0.291667 0.708333 1 + 0.25 1 1 0.5 0.779762 1 0.5 1 0.779762 0.5 1 1 + 0.5 0.5 0.6 0.75 0.5 0.5 0.5 0.5 0.5 0.625 0.625 0.5 + 0.5 0.625 0.55 0.5 0.5 0.6 0.5 0.5 0.5 0.625 0.625 0.5 + 0.5 0.5 0.6 0.625 0.625 0.5 0.5 0.625 0.55 0.645 0.625 0.73125 + 0.5 0.5 0.6 0.75 0.5 0.5 0.625 0.625 0.5 0.645 0.625 0.73125 + 0.5 0.5 0.5 0.5 0.75 0.5 0.5 0.625 0.55 0.625 0.625 0.5 + 0.5 0.625 0.55 0.5 0.75 0.6 0.625 0.625 0.5 0.5 0.75 0.5 + 0.5 0.75 0.6 0.625 0.625 0.5 0.5 0.75 0.5 0.75 0.75 0.5 + 0.5 0.75 0.6 0.5 0.625 0.55 0.625 0.625 0.5 0.645 0.625 0.73125 + 0.75 0.5 0.5 0.75 0.75 0.5 0.625 0.625 0.5 0.645 0.625 0.73125 + 0.5 0.75 0.6 0.625 0.625 0.5 0.75 0.75 0.5 0.645 0.625 0.73125 + 0.5 0.5 0.6 0.645 0.625 0.73125 0.5 0.625 0.55 0.355 0.625 0.73125 + 0.5 0.5 0.6 0.645 0.375 0.73125 0.75 0.5 0.5 0.645 0.625 0.73125 + 0.5 0.75 0.6 0.5 0.625 0.55 0.645 0.625 0.73125 0.355 0.625 0.73125 + 1 0.708333 0.708333 1 0.5 0.5 0.75 0.5 0.5 0.75 0.75 0.5 + 1 0.5 0.779762 1 0.708333 0.708333 1 0.5 0.5 0.75 0.5 0.5 + 1 0.708333 0.708333 0.75 0.75 0.5 0.75 0.5 0.5 0.645 0.625 0.73125 + 1 0.708333 0.708333 1 0.779762 0.5 1 0.5 0.5 0.75 0.75 0.5 + 1 0.5 0.779762 0.75 0.5 0.5 0.645 0.375 0.73125 0.645 0.625 0.73125 + 1 0.5 0.779762 1 0.708333 0.708333 0.75 0.5 0.5 0.645 0.625 0.73125 + 0.5 1 0.5 0.5 0.75 0.6 0.5 0.75 0.5 0.75 0.75 0.5 + 0.5 1 0.5 0.708333 1 0.708333 0.5 0.75 0.6 0.75 0.75 0.5 + 0.5 1 0.5 0.779762 1 0.5 0.708333 1 0.708333 0.75 0.75 0.5 + 0.5 1 0.779762 0.5 0.75 0.6 0.708333 1 0.708333 0.645 0.625 0.73125 + 0.708333 1 0.708333 0.5 0.75 0.6 0.75 0.75 0.5 0.645 0.625 0.73125 + 0.5 1 0.779762 0.5 1 0.5 0.708333 1 0.708333 0.5 0.75 0.6 + 0.708333 1 0.708333 0.779762 1 0.5 1 0.708333 0.708333 0.75 0.75 0.5 + 0.779762 1 0.5 1 0.779762 0.5 1 0.708333 0.708333 0.75 0.75 0.5 + 1 0.779762 0.5 1 1 0.75 0.779762 1 0.5 1 0.708333 0.708333 + 1 1 0.75 1 0.779762 0.5 0.779762 1 0.5 1 1 0.5 + 0.708333 1 0.708333 0.75 0.75 0.5 1 0.708333 0.708333 0.645 0.625 0.73125 + 0.838542 1 0.838542 0.708333 1 0.708333 1 0.708333 0.708333 0.645 0.625 0.73125 + 0.779762 1 0.5 1 1 0.75 0.708333 1 0.708333 1 0.708333 0.708333 + 0.5 0.5 1 0.645 0.375 0.73125 0.5 0.5 0.6 0.645 0.625 0.73125 + 0.5 0.5 1 0.645 0.625 0.73125 0.5 0.5 0.6 0.355 0.625 0.73125 + 0.779762 0.5 1 0.645 0.375 0.73125 0.5 0.5 1 0.645 0.625 0.73125 + 0.779762 0.5 1 0.5 0.5 1 0.708333 0.708333 1 0.645 0.625 0.73125 + 0.5 0.5 1 0.5 0.779762 1 0.708333 0.708333 1 0.645 0.625 0.73125 + 1 0.5 0.779762 0.645 0.375 0.73125 0.779762 0.5 1 0.645 0.625 0.73125 + 1 0.5 0.779762 0.779762 0.5 1 1 0.708333 0.708333 0.645 0.625 0.73125 + 1 0.5 0.779762 0.779762 0.5 1 1 0.75 1 1 0.708333 0.708333 + 0.779762 0.5 1 0.708333 0.708333 1 1 0.708333 0.708333 0.645 0.625 0.73125 + 0.645 0.625 0.73125 1 0.848032 0.848032 0.708333 0.708333 1 1 0.708333 0.708333 + 1 0.5 1 1 0.5 0.779762 0.779762 0.5 1 1 0.75 1 + 1 0.75 1 0.779762 0.5 1 0.708333 0.708333 1 1 0.708333 0.708333 + 0.5 0.779762 1 0.5 0.75 0.6 0.5 1 0.779762 0.645 0.625 0.73125 + 0.708333 0.708333 1 0.5 1 0.779762 0.708333 1 0.708333 0.645 0.625 0.73125 + 0.838542 1 0.838542 0.708333 0.708333 1 0.708333 1 0.708333 0.645 0.625 0.73125 + 0.5 1 0.779762 0.75 1 1 0.708333 0.708333 1 0.708333 1 0.708333 + 0.5 0.779762 1 0.5 1 0.779762 0.708333 0.708333 1 0.645 0.625 0.73125 + 0.75 1 1 0.5 0.779762 1 0.5 1 0.779762 0.708333 0.708333 1 + 0.5 0.779762 1 0.75 1 1 0.5 1 0.779762 0.5 1 1 + 0.838542 1 0.838542 1 0.708333 0.708333 1 0.848032 0.848032 0.645 0.625 0.73125 + 0.838542 1 0.838542 1 0.848032 0.848032 0.708333 0.708333 1 0.645 0.625 0.73125 + 1 1 0.75 0.838542 1 0.838542 0.708333 1 0.708333 1 0.708333 0.708333 + 1 0.848032 0.848032 0.838542 1 0.838542 1 1 0.75 1 0.708333 0.708333 + 0.838542 1 0.838542 1 1 1 1 0.848032 0.848032 1 1 0.75 + 0.838542 1 0.838542 0.708333 0.708333 1 1 0.848032 0.848032 0.838542 0.838542 1 + 1 0.75 1 0.708333 0.708333 1 1 0.848032 0.848032 1 0.708333 0.708333 + 1 0.75 1 1 0.848032 0.848032 0.708333 0.708333 1 0.838542 0.838542 1 + 1 0.75 1 1 1 1 1 0.848032 0.848032 0.838542 0.838542 1 + 0.75 1 1 0.838542 1 0.838542 0.708333 0.708333 1 0.708333 1 0.708333 + 0.838542 1 0.838542 0.75 1 1 0.708333 0.708333 1 0.838542 0.838542 1 + 0.75 1 1 0.838542 1 0.838542 1 1 1 0.838542 0.838542 1 + 1 1 1 0.838542 1 0.838542 1 0.848032 0.848032 0.838542 0.838542 1 + + + + + 0 1 2 3 4 5 6 7 8 9 10 11 + 12 13 14 15 16 17 18 19 20 21 22 23 + 24 25 26 27 28 29 30 31 32 33 34 35 + 36 37 38 39 40 41 42 43 44 45 46 47 + 48 49 50 51 52 53 54 55 56 57 58 59 + 60 61 62 63 64 65 66 67 68 69 70 71 + 72 73 74 75 76 77 78 79 80 81 82 83 + 84 85 86 87 88 89 90 91 92 93 94 95 + 96 97 98 99 100 101 102 103 104 105 106 107 + 108 109 110 111 112 113 114 115 116 117 118 119 + 120 121 122 123 124 125 126 127 128 129 130 131 + 132 133 134 135 136 137 138 139 140 141 142 143 + 144 145 146 147 148 149 150 151 152 153 154 155 + 156 157 158 159 160 161 162 163 164 165 166 167 + 168 169 170 171 172 173 174 175 176 177 178 179 + 180 181 182 183 184 185 186 187 188 189 190 191 + 192 193 194 195 196 197 198 199 200 201 202 203 + 204 205 206 207 208 209 210 211 212 213 214 215 + 216 217 218 219 220 221 222 223 224 225 226 227 + 228 229 230 231 232 233 234 235 236 237 238 239 + 240 241 242 243 244 245 246 247 248 249 250 251 + 252 253 254 255 256 257 258 259 260 261 262 263 + 264 265 266 267 268 269 270 271 272 273 274 275 + 276 277 278 279 280 281 282 283 284 285 286 287 + 288 289 290 291 292 293 294 295 296 297 298 299 + 300 301 302 303 304 305 306 307 308 309 310 311 + 312 313 314 315 316 317 318 319 320 321 322 323 + 324 325 326 327 328 329 330 331 332 333 334 335 + 336 337 338 339 340 341 342 343 344 345 346 347 + 348 349 350 351 352 353 354 355 356 357 358 359 + 360 361 362 363 364 365 366 367 368 369 370 371 + 372 373 374 375 376 377 378 379 380 381 382 383 + 384 385 386 387 388 389 390 391 392 393 394 395 + 396 397 398 399 400 401 402 403 404 405 406 407 + 408 409 410 411 412 413 414 415 416 417 418 419 + 420 421 422 423 424 425 426 427 428 429 430 431 + 432 433 434 435 436 437 438 439 440 441 442 443 + 444 445 446 447 448 449 450 451 452 453 454 455 + 456 457 458 459 460 461 462 463 464 465 466 467 + 468 469 470 471 472 473 474 475 476 477 478 479 + 480 481 482 483 484 485 486 487 488 489 490 491 + 492 493 494 495 496 497 498 499 500 501 502 503 + 504 505 506 507 508 509 510 511 512 513 514 515 + 516 517 518 519 520 521 522 523 524 525 526 527 + 528 529 530 531 532 533 534 535 536 537 538 539 + 540 541 542 543 544 545 546 547 548 549 550 551 + 552 553 554 555 556 557 558 559 560 561 562 563 + 564 565 566 567 568 569 570 571 572 573 574 575 + 576 577 578 579 580 581 582 583 584 585 586 587 + 588 589 590 591 592 593 594 595 596 597 598 599 + 600 601 602 603 604 605 606 607 608 609 610 611 + 612 613 614 615 616 617 618 619 620 621 622 623 + 624 625 626 627 628 629 630 631 632 633 634 635 + 636 637 638 639 640 641 642 643 644 645 646 647 + 648 649 650 651 652 653 654 655 656 657 658 659 + 660 661 662 663 664 665 666 667 668 669 670 671 + 672 673 674 675 676 677 678 679 680 681 682 683 + 684 685 686 687 688 689 690 691 692 693 694 695 + 696 697 698 699 700 701 702 703 704 705 706 707 + 708 709 710 711 712 713 714 715 716 717 718 719 + 720 721 722 723 724 725 726 727 728 729 730 731 + 732 733 734 735 736 737 738 739 740 741 742 743 + 744 745 746 747 748 749 750 751 752 753 754 755 + 756 757 758 759 760 761 762 763 764 765 766 767 + 768 769 770 771 772 773 774 775 776 777 778 779 + 780 781 782 783 784 785 786 787 788 789 790 791 + 792 793 794 795 796 797 798 799 800 801 802 803 + 804 805 806 807 808 809 810 811 812 813 814 815 + 816 817 818 819 820 821 822 823 824 825 826 827 + 828 829 830 831 832 833 834 835 836 837 838 839 + 840 841 842 843 844 845 846 847 848 849 850 851 + 852 853 854 855 856 857 858 859 860 861 862 863 + 864 865 866 867 868 869 870 871 872 873 874 875 + 876 877 878 879 880 881 882 883 884 885 886 887 + 888 889 890 891 892 893 894 895 896 897 898 899 + 900 901 902 903 904 905 906 907 908 909 910 911 + 912 913 914 915 916 917 918 919 920 921 922 923 + 924 925 926 927 928 929 930 931 932 933 934 935 + 936 937 938 939 940 941 942 943 944 945 946 947 + 948 949 950 951 952 953 954 955 956 957 958 959 + 960 961 962 963 964 965 966 967 968 969 970 971 + 972 973 974 975 976 977 978 979 980 981 982 983 + 984 985 986 987 988 989 990 991 992 993 994 995 + 996 997 998 999 1000 1001 1002 1003 1004 1005 1006 1007 + 1008 1009 1010 1011 1012 1013 1014 1015 1016 1017 1018 1019 + 1020 1021 1022 1023 1024 1025 1026 1027 1028 1029 1030 1031 + 1032 1033 1034 1035 1036 1037 1038 1039 1040 1041 1042 1043 + 1044 1045 1046 1047 1048 1049 1050 1051 1052 1053 1054 1055 + 1056 1057 1058 1059 1060 1061 1062 1063 1064 1065 1066 1067 + 1068 1069 1070 1071 1072 1073 1074 1075 1076 1077 1078 1079 + 1080 1081 1082 1083 1084 1085 1086 1087 1088 1089 1090 1091 + 1092 1093 1094 1095 1096 1097 1098 1099 1100 1101 1102 1103 + 1104 1105 1106 1107 1108 1109 1110 1111 1112 1113 1114 1115 + 1116 1117 1118 1119 1120 1121 1122 1123 1124 1125 1126 1127 + 1128 1129 1130 1131 1132 1133 1134 1135 1136 1137 1138 1139 + 1140 1141 1142 1143 1144 1145 1146 1147 1148 1149 1150 1151 + 1152 1153 1154 1155 1156 1157 1158 1159 1160 1161 1162 1163 + 1164 1165 1166 1167 1168 1169 1170 1171 1172 1173 1174 1175 + 1176 1177 1178 1179 1180 1181 1182 1183 1184 1185 1186 1187 + 1188 1189 1190 1191 1192 1193 1194 1195 1196 1197 1198 1199 + 1200 1201 1202 1203 1204 1205 1206 1207 1208 1209 1210 1211 + 1212 1213 1214 1215 1216 1217 1218 1219 1220 1221 1222 1223 + 1224 1225 1226 1227 1228 1229 1230 1231 1232 1233 1234 1235 + 1236 1237 1238 1239 1240 1241 1242 1243 1244 1245 1246 1247 + 1248 1249 1250 1251 1252 1253 1254 1255 1256 1257 1258 1259 + 1260 1261 1262 1263 1264 1265 1266 1267 1268 1269 1270 1271 + 1272 1273 1274 1275 1276 1277 1278 1279 1280 1281 1282 1283 + 1284 1285 1286 1287 1288 1289 1290 1291 1292 1293 1294 1295 + 1296 1297 1298 1299 1300 1301 1302 1303 1304 1305 1306 1307 + 1308 1309 1310 1311 1312 1313 1314 1315 1316 1317 1318 1319 + 1320 1321 1322 1323 1324 1325 1326 1327 1328 1329 1330 1331 + 1332 1333 1334 1335 1336 1337 1338 1339 1340 1341 1342 1343 + 1344 1345 1346 1347 1348 1349 1350 1351 1352 1353 1354 1355 + 1356 1357 1358 1359 1360 1361 1362 1363 1364 1365 1366 1367 + 1368 1369 1370 1371 1372 1373 1374 1375 1376 1377 1378 1379 + 1380 1381 1382 1383 1384 1385 1386 1387 1388 1389 1390 1391 + 1392 1393 1394 1395 1396 1397 1398 1399 1400 1401 1402 1403 + 1404 1405 1406 1407 1408 1409 1410 1411 1412 1413 1414 1415 + 1416 1417 1418 1419 1420 1421 1422 1423 1424 1425 1426 1427 + 1428 1429 1430 1431 1432 1433 1434 1435 1436 1437 1438 1439 + 1440 1441 1442 1443 1444 1445 1446 1447 1448 1449 1450 1451 + 1452 1453 1454 1455 1456 1457 1458 1459 1460 1461 1462 1463 + 1464 1465 1466 1467 1468 1469 1470 1471 1472 1473 1474 1475 + 1476 1477 1478 1479 1480 1481 1482 1483 1484 1485 1486 1487 + 1488 1489 1490 1491 1492 1493 1494 1495 1496 1497 1498 1499 + 1500 1501 1502 1503 1504 1505 1506 1507 1508 1509 1510 1511 + 1512 1513 1514 1515 1516 1517 1518 1519 1520 1521 1522 1523 + 1524 1525 1526 1527 1528 1529 1530 1531 1532 1533 1534 1535 + 1536 1537 1538 1539 1540 1541 1542 1543 1544 1545 1546 1547 + 1548 1549 1550 1551 1552 1553 1554 1555 1556 1557 1558 1559 + 1560 1561 1562 1563 1564 1565 1566 1567 1568 1569 1570 1571 + 1572 1573 1574 1575 1576 1577 1578 1579 1580 1581 1582 1583 + 1584 1585 1586 1587 1588 1589 1590 1591 1592 1593 1594 1595 + 1596 1597 1598 1599 1600 1601 1602 1603 1604 1605 1606 1607 + 1608 1609 1610 1611 1612 1613 1614 1615 1616 1617 1618 1619 + 1620 1621 1622 1623 1624 1625 1626 1627 1628 1629 1630 1631 + 1632 1633 1634 1635 1636 1637 1638 1639 1640 1641 1642 1643 + 1644 1645 1646 1647 1648 1649 1650 1651 1652 1653 1654 1655 + 1656 1657 1658 1659 1660 1661 1662 1663 1664 1665 1666 1667 + 1668 1669 1670 1671 1672 1673 1674 1675 1676 1677 1678 1679 + 1680 1681 1682 1683 1684 1685 1686 1687 1688 1689 1690 1691 + 1692 1693 1694 1695 1696 1697 1698 1699 1700 1701 1702 1703 + 1704 1705 1706 1707 1708 1709 1710 1711 1712 1713 1714 1715 + 1716 1717 1718 1719 1720 1721 1722 1723 1724 1725 1726 1727 + 1728 1729 1730 1731 1732 1733 1734 1735 1736 1737 1738 1739 + 1740 1741 1742 1743 1744 1745 1746 1747 1748 1749 1750 1751 + 1752 1753 1754 1755 1756 1757 1758 1759 1760 1761 1762 1763 + 1764 1765 1766 1767 1768 1769 1770 1771 1772 1773 1774 1775 + 1776 1777 1778 1779 1780 1781 1782 1783 1784 1785 1786 1787 + 1788 1789 1790 1791 1792 1793 1794 1795 1796 1797 1798 1799 + 1800 1801 1802 1803 1804 1805 1806 1807 1808 1809 1810 1811 + 1812 1813 1814 1815 1816 1817 1818 1819 1820 1821 1822 1823 + 1824 1825 1826 1827 1828 1829 1830 1831 1832 1833 1834 1835 + 1836 1837 1838 1839 1840 1841 1842 1843 1844 1845 1846 1847 + 1848 1849 1850 1851 1852 1853 1854 1855 1856 1857 1858 1859 + 1860 1861 1862 1863 1864 1865 1866 1867 1868 1869 1870 1871 + 1872 1873 1874 1875 1876 1877 1878 1879 1880 1881 1882 1883 + 1884 1885 1886 1887 1888 1889 1890 1891 1892 1893 1894 1895 + 1896 1897 1898 1899 1900 1901 1902 1903 1904 1905 1906 1907 + 1908 1909 1910 1911 1912 1913 1914 1915 1916 1917 1918 1919 + 1920 1921 1922 1923 1924 1925 1926 1927 1928 1929 1930 1931 + 1932 1933 1934 1935 1936 1937 1938 1939 1940 1941 1942 1943 + 1944 1945 1946 1947 1948 1949 1950 1951 1952 1953 1954 1955 + 1956 1957 1958 1959 1960 1961 1962 1963 1964 1965 1966 1967 + 1968 1969 1970 1971 1972 1973 1974 1975 1976 1977 1978 1979 + 1980 1981 1982 1983 1984 1985 1986 1987 1988 1989 1990 1991 + 1992 1993 1994 1995 1996 1997 1998 1999 2000 2001 2002 2003 + 2004 2005 2006 2007 2008 2009 2010 2011 2012 2013 2014 2015 + 2016 2017 2018 2019 2020 2021 2022 2023 2024 2025 2026 2027 + 2028 2029 2030 2031 2032 2033 2034 2035 2036 2037 2038 2039 + 2040 2041 2042 2043 2044 2045 2046 2047 2048 2049 2050 2051 + 2052 2053 2054 2055 2056 2057 2058 2059 2060 2061 2062 2063 + 2064 2065 2066 2067 2068 2069 2070 2071 2072 2073 2074 2075 + 2076 2077 2078 2079 2080 2081 2082 2083 2084 2085 2086 2087 + 2088 2089 2090 2091 2092 2093 2094 2095 2096 2097 2098 2099 + 2100 2101 2102 2103 2104 2105 2106 2107 2108 2109 2110 2111 + 2112 2113 2114 2115 2116 2117 2118 2119 2120 2121 2122 2123 + 2124 2125 2126 2127 2128 2129 2130 2131 2132 2133 2134 2135 + 2136 2137 2138 2139 2140 2141 2142 2143 2144 2145 2146 2147 + 2148 2149 2150 2151 2152 2153 2154 2155 2156 2157 2158 2159 + 2160 2161 2162 2163 2164 2165 2166 2167 2168 2169 2170 2171 + 2172 2173 2174 2175 2176 2177 2178 2179 2180 2181 2182 2183 + 2184 2185 2186 2187 2188 2189 2190 2191 2192 2193 2194 2195 + 2196 2197 2198 2199 2200 2201 2202 2203 2204 2205 2206 2207 + 2208 2209 2210 2211 2212 2213 2214 2215 2216 2217 2218 2219 + 2220 2221 2222 2223 2224 2225 2226 2227 2228 2229 2230 2231 + 2232 2233 2234 2235 2236 2237 2238 2239 2240 2241 2242 2243 + 2244 2245 2246 2247 2248 2249 2250 2251 2252 2253 2254 2255 + 2256 2257 2258 2259 2260 2261 2262 2263 2264 2265 2266 2267 + 2268 2269 2270 2271 2272 2273 2274 2275 2276 2277 2278 2279 + 2280 2281 2282 2283 2284 2285 2286 2287 2288 2289 2290 2291 + 2292 2293 2294 2295 2296 2297 2298 2299 2300 2301 2302 2303 + 2304 2305 2306 2307 2308 2309 2310 2311 2312 2313 2314 2315 + 2316 2317 2318 2319 2320 2321 2322 2323 2324 2325 2326 2327 + 2328 2329 2330 2331 2332 2333 2334 2335 2336 2337 2338 2339 + 2340 2341 2342 2343 2344 2345 2346 2347 2348 2349 2350 2351 + 2352 2353 2354 2355 2356 2357 2358 2359 2360 2361 2362 2363 + 2364 2365 2366 2367 2368 2369 2370 2371 2372 2373 2374 2375 + 2376 2377 2378 2379 2380 2381 2382 2383 2384 2385 2386 2387 + 2388 2389 2390 2391 2392 2393 2394 2395 2396 2397 2398 2399 + 2400 2401 2402 2403 2404 2405 2406 2407 + + + 4 8 12 16 20 24 28 32 36 40 44 48 + 52 56 60 64 68 72 76 80 84 88 92 96 + 100 104 108 112 116 120 124 128 132 136 140 144 + 148 152 156 160 164 168 172 176 180 184 188 192 + 196 200 204 208 212 216 220 224 228 232 236 240 + 244 248 252 256 260 264 268 272 276 280 284 288 + 292 296 300 304 308 312 316 320 324 328 332 336 + 340 344 348 352 356 360 364 368 372 376 380 384 + 388 392 396 400 404 408 412 416 420 424 428 432 + 436 440 444 448 452 456 460 464 468 472 476 480 + 484 488 492 496 500 504 508 512 516 520 524 528 + 532 536 540 544 548 552 556 560 564 568 572 576 + 580 584 588 592 596 600 604 608 612 616 620 624 + 628 632 636 640 644 648 652 656 660 664 668 672 + 676 680 684 688 692 696 700 704 708 712 716 720 + 724 728 732 736 740 744 748 752 756 760 764 768 + 772 776 780 784 788 792 796 800 804 808 812 816 + 820 824 828 832 836 840 844 848 852 856 860 864 + 868 872 876 880 884 888 892 896 900 904 908 912 + 916 920 924 928 932 936 940 944 948 952 956 960 + 964 968 972 976 980 984 988 992 996 1000 1004 1008 + 1012 1016 1020 1024 1028 1032 1036 1040 1044 1048 1052 1056 + 1060 1064 1068 1072 1076 1080 1084 1088 1092 1096 1100 1104 + 1108 1112 1116 1120 1124 1128 1132 1136 1140 1144 1148 1152 + 1156 1160 1164 1168 1172 1176 1180 1184 1188 1192 1196 1200 + 1204 1208 1212 1216 1220 1224 1228 1232 1236 1240 1244 1248 + 1252 1256 1260 1264 1268 1272 1276 1280 1284 1288 1292 1296 + 1300 1304 1308 1312 1316 1320 1324 1328 1332 1336 1340 1344 + 1348 1352 1356 1360 1364 1368 1372 1376 1380 1384 1388 1392 + 1396 1400 1404 1408 1412 1416 1420 1424 1428 1432 1436 1440 + 1444 1448 1452 1456 1460 1464 1468 1472 1476 1480 1484 1488 + 1492 1496 1500 1504 1508 1512 1516 1520 1524 1528 1532 1536 + 1540 1544 1548 1552 1556 1560 1564 1568 1572 1576 1580 1584 + 1588 1592 1596 1600 1604 1608 1612 1616 1620 1624 1628 1632 + 1636 1640 1644 1648 1652 1656 1660 1664 1668 1672 1676 1680 + 1684 1688 1692 1696 1700 1704 1708 1712 1716 1720 1724 1728 + 1732 1736 1740 1744 1748 1752 1756 1760 1764 1768 1772 1776 + 1780 1784 1788 1792 1796 1800 1804 1808 1812 1816 1820 1824 + 1828 1832 1836 1840 1844 1848 1852 1856 1860 1864 1868 1872 + 1876 1880 1884 1888 1892 1896 1900 1904 1908 1912 1916 1920 + 1924 1928 1932 1936 1940 1944 1948 1952 1956 1960 1964 1968 + 1972 1976 1980 1984 1988 1992 1996 2000 2004 2008 2012 2016 + 2020 2024 2028 2032 2036 2040 2044 2048 2052 2056 2060 2064 + 2068 2072 2076 2080 2084 2088 2092 2096 2100 2104 2108 2112 + 2116 2120 2124 2128 2132 2136 2140 2144 2148 2152 2156 2160 + 2164 2168 2172 2176 2180 2184 2188 2192 2196 2200 2204 2208 + 2212 2216 2220 2224 2228 2232 2236 2240 2244 2248 2252 2256 + 2260 2264 2268 2272 2276 2280 2284 2288 2292 2296 2300 2304 + 2308 2312 2316 2320 2324 2328 2332 2336 2340 2344 2348 2352 + 2356 2360 2364 2368 2372 2376 2380 2384 2388 2392 2396 2400 + 2404 2408 + + + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 10 10 10 10 10 10 10 10 10 10 + 10 10 + + + + +