diff --git a/dumux/discretization/staggered/freeflow/connectivitymap.hh b/dumux/discretization/staggered/freeflow/connectivitymap.hh index 313874e84121d9bf907f3f820f4a566918899a0e..e43321f1c0c68767972c7212d5b5002febda09c7 100644 --- a/dumux/discretization/staggered/freeflow/connectivitymap.hh +++ b/dumux/discretization/staggered/freeflow/connectivitymap.hh @@ -92,6 +92,13 @@ public: } } + //! \brief Set the order needed by the scheme + void setStencilOrder(const int stencilOrder) + { + stencilOrder_ = stencilOrder; + } + + //! Returns the stencil of a cell center dof w.r.t. other cell center dofs const std::vector<GridIndexType>& operator() (CellCenterIdxType, CellCenterIdxType, const GridIndexType globalI) const { @@ -143,7 +150,7 @@ private: const FVElementGeometry& fvGeometry, const SubControlVolumeFace& scvf) { - stencil.push_back(scvf.dofIndex()); + stencil.push_back(scvf.axisData().selfDof); } /* @@ -163,8 +170,8 @@ private: auto& normalFace = fvGeometry.scvf(eIdx, data.localNormalFaceIdx); if(!normalFace.boundary()) { - const auto outerParallelElementDofIdx = normalFace.outsideScvIdx(); - stencil.push_back(outerParallelElementDofIdx); + const auto firstParallelElementDofIdx = normalFace.outsideScvIdx(); + stencil.push_back(firstParallelElementDofIdx); } } } @@ -177,21 +184,43 @@ private: const FVElementGeometry& fvGeometry, const SubControlVolumeFace& scvf) { - // the first entries are always the face dofIdx itself and the one of the opposing face if(stencil.empty()) { - stencil.push_back(scvf.dofIndex()); - stencil.push_back(scvf.dofIndexOpposingFace()); + for(int i = 0; i < stencilOrder_ - 1; i++) + { + if(scvf.hasBackwardNeighbor(i)) + { + stencil.push_back(scvf.axisData().inAxisBackwardDofs[i]); + } + } + + stencil.push_back(scvf.axisData().selfDof); + stencil.push_back(scvf.axisData().oppositeDof); + + for(int i = 0; i < stencilOrder_ - 1; i++) + { + if(scvf.hasForwardNeighbor(i)) + { + stencil.push_back(scvf.axisData().inAxisForwardDofs[i]); + } + } } for(const auto& data : scvf.pairData()) { + // add normal dofs stencil.push_back(data.normalPair.first); - const auto outerParallelFaceDofIdx = data.outerParallelFaceDofIdx; - if(outerParallelFaceDofIdx >= 0) - stencil.push_back(outerParallelFaceDofIdx); if(!scvf.boundary()) stencil.push_back(data.normalPair.second); + + // add parallel dofs + for (int i = 0; i < stencilOrder_ /*data.parallelDofs.size()*/; i++) + { + if(!(data.parallelDofs[i] < 0)) + { + stencil.push_back(data.parallelDofs[i]); + } + } } } @@ -199,6 +228,7 @@ private: CellCenterToFaceMap cellCenterToFaceMap_; FaceToCellCenterMap faceToCellCenterMap_; FaceToFaceMap faceToFaceMap_; + int stencilOrder_; }; } // end namespace Dumux diff --git a/dumux/discretization/staggered/freeflow/facevariables.hh b/dumux/discretization/staggered/freeflow/facevariables.hh index 6fd24dc689105446baddd6fb1b78c8d39db3f97c..e227cfdc046c20788df80bdd921032862069b858 100644 --- a/dumux/discretization/staggered/freeflow/facevariables.hh +++ b/dumux/discretization/staggered/freeflow/facevariables.hh @@ -25,6 +25,7 @@ #define DUMUX_DISCRETIZATION_STAGGERED_FREEFLOW_FACEVARIABLES_HH #include <array> +#include <vector> namespace Dumux { @@ -37,6 +38,7 @@ template<class FacePrimaryVariables, int dim> class StaggeredFaceVariables { static constexpr int numPairs = (dim == 2) ? 2 : 4; + static constexpr int order = 2; using Scalar = typename FacePrimaryVariables::block_type; public: @@ -72,7 +74,32 @@ public: velocitySelf_ = faceSol[scvf.dofIndex()]; velocityOpposite_ = faceSol[scvf.dofIndexOpposingFace()]; + // treat the velocity forward of the self face i.e. the face that is + // forward wrt the self face by degree i + velocityForward_.fill(0.0); + for (int i = 0; i < scvf.axisData().inAxisForwardDofs.size(); i++) + { + if(!(scvf.axisData().inAxisForwardDofs[i] < 0)) + { + velocityForward_[i]= faceSol[scvf.axisData().inAxisForwardDofs[i]]; + } + } + + // treat the velocity at the first backward face i.e. the face that is + // behind the opposite face by degree i + velocityBackward_.fill(0.0); + for (int i = 0; i < scvf.axisData().inAxisBackwardDofs.size(); i++) + { + if(!(scvf.axisData().inAxisBackwardDofs[i] < 0)) + { + velocityBackward_[i] = faceSol[scvf.axisData().inAxisBackwardDofs[i]]; + } + } + // handle all sub faces + for(int i = 0; i < velocityParallel_.size(); ++i) + velocityParallel_[i].fill(0.0); + for(int i = 0; i < scvf.pairData().size(); ++i) { const auto& subFaceData = scvf.pairData(i); @@ -80,12 +107,17 @@ public: // treat the velocities normal to the face velocityNormalInside_[i] = faceSol[subFaceData.normalPair.first]; - if(scvf.hasFrontalNeighbor(i)) + if(scvf.hasOuterNormal(i)) velocityNormalOutside_[i] = faceSol[subFaceData.normalPair.second]; - // treat the velocity parallel to the face - if(scvf.hasParallelNeighbor(i)) - velocityParallel_[i] = faceSol[subFaceData.outerParallelFaceDofIdx]; + // treat the velocities parallel to the self face + for(int j = 0; j < subFaceData.parallelDofs.size(); j++) + { + if(scvf.hasParallelNeighbor(i,j)) + { + velocityParallel_[i][j] = faceSol[subFaceData.parallelDofs[j]]; + } + } } } @@ -106,13 +138,34 @@ public: } /*! - * \brief Returns the velocity at the parallel face + * \brief Returns the velocity at a backward face + * + * \param backwardIdx The index describing how many faces backward this dof is from the opposite face + */ + Scalar velocityBackward(const int backwardIdx) const + { + return velocityBackward_[backwardIdx]; + } + + /*! + * \brief Returns the velocity at a forward face + * + * \param forwardIdx The index describing how many faces forward this dof is of the self face + */ + Scalar velocityForward(const int forwardIdx) const + { + return velocityForward_[forwardIdx]; + } + + /*! + * \brief Returns the velocity at a parallel face * * \param localSubFaceIdx The local index of the subface + * \param parallelDegreeIdx The index describing how many faces parallel this dof is of the parallel face */ - Scalar velocityParallel(const int localSubFaceIdx) const + Scalar velocityParallel(const int localSubFaceIdx, const int parallelDegreeIdx) const { - return velocityParallel_[localSubFaceIdx]; + return velocityParallel_[localSubFaceIdx][parallelDegreeIdx]; } /*! @@ -136,12 +189,14 @@ public: } private: - Scalar velocitySelf_; Scalar velocityOpposite_; - std::array<Scalar, numPairs> velocityParallel_; - std::array<Scalar, numPairs> velocityNormalInside_; - std::array<Scalar, numPairs> velocityNormalOutside_; + std::array<Scalar, order-1> velocityForward_; + std::array<Scalar, order-1> velocityBackward_; + std::array<std::array<Scalar, order>, numPairs> velocityParallel_; + std::array<Scalar, numPairs> velocityNormalInside_; + std::array<Scalar, numPairs> velocityNormalOutside_; + }; } // end namespace Dumux diff --git a/dumux/discretization/staggered/freeflow/staggeredgeometryhelper.hh b/dumux/discretization/staggered/freeflow/staggeredgeometryhelper.hh index 7760f173a222308fc2689da2bac8229a316aa0e3..6990c0daed38f81762929ddeedec7f1f85febbbd 100644 --- a/dumux/discretization/staggered/freeflow/staggeredgeometryhelper.hh +++ b/dumux/discretization/staggered/freeflow/staggeredgeometryhelper.hh @@ -30,26 +30,43 @@ #include <dumux/common/math.hh> #include <type_traits> #include <algorithm> +#include <array> -namespace Dumux { +namespace Dumux +{ /*! * \ingroup StaggeredDiscretization - * \brief Data stored per sub face + * \brief Parallel Data stored per sub face */ -template<class Scalar, class GlobalPosition> +template<class Scalar, class GlobalPosition, int geometryOrder> struct PairData { - int outerParallelFaceDofIdx; - std::pair<int,int> normalPair; + std::array<int, geometryOrder> parallelDofs; + std::array<Scalar, geometryOrder+1> parallelDistances; + std::pair<signed int,signed int> normalPair; int localNormalFaceIdx; - int globalCommonEntIdx; - Scalar parallelDistance; Scalar normalDistance; - GlobalPosition virtualOuterParallelFaceDofPos; + GlobalPosition virtualFirstParallelFaceDofPos; +}; + +/*! + * \ingroup StaggeredDiscretization + * \brief In Axis Data stored per sub face + */ +template<class Scalar, int geometryOrder> +struct AxisData +{ + int selfDof; + int oppositeDof; + std::array<int, geometryOrder-1> inAxisForwardDofs; + std::array<int, geometryOrder-1> inAxisBackwardDofs; + Scalar selfToOppositeDistance; + std::array<Scalar, geometryOrder-1> inAxisForwardDistances; + std::array<Scalar, geometryOrder-1> inAxisBackwardDistances; }; - /*! +/*! * \ingroup StaggeredDiscretization * \brief Returns the dirction index of the facet (0 = x, 1 = y, 2 = z) */ @@ -65,11 +82,6 @@ inline static unsigned int directionIndex(Vector&& vector) * \ingroup StaggeredDiscretization * \brief Helper class constructing the dual grid finite volume geometries * for the free flow staggered discretization method. - * - * A visualization of the variables that are in this document can be found in the following image: - * - * \image html staggeredgeometry.png - * */ template<class GridView> class FreeFlowStaggeredGeometryHelper @@ -92,6 +104,7 @@ class FreeFlowStaggeredGeometryHelper static constexpr int codimIntersection = 1; static constexpr int codimCommonEntity = 2; static constexpr int numFacetSubEntities = (dim == 2) ? 2 : 4; + static constexpr int numfacets = dimWorld * 2; static constexpr int numPairs = 2 * (dimWorld - 1); public: @@ -106,95 +119,227 @@ public: intersection_ = intersection; innerNormalFacePos_.clear(); fillPairData_(); + fillAxisData_(); } /*! - * \brief Returns the global dofIdx of the intersection itself + * \brief Returns the local index of the face (i.e. the intersection) */ - int dofIndex() const + int localFaceIndex() const { - //TODO: use proper intersection mapper! - const auto inIdx = intersection_.indexInInside(); - return gridView_.indexSet().subIndex(intersection_.inside(), inIdx, codimIntersection); + return intersection_.indexInInside(); } /*! - * \brief Returns the global dofIdx of the opposing intersection + * \brief Returns a copy of the axis data */ - int dofIndexOpposingFace() const + auto axisData() const { - //TODO: use proper intersection mapper! - const auto inIdx = intersection_.indexInInside(); - return gridView_.indexSet().subIndex(this->intersection_.inside(), localOppositeIdx_(inIdx), codimIntersection); + return axisData_; } /*! - * \brief Returns the local index of the face (i.e. the intersection) + * \brief Returns a copy of the pair data */ - int localFaceIndex() const + auto pairData() const { - return intersection_.indexInInside(); + return pairData_; } - /*! - * \brief Returns the distance between dofSelf and dofOpposite + /*! + * \brief Returns the dirction index of the primary facet (0 = x, 1 = y, 2 = z) */ - Scalar selfToOppositeDistance() const + int directionIndex() const { - const auto inIdx = intersection_.indexInInside(); - const auto self = getFacet_(inIdx, element_); - const auto opposite = getFacet_(localOppositeIdx_(inIdx), element_); - return (self.geometry().center() - opposite.geometry().center()).two_norm(); + return Dumux::directionIndex(std::move(intersection_.centerUnitOuterNormal())); } /*! - * \brief Returns a copy of the pair data + * \brief Returns the dirction index of the facet passed as an argument (0 = x, 1 = y, 2 = z) */ - auto pairData() const + int directionIndex(const Intersection& intersection) const { - return pairData_; + return Dumux::directionIndex(std::move(intersection.centerUnitOuterNormal())); } - /*! - * \brief Returns the dirction index of the facet (0 = x, 1 = y, 2 = z) + static constexpr int geometryOrder = 2; + +private: + /*! + * \brief Fills all entries of the in axis data */ - int directionIndex() const + void fillAxisData_() { - return Dumux::directionIndex(std::move(intersection_.centerUnitOuterNormal())); + unsigned int numForwardBackwardAxisDofs = axisData_.inAxisForwardDofs.size(); + const auto inIdx = intersection_.indexInInside(); + const auto oppIdx = localOppositeIdx_(inIdx); + + this->axisData_.inAxisForwardDofs.fill(-1); + this->axisData_.inAxisBackwardDofs.fill(-1); + this->axisData_.inAxisForwardDistances.fill(0); + this->axisData_.inAxisBackwardDistances.fill(0); + + // Set the self Dof + this->axisData_.selfDof = gridView_.indexSet().subIndex(this->intersection_.inside(), inIdx, codimIntersection); + const auto self = getFacet_(inIdx, element_); + + // Set the opposite Dof + this->axisData_.oppositeDof = gridView_.indexSet().subIndex(this->intersection_.inside(), oppIdx, codimIntersection); + const auto opposite = getFacet_(oppIdx, element_); + + // Set the Self to Opposite Distance + this->axisData_.selfToOppositeDistance = (self.geometry().center() - opposite.geometry().center()).two_norm(); + + // Set the Forward Dofs + std::stack<Element> inAxisForwardElementStack; + auto selfFace = getFacet_(inIdx, element_); + if(intersection_.neighbor()) + { + inAxisForwardElementStack.push(intersection_.outside()); + bool keepStackingForward = (inAxisForwardElementStack.size() < numForwardBackwardAxisDofs); + while(keepStackingForward) + { + auto e = inAxisForwardElementStack.top(); + for(const auto& intersection : intersections(gridView_,e)) + { + if( (intersection.indexInInside() == inIdx ) ) + { + if( intersection.neighbor()) + { + inAxisForwardElementStack.push(intersection.outside()); + keepStackingForward = (inAxisForwardElementStack.size() < numForwardBackwardAxisDofs); + } + else + { + keepStackingForward = false; + } + } + } + } + } + + std::vector<GlobalPosition> forwardFaceCoordinates(inAxisForwardElementStack.size(), selfFace.geometry().center()); + while(!inAxisForwardElementStack.empty()) + { + int forwardIdx = inAxisForwardElementStack.size()-1; + this->axisData_.inAxisForwardDofs[forwardIdx] = gridView_.indexSet().subIndex(inAxisForwardElementStack.top(), inIdx, codimIntersection); + selfFace = getFacet_(inIdx, inAxisForwardElementStack.top()); + forwardFaceCoordinates[forwardIdx] = selfFace.geometry().center(); + inAxisForwardElementStack.pop(); + } + + for(int i = 0; i< forwardFaceCoordinates.size(); i++) + { + if(i == 0) + { + this->axisData_.inAxisForwardDistances[i] = (forwardFaceCoordinates[i] - self.geometry().center()).two_norm(); + } + else + { + this->axisData_.inAxisForwardDistances[i] = (forwardFaceCoordinates[i]- forwardFaceCoordinates[i-1]).two_norm(); + } + } + + // Set the Backward Dofs + std::stack<Element> inAxisBackwardElementStack; + auto oppFace = getFacet_(oppIdx, element_); + for(const auto& intersection : intersections(gridView_, element_)) + { + if(intersection.indexInInside() == oppIdx) + { + if(intersection.neighbor()) + { + inAxisBackwardElementStack.push(intersection.outside()); + bool keepStackingBackward = (inAxisBackwardElementStack.size() < numForwardBackwardAxisDofs); + while(keepStackingBackward) + { + auto e = inAxisBackwardElementStack.top(); + for(const auto& intersectionOut : intersections(gridView_,e)) + { + + if( (intersectionOut.indexInInside() == oppIdx ) ) + { + if( intersectionOut.neighbor()) + { + inAxisBackwardElementStack.push(intersectionOut.outside()); + keepStackingBackward = (inAxisBackwardElementStack.size() < numForwardBackwardAxisDofs); + } + else + { + keepStackingBackward = false; + } + } + } + } + } + } + } + + std::vector<GlobalPosition> backwardFaceCoordinates(inAxisBackwardElementStack.size(), oppFace.geometry().center()); + while(!inAxisBackwardElementStack.empty()) + { + int backwardIdx = inAxisBackwardElementStack.size()-1; + this->axisData_.inAxisBackwardDofs[backwardIdx] = gridView_.indexSet().subIndex(inAxisBackwardElementStack.top(), oppIdx, codimIntersection); + oppFace = getFacet_(oppIdx, inAxisBackwardElementStack.top()); + backwardFaceCoordinates[backwardIdx] = oppFace.geometry().center(); + inAxisBackwardElementStack.pop(); + } + + for(int i = 0; i< backwardFaceCoordinates.size(); i++) + { + if(i == 0) + { + this->axisData_.inAxisBackwardDistances[i] = (backwardFaceCoordinates[i] - opposite.geometry().center()).two_norm(); + } + else + { + this->axisData_.inAxisBackwardDistances[i] = (backwardFaceCoordinates[i] - backwardFaceCoordinates[i-1]).two_norm(); + } + } } -private: - /*! + /*! * \brief Fills all entries of the pair data */ void fillPairData_() { - const int localFacetIdx = intersection_.indexInInside(); - // initialize values that could remain unitialized if the intersection lies on a boundary for(auto& data : pairData_) { - data.outerParallelFaceDofIdx = -1; + // parallel Dofs + data.parallelDofs.fill(-1); + + // parallel Distances + data.parallelDistances.fill(0.0); + + // outer normals data.normalPair.second = -1; - data.normalDistance = -1; - data.parallelDistance = -1; } - // set the inner parts of the normal pairs - const auto localIndices = getLocalIndices_(localFacetIdx); - setInnerIndices_(localIndices); - - // get the positions of the faces normal to the intersection within the element - innerNormalFacePos_.reserve(numPairs); + unsigned int numParallelFaces = pairData_[0].parallelDistances.size(); + // set basic global positions + const auto& elementCenter = this->element_.geometry().center(); + const auto& FacetCenter = intersection_.geometry().center(); - for(int i = 0; i < numPairs; ++i) + // get the inner normal Dof Index + int numPairInnerNormalIdx = 0; + for(const auto& innerElementIntersection : intersections(gridView_, element_)) { - const auto& innerNormalFacet = getFacet_(localIndices.normalLocalDofIdx[i], element_); - innerNormalFacePos_.emplace_back(innerNormalFacet.geometry().center()); + if(facetIsNormal_(innerElementIntersection.indexInInside(), intersection_.indexInInside())) + { + const int innerElementIntersectionIdx = innerElementIntersection.indexInInside(); + setNormalPairFirstInfo_(innerElementIntersectionIdx, element_, numPairInnerNormalIdx); + numPairInnerNormalIdx++; + + innerNormalFacePos_.reserve(numPairs); + const auto& innerNormalFacet = getFacet_(innerElementIntersection.indexInInside(), element_); + innerNormalFacePos_.emplace_back(innerNormalFacet.geometry().center()); + } } - // go into the direct neighbor element + // get the outer normal Dof Index + int numPairOuterNormalIdx = 0; if(intersection_.neighbor()) { // the direct neighbor element and the respective intersection index @@ -202,60 +347,94 @@ private: for(const auto& directNeighborElementIntersection : intersections(gridView_, directNeighborElement)) { - - const int directNeighborElemIsIdx = directNeighborElementIntersection.indexInInside(); // skip the directly neighboring face itself and its opposing one - if(facetIsNormal_(directNeighborElemIsIdx, intersection_.indexInOutside())) + if(facetIsNormal_(directNeighborElementIntersection.indexInInside(), intersection_.indexInOutside())) { - setPairInfo_(directNeighborElemIsIdx, directNeighborElement, false); - - // go into the adjacent neighbor element to get parallel dof info - if(directNeighborElementIntersection.neighbor()) - { - const auto& diagonalNeighborElement = directNeighborElementIntersection.outside(); - for(const auto& dIs : intersections(gridView_, diagonalNeighborElement)) - { - if(facetIsNormal_(dIs.indexInInside(), directNeighborElementIntersection.indexInOutside())) - setPairInfo_(dIs.indexInInside(), diagonalNeighborElement, true); - } - } + const int directNeighborElemIsIdx = directNeighborElementIntersection.indexInInside(); + setNormalPairSecondInfo_(directNeighborElemIsIdx, directNeighborElement, numPairOuterNormalIdx); + numPairOuterNormalIdx++; } } } else // intersection is on boundary { - // find an intersection normal to the face - for(const auto& normalIntersection : intersections(gridView_, element_)) + // fill the normal pair entries + for(int pairIdx = 0; pairIdx < numPairs; ++pairIdx) { - if(facetIsNormal_(normalIntersection.indexInInside(), intersection_.indexInInside()) && normalIntersection.neighbor()) + assert(pairData_[pairIdx].normalPair.second == -1); + const auto distance = FacetCenter - elementCenter; + this->pairData_[pairIdx].normalDistance = std::move(distance.two_norm()); + numPairOuterNormalIdx++; + } + } + + // get the parallel Dofs + const int parallelLocalIdx = intersection_.indexInInside(); + int numPairParallelIdx = 0; + std::stack<Element> parallelElementStack; + for(const auto& intersection : intersections(gridView_, element_)) + { + if( facetIsNormal_(intersection.indexInInside(), parallelLocalIdx) ) + { + if( intersection.neighbor() ) { - const auto& neighborElement = normalIntersection.outside(); + auto parallelAxisIdx = directionIndex(intersection); + auto localNormalIntersectionIndex = intersection.indexInInside(); + parallelElementStack.push(element_); - for(const auto& neighborElementIs : intersections(gridView_, neighborElement)) + bool keepStacking = (parallelElementStack.size() < numParallelFaces); + while(keepStacking) { - // iterate over facets sub-entities - if(facetIsNormal_(normalIntersection.indexInInside(), neighborElementIs.indexInInside())) - setPairInfo_(neighborElementIs.indexInInside(), neighborElement, true); + auto e = parallelElementStack.top(); + for(const auto& normalIntersection : intersections(gridView_, e)) + { + if( normalIntersection.indexInInside() == localNormalIntersectionIndex ) + { + if( normalIntersection.neighbor() ) + { + parallelElementStack.push(normalIntersection.outside()); + keepStacking = (parallelElementStack.size() < numParallelFaces); + } + else + { + keepStacking = false; + } + } + } } + + while(!parallelElementStack.empty()) + { + if(parallelElementStack.size() > 1) + { + this->pairData_[numPairParallelIdx].parallelDofs[parallelElementStack.size()-2] = gridView_.indexSet().subIndex(parallelElementStack.top(), parallelLocalIdx, codimIntersection); + } + this->pairData_[numPairParallelIdx].parallelDistances[parallelElementStack.size()-1] = setParallelPairDistances_(parallelElementStack.top(), parallelAxisIdx); + parallelElementStack.pop(); + } + } - } + else + { + // If the intersection has no neighbor we have to deal with the virtual outer parallel dof + const auto& elementCenter = this->element_.geometry().center(); + const auto& boundaryFacetCenter = intersection.geometry().center(); - // fill the normal pair entries - for(int pairIdx = 0; pairIdx < numPairs; ++pairIdx) - { - assert(pairData_[pairIdx].normalPair.second == -1); - const auto& elementCenter = this->element_.geometry().center(); - const auto& boundaryFacetCenter = intersection_.geometry().center(); - const auto distance = boundaryFacetCenter - elementCenter; + const auto distance = boundaryFacetCenter - elementCenter; + const auto virtualFirstParallelFaceDofPos = this->intersection_.geometry().center() + distance; + + this->pairData_[numPairParallelIdx].virtualFirstParallelFaceDofPos = std::move(virtualFirstParallelFaceDofPos); - pairData_[pairIdx].normalDistance = std::move(distance.two_norm()); + // The distance is saved doubled because with scvf.cellCenteredSelfToFirstParallelDistance + // an average between parallelDistances[0] and parallelDistances[1] will be computed + this->pairData_[numPairParallelIdx].parallelDistances[0] = std::move(distance.two_norm() * 2); + } + numPairParallelIdx++; } } - - treatVirtualOuterParallelFaceDofs_(); } - /*! + /*! * \brief Returns the local opposing intersection index * * \param idx The local index of the intersection itself @@ -265,7 +444,7 @@ private: return (idx % 2) ? (idx - 1) : (idx + 1); } - /*! + /*! * \brief Returns true if the intersection lies normal to another given intersection * * \param selfIdx The local index of the intersection itself @@ -276,198 +455,79 @@ private: return !(selfIdx == otherIdx || localOppositeIdx_(selfIdx) == otherIdx); }; - /*! - * \brief Returns the global index of the common entity - * - * \param localIdx The local index of the common entity - * \param element The element - */ - int localToGlobalCommonEntityIdx_(const int localIdx, const Element& element) const - { - return this->gridView_.indexSet().subIndex(element, localIdx, codimCommonEntity); - }; - auto getFacet_(const int localFacetIdx, const Element& element) const { return element.template subEntity <1> (localFacetIdx); }; - void setPairInfo_(const int isIdx, const Element& element, const bool isParallel) + //! Sets the information about the normal faces (within the element) + void setNormalPairFirstInfo_(const int isIdx, const Element& element, const int numPairsIdx) { - const auto referenceElement = ReferenceElements::general(element_.geometry().type()); + // store the inner normal dofIdx + auto& dofIdx = pairData_[numPairsIdx].normalPair.first; + dofIdx = gridView_.indexSet().subIndex(element, isIdx, codimIntersection); - // iterate over facets sub-entities - for(int i = 0; i < numFacetSubEntities; ++i) - { - int localCommonEntIdx = referenceElement.subEntity(isIdx, 1, i, codimCommonEntity); - int globalCommonEntIdx = localToGlobalCommonEntityIdx_(localCommonEntIdx, element); - - // fill the normal pair entries - for(int pairIdx = 0; pairIdx < numPairs; ++pairIdx) - { - if(globalCommonEntIdx == pairData_[pairIdx].globalCommonEntIdx) - { - auto& dofIdx = isParallel ? pairData_[pairIdx].outerParallelFaceDofIdx : pairData_[pairIdx].normalPair.second; - dofIdx = gridView_.indexSet().subIndex(element, isIdx, codimIntersection); - if(isParallel) - { - const auto& selfFacet = getFacet_(intersection_.indexInInside(), element_); - const auto& parallelFacet = getFacet_(isIdx, element); - pairData_[pairIdx].parallelDistance = (selfFacet.geometry().center() - parallelFacet.geometry().center()).two_norm(); - } - else - { - const auto& outerNormalFacet = getFacet_(isIdx, element); - const auto outerNormalFacetPos = outerNormalFacet.geometry().center(); - pairData_[pairIdx].normalDistance = (innerNormalFacePos_[pairIdx] - outerNormalFacetPos).two_norm(); - } - } - } - } + // store the local normal facet index + this->pairData_[numPairsIdx].localNormalFaceIdx = isIdx; } - template<class Indices> - void setInnerIndices_(const Indices& indices) + //! Sets the information about the normal faces (in the neighbor element) + void setNormalPairSecondInfo_(const int isIdx, const Element& element, const int numPairsIdx) { - for(int i = 0; i < numPairs; ++i) - { - this->pairData_[i].normalPair.first = this->gridView_.indexSet().subIndex(this->intersection_.inside(), indices.normalLocalDofIdx[i], codimIntersection); - this->pairData_[i].globalCommonEntIdx = this->gridView_.indexSet().subIndex(this->intersection_.inside(), indices.localCommonEntIdx[i], codimCommonEntity); - this->pairData_[i].localNormalFaceIdx = indices.normalLocalDofIdx[i]; - } + // store the dofIdx + auto& dofIdx = pairData_[numPairsIdx].normalPair.second; + dofIdx = gridView_.indexSet().subIndex(element, isIdx, codimIntersection); + + // store the element distance + const auto& outerNormalFacet = getFacet_(isIdx, element); + const auto outerNormalFacetPos = outerNormalFacet.geometry().center(); + const auto& innerNormalFacet = getFacet_(isIdx, element_); + const auto innerNormalFacetPos = innerNormalFacet.geometry().center(); + this->pairData_[numPairsIdx].normalDistance = (innerNormalFacetPos - outerNormalFacetPos).two_norm(); } - /*! - * \brief Sets the position of "virtual" dofs on facets which are perpendicular to facets on the domain boundary. - * This is required to account e.g. for wall friction. - */ - void treatVirtualOuterParallelFaceDofs_() + //! Sets the information about the parallel distances + Scalar setParallelPairDistances_(const Element& element, const int parallelAxisIdx) const { - // get the local index of the facet we are dealing with in this class - const int localIntersectionIdx = this->intersection_.indexInInside(); - - // iterate over all intersections of the element, this facet is part of - for(const auto& is : intersections(this->gridView_, this->element_)) + Scalar distance = 0; + std::vector<GlobalPosition> faces; + faces.reserve(numfacets); + for (const auto& intElement : intersections(gridView_, element)) { - const int otherIsIdx = is.indexInInside(); - // check if any of these intersection, which are normal to our facet, lie on the domain boundary - if(( !is.neighbor() ) && this->facetIsNormal_(localIntersectionIdx, otherIsIdx) ) - { - const auto& elementCenter = this->element_.geometry().center(); - const auto& boundaryFacetCenter = is.geometry().center(); - - const auto distance = boundaryFacetCenter - elementCenter; - const auto virtualOuterParallelFaceDofPos = this->intersection_.geometry().center() + distance; - - auto foundCorrectIdx = [otherIsIdx](const auto& x) { return x.localNormalFaceIdx == otherIsIdx; }; - const int index = std::find_if(this->pairData_.begin(), this->pairData_.end(), foundCorrectIdx) - this->pairData_.begin(); - - this->pairData_[index].virtualOuterParallelFaceDofPos = std::move(virtualOuterParallelFaceDofPos); - this->pairData_[index].parallelDistance = std::move(distance.two_norm()); - } + faces.push_back(intElement.geometry().center()); } - } - - auto getLocalIndices_(const int localFacetIdx) const - { - struct Indices - { - std::array<int, numPairs> normalLocalDofIdx; - std::array<int, numPairs> localCommonEntIdx; - }; - - Indices indices; - if (dim == 1) - return indices; - - switch(localFacetIdx) + switch(parallelAxisIdx) { case 0: - indices.normalLocalDofIdx[0] = 3; - indices.normalLocalDofIdx[1] = 2; - indices.localCommonEntIdx[0] = 2; - indices.localCommonEntIdx[1] = 0; - if(dim == 3) - { - indices.normalLocalDofIdx[2] = 4; - indices.normalLocalDofIdx[3] = 5; - indices.localCommonEntIdx[2] = 4; - indices.localCommonEntIdx[3] = 8; - } - break; + { + distance = (faces[1] - faces[0]).two_norm(); + break; + } case 1: - indices.normalLocalDofIdx[0] = 2; - indices.normalLocalDofIdx[1] = 3; - indices.localCommonEntIdx[0] = 1; - indices.localCommonEntIdx[1] = 3; - if(dim == 3) - { - indices.normalLocalDofIdx[2] = 4; - indices.normalLocalDofIdx[3] = 5; - indices.localCommonEntIdx[2] = 5; - indices.localCommonEntIdx[3] = 9; - } - break; + { + distance = (faces[3] - faces[2]).two_norm(); + break; + } case 2: - indices.normalLocalDofIdx[0] = 0; - indices.normalLocalDofIdx[1] = 1; - indices.localCommonEntIdx[0] = 0; - indices.localCommonEntIdx[1] = 1; - if(dim == 3) - { - indices.normalLocalDofIdx[2] = 4; - indices.normalLocalDofIdx[3] = 5; - indices.localCommonEntIdx[2] = 6; - indices.localCommonEntIdx[3] = 10; - } - break; - case 3: - indices.normalLocalDofIdx[0] = 1; - indices.normalLocalDofIdx[1] = 0; - indices.localCommonEntIdx[0] = 3; - indices.localCommonEntIdx[1] = 2; - if(dim == 3) - { - indices.normalLocalDofIdx[2] = 4; - indices.normalLocalDofIdx[3] = 5; - indices.localCommonEntIdx[2] = 7; - indices.localCommonEntIdx[3] = 11; - } - break; - case 4: - assert(dim == 3); - indices.normalLocalDofIdx[0] = 0; - indices.normalLocalDofIdx[1] = 1; - indices.normalLocalDofIdx[2] = 3; - indices.normalLocalDofIdx[3] = 2; - indices.localCommonEntIdx[0] = 4; - indices.localCommonEntIdx[1] = 5; - indices.localCommonEntIdx[2] = 7; - indices.localCommonEntIdx[3] = 6; - break; - case 5: + { assert(dim == 3); - indices.normalLocalDofIdx[0] = 0; - indices.normalLocalDofIdx[1] = 1; - indices.normalLocalDofIdx[2] = 2; - indices.normalLocalDofIdx[3] = 3; - indices.localCommonEntIdx[0] = 8; - indices.localCommonEntIdx[1] = 9; - indices.localCommonEntIdx[2] = 10; - indices.localCommonEntIdx[3] = 11; - break; + distance = (faces[5] - faces[4]).two_norm(); + break; + } default: + { DUNE_THROW(Dune::InvalidStateException, "Something went terribly wrong"); + } } - return indices; + return distance; } - // TODO: check whether to use references here or not Intersection intersection_; //!< The intersection of interest const Element element_; //!< The respective element const typename Element::Geometry elementGeometry_; //!< Reference to the element geometry - const GridView gridView_; - std::array<PairData<Scalar, GlobalPosition>, numPairs> pairData_; //!< collection of pair information + const GridView gridView_; //!< The grid view + AxisData<Scalar, geometryOrder> axisData_; //!< Data related to forward and backward faces + std::array<PairData<Scalar, GlobalPosition, geometryOrder>, numPairs> pairData_; //!< Collection of pair information related to normal and parallel faces std::vector<GlobalPosition> innerNormalFacePos_; }; diff --git a/dumux/discretization/staggered/freeflow/subcontrolvolumeface.hh b/dumux/discretization/staggered/freeflow/subcontrolvolumeface.hh index 924c9b897e6e495dbc25a8a13d4de9a88de0e69c..0fa6efc60735a797a487304caea533c7781e9032 100644 --- a/dumux/discretization/staggered/freeflow/subcontrolvolumeface.hh +++ b/dumux/discretization/staggered/freeflow/subcontrolvolumeface.hh @@ -51,12 +51,14 @@ class FreeFlowStaggeredSubControlVolumeFace using Geometry = typename T::Geometry; using GridIndexType = typename IndexTraits<GV>::GridIndex; using LocalIndexType = typename IndexTraits<GV>::LocalIndex; + using GeometryHelper = FreeFlowStaggeredGeometryHelper<GV>; using Scalar = typename T::Scalar; static const int dim = Geometry::mydimension; static const int dimworld = Geometry::coorddimension; static constexpr int numPairs = 2 * (dimworld - 1); + static constexpr int geometryOrder = GeometryHelper::geometryOrder; public: using GlobalPosition = typename T::GlobalPosition; @@ -73,8 +75,7 @@ public: const typename Intersection::Geometry& isGeometry, GridIndexType scvfIndex, const std::vector<GridIndexType>& scvIndices, - const GeometryHelper& geometryHelper - ) + const GeometryHelper& geometryHelper) : ParentType(), geomType_(isGeometry.type()), area_(isGeometry.volume()), @@ -83,9 +84,8 @@ public: scvfIndex_(scvfIndex), scvIndices_(scvIndices), boundary_(is.boundary()), - dofIdx_(geometryHelper.dofIndex()), - dofIdxOpposingFace_(geometryHelper.dofIndexOpposingFace()), - selfToOppositeDistance_(geometryHelper.selfToOppositeDistance()), + + axisData_(geometryHelper.axisData()), pairData_(geometryHelper.pairData()), localFaceIdx_(geometryHelper.localFaceIndex()), dirIdx_(geometryHelper.directionIndex()), @@ -110,7 +110,7 @@ public: selfToOppositeDistance_(0.0), dirIdx_(dirIdx), isGhostFace_(true) - {} + { axisData_.selfDof = dofIdx; } //! The center of the sub control volume face const GlobalPosition& center() const @@ -181,18 +181,6 @@ public: return Geometry(geomType_, corners_); } - //! The global index of the dof living on this face - GridIndexType dofIndex() const - { - return dofIdx_; - } - - //! The global index of the dof living on the opposing face - GridIndexType dofIndexOpposingFace() const - { - return dofIdxOpposingFace_; - } - //! The local index of this sub control volume face LocalIndexType localFaceIdx() const { @@ -205,12 +193,6 @@ public: return dirIdx_; } - //! The distance between the position of the dof itself and the one of the oppsing dof - Scalar selfToOppositeDistance() const - { - return selfToOppositeDistance_; - } - //! Returns whether the unitNormal of the face points in positive coordinate direction bool normalInPosCoordDir() const { @@ -224,7 +206,7 @@ public: } //! Returns the data for one sub face - const PairData<Scalar, GlobalPosition>& pairData(const int idx) const + const PairData<Scalar, GlobalPosition, geometryOrder>& pairData(const int idx) const { return pairData_[idx]; } @@ -235,21 +217,102 @@ public: return pairData_; } + //! Return an array of all pair data + const auto& axisData() const + { + return axisData_; + } + + //! Returns @c true if the face is a ghost face bool isGhostFace() const { return isGhostFace_; } - bool hasParallelNeighbor(const int localFaceIdx) const + /*! + * \brief Check if the face has a parallel neighbor + * + * \param localSubFaceIdx The local index of the subface + * \param parallelDegreeIdx The index describing how many faces away from the self face + */ + bool hasParallelNeighbor(const int localSubFaceIdx, const int parallelDegreeIdx) const + { + return !(pairData(localSubFaceIdx).parallelDofs[parallelDegreeIdx] < 0); + } + + /*! + * \brief Check if the face has an outer normal neighbor + * + * \param localSubFaceIdx The local index of the subface + */ + bool hasOuterNormal(const int localSubFaceIdx) const + { + return !(pairData_[localSubFaceIdx].normalPair.second < 0); + } + + /*! + * \brief Check if the face has a backward neighbor + * + * \param backwardIdx The index describing how many faces backward this dof is from the opposite face + */ + bool hasBackwardNeighbor(const int backwardIdx) const { - return pairData_[localFaceIdx].outerParallelFaceDofIdx >= 0; + return !(axisData().inAxisBackwardDofs[backwardIdx] < 0); } - bool hasFrontalNeighbor(const int localFaceIdx) const + /*! + * \brief Check if the face has a forward neighbor + * + * \param forwardIdx The index describing how many faces forward this dof is of the self face + */ + bool hasForwardNeighbor(const int forwardIdx) const { - return pairData_[localFaceIdx].normalPair.second >= 0; + return !(axisData().inAxisForwardDofs[forwardIdx] < 0); } + //! Returns the dof of the face + GridIndexType dofIndex() const + { + return axisData().selfDof; + } + + //! Returns the dof of the opposing face + GridIndexType dofIndexOpposingFace() const + { + return axisData().oppositeDof; + } + + //! Returns the dof the first forward face + GridIndexType dofIndexForwardFace() const + { + return axisData().inAxisForwardDofs[0]; + } + + //! Returns the dof of the first backward face + GridIndexType dofIndexBackwardFace() const + { + return axisData().inAxisBackwardDofs[0]; + } + + //! Returns the distance between the face and the opposite one + Scalar selfToOppositeDistance() const + { + return axisData().selfToOppositeDistance; + } + + /*! + * \brief Returns the distance between the parallel dofs + * + * \param localSubFaceIdx The local index of the subface + * \param parallelDegreeIdx The index describing how many faces away from the self + */ + Scalar cellCenteredParallelDistance(const int localSubFaceIdx, const int parallelDegreeIdx) const + { + return (pairData(localSubFaceIdx).parallelDistances[parallelDegreeIdx] + + pairData(localSubFaceIdx).parallelDistances[parallelDegreeIdx+1]) * 0.5; + } + + private: Dune::GeometryType geomType_; std::vector<GlobalPosition> corners_; @@ -261,10 +324,11 @@ private: bool boundary_; int dofIdx_; - int dofIdxOpposingFace_; Scalar selfToOppositeDistance_; - std::array<PairData<Scalar, GlobalPosition>, numPairs> pairData_; - LocalIndexType localFaceIdx_; + AxisData<Scalar, geometryOrder> axisData_; + std::array<PairData<Scalar, GlobalPosition, geometryOrder>, numPairs> pairData_; + + int localFaceIdx_; unsigned int dirIdx_; int outerNormalSign_; bool isGhostFace_; @@ -272,4 +336,4 @@ private: } // end namespace Dumux -#endif +#endif // DUMUX_DISCRETIZATION_STAGGERED_FREE_FLOW_SUBCONTROLVOLUMEFACE_HH diff --git a/dumux/discretization/staggered/fvgridgeometry.hh b/dumux/discretization/staggered/fvgridgeometry.hh index bdf0c3fd28814c6e195c80555903d28eb61027b4..2b7e9b22f68f18f07a9b1d2ebc413ddc95f69d7b 100644 --- a/dumux/discretization/staggered/fvgridgeometry.hh +++ b/dumux/discretization/staggered/fvgridgeometry.hh @@ -219,7 +219,7 @@ public: using FVGridGeometryTuple = std::tuple< CellCenterFVGridGeometry<ThisType>, FaceFVGridGeometry<ThisType> >; //! Constructor - StaggeredFVGridGeometry(const GridView& gridView) + StaggeredFVGridGeometry(const GridView& gridView, const std::string& paramGroup = "") : ParentType(gridView) , intersectionMapper_(gridView) { @@ -227,6 +227,10 @@ public: if (!CheckOverlapSize<DiscretizationMethod::staggered>::isValid(gridView)) DUNE_THROW(Dune::InvalidStateException, "The staggered discretization method needs at least an overlap of 1 for parallel computations. " << " Set the parameter \"Grid.Overlap\" in the input file."); + if (hasParamInGroup(paramGroup, "Discretization.TvdApproach")) + stencilOrder_ = 2; + else + stencilOrder_ = 1; } //! The total number of sub control volumes @@ -247,6 +251,12 @@ public: return numBoundaryScvf_; } + //! The order of the stencil built + std::size_t order() const + { + return stencilOrder_; + } + //! The total number of intersections std::size_t numIntersections() const { @@ -341,6 +351,7 @@ public: } // build the connectivity map for an effecient assembly + connectivityMap_.setStencilOrder(stencilOrder_); connectivityMap_.update(*this); } @@ -412,6 +423,7 @@ private: // mappers ConnectivityMap connectivityMap_; IntersectionMapper intersectionMapper_; + int stencilOrder_; std::vector<SubControlVolume> scvs_; std::vector<SubControlVolumeFace> scvfs_; @@ -471,7 +483,7 @@ public: using FVGridGeometryTuple = std::tuple< CellCenterFVGridGeometry<ThisType>, FaceFVGridGeometry<ThisType> >; //! Constructor - StaggeredFVGridGeometry(const GridView& gridView) + StaggeredFVGridGeometry(const GridView& gridView, const std::string& paramGroup = "") : ParentType(gridView) , intersectionMapper_(gridView) { @@ -479,6 +491,10 @@ public: if (!CheckOverlapSize<DiscretizationMethod::staggered>::isValid(gridView)) DUNE_THROW(Dune::InvalidStateException, "The staggered discretization method needs at least an overlap of 1 for parallel computations. " << " Set the parameter \"Grid.Overlap\" in the input file."); + if (hasParamInGroup(paramGroup, "Discretization.TvdApproach")) + stencilOrder_ = 2; + else + stencilOrder_ = 1; } //! update all fvElementGeometries (do this again after grid adaption) @@ -531,6 +547,7 @@ public: } // build the connectivity map for an effecient assembly + connectivityMap_.setStencilOrder(stencilOrder_); connectivityMap_.update(*this); } @@ -546,6 +563,12 @@ public: return numScvf_; } + //! The order of the stencil built + std::size_t order() const + { + return stencilOrder_; + } + //! The total number of boundary sub control volume faces std::size_t numBoundaryScvf() const { @@ -629,6 +652,7 @@ private: // mappers ConnectivityMap connectivityMap_; IntersectionMapper intersectionMapper_; + int stencilOrder_; //! vectors that store the global data std::vector<std::vector<GridIndexType>> scvfIndicesOfScv_; diff --git a/dumux/discretization/staggered/gridfluxvariablescache.hh b/dumux/discretization/staggered/gridfluxvariablescache.hh index 5214858f72c0a31f65d42a9e660d860274b7bb2e..3c87372776d2c95922574fc8730da2ef0249097d 100644 --- a/dumux/discretization/staggered/gridfluxvariablescache.hh +++ b/dumux/discretization/staggered/gridfluxvariablescache.hh @@ -28,6 +28,8 @@ #include <dumux/discretization/localview.hh> #include <dumux/discretization/staggered/elementfluxvariablescache.hh> +#include <dumux/freeflow/higherorderapproximation.hh> + namespace Dumux { /*! @@ -42,7 +44,6 @@ struct StaggeredDefaultGridFluxVariablesCacheTraits using Problem = P; using FluxVariablesCache = FVC; using FluxVariablesCacheFiller = FVCF; - template<class GridFluxVariablesCache, bool cachingEnabled> using LocalView = StaggeredElementFluxVariablesCache<GridFluxVariablesCache, cachingEnabled>; }; @@ -72,6 +73,7 @@ class StaggeredGridFluxVariablesCache<P, FVC, FVCF, true, Traits> public: //! export the flux variable cache type using FluxVariablesCache = typename Traits::FluxVariablesCache; + using Scalar = typename FluxVariablesCache::Scalar; //! export the flux variable cache filler type using FluxVariablesCacheFiller = typename Traits::FluxVariablesCacheFiller; @@ -82,7 +84,10 @@ public: //! export the type of the local view using LocalView = typename Traits::template LocalView<ThisType, cachingEnabled>; - StaggeredGridFluxVariablesCache(const Problem& problem) : problemPtr_(&problem) {} + StaggeredGridFluxVariablesCache(const Problem& problem, const std::string& paramGroup = "") + : problemPtr_(&problem) + , higherOrderApproximation_(paramGroup) + {} // When global caching is enabled, precompute transmissibilities and stencils for all the scv faces template<class FVGridGeometry, class GridVolumeVariables, class SolutionVector> @@ -118,6 +123,12 @@ public: } } + //! Return the HigherOrderApproximation + const HigherOrderApproximation<Scalar>& higherOrderApproximation() const + { + return higherOrderApproximation_; + } + const Problem& problem() const { return *problemPtr_; } @@ -130,6 +141,7 @@ public: private: const Problem* problemPtr_; + HigherOrderApproximation<Scalar> higherOrderApproximation_; std::vector<FluxVariablesCache> fluxVarsCache_; std::vector<std::size_t> globalScvfIndices_; @@ -149,6 +161,7 @@ class StaggeredGridFluxVariablesCache<P, FVC, FVCF, false, Traits> public: //! export the flux variable cache type using FluxVariablesCache = typename Traits::FluxVariablesCache; + using Scalar = typename FluxVariablesCache::Scalar; //! export the flux variable cache filler type using FluxVariablesCacheFiller = typename Traits::FluxVariablesCacheFiller; @@ -159,7 +172,10 @@ public: //! export the type of the local view using LocalView = typename Traits::template LocalView<ThisType, cachingEnabled>; - StaggeredGridFluxVariablesCache(const Problem& problem) : problemPtr_(&problem) {} + StaggeredGridFluxVariablesCache(const Problem& problem, const std::string& paramGroup = "") + : problemPtr_(&problem) + , higherOrderApproximation_(paramGroup) + {} // When global caching is enabled, precompute transmissibilities and stencils for all the scv faces template<class FVGridGeometry, class GridVolumeVariables, class SolutionVector> @@ -171,10 +187,16 @@ public: const Problem& problem() const { return *problemPtr_; } -private: - + //! Return the HigherOrderApproximation + const HigherOrderApproximation<Scalar>& higherOrderApproximation() const + { + return higherOrderApproximation_; + } +private: const Problem* problemPtr_; + HigherOrderApproximation<Scalar> higherOrderApproximation_; + }; } // end namespace Dumux diff --git a/dumux/freeflow/CMakeLists.txt b/dumux/freeflow/CMakeLists.txt index 318f762168f1509c66e1f3c7e1b5f8cac466943e..5f16de206e056526ae1a904c3c0261c80257a51b 100644 --- a/dumux/freeflow/CMakeLists.txt +++ b/dumux/freeflow/CMakeLists.txt @@ -7,4 +7,5 @@ install(FILES properties.hh turbulenceproperties.hh volumevariables.hh +higherorderapproximation.hh DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/freeflow) diff --git a/dumux/freeflow/higherorderapproximation.hh b/dumux/freeflow/higherorderapproximation.hh new file mode 100644 index 0000000000000000000000000000000000000000..601bf115d219eec1d22c79af9b71e02e387feee5 --- /dev/null +++ b/dumux/freeflow/higherorderapproximation.hh @@ -0,0 +1,460 @@ +// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- +// vi: set et ts=4 sw=4 sts=4: +/***************************************************************************** + * See the file COPYING for full copying permissions. * + * * + * This program is free software: you can redistribute it and/or modify * + * it under the terms of the GNU General Public License as published by * + * the Free Software Foundation, either version 2 of the License, or * + * (at your option) any later version. * + * * + * This program is distributed in the hope that it will be useful, * + * but WITHOUT ANY WARRANTY; without even the implied warranty of * + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * + * GNU General Public License for more details. * + * * + * You should have received a copy of the GNU General Public License * + * along with this program. If not, see <http://www.gnu.org/licenses/>. * + *****************************************************************************/ +/** \file + * \brief This file contains different higher order methods for approximating the velocity. + */ + +#ifndef DUMUX_HIGHER_ORDER_VELOCITY_APPROXIMATION_HH +#define DUMUX_HIGHER_ORDER_VELOCITY_APPROXIMATION_HH + +#include <cmath> +#include <functional> +#include <iostream> +#include <string> + +#include <dumux/common/exceptions.hh> + +namespace Dumux { + +//! \brief Available Tvd approaches +enum class TvdApproach +{ + none, uniform, li, hou +}; + +//! \biraf Available differencing schemes +enum class DifferencingScheme +{ + none, vanleer, vanalbada, minmod, superbee, umist, mclimiter, wahyd +}; + +/** + * \brief This file contains different higher order methods for approximating the velocity. + */ +template<class Scalar> +class HigherOrderApproximation +{ +public: + HigherOrderApproximation(const std::string& paramGroup = "") + { + if (hasParamInGroup(paramGroup, "Discretization.TvdApproach")) + { + // Read the runtime parameters + tvdApproach_ = tvdApproachFromString(getParamFromGroup<std::string>(paramGroup, "Discretization.TvdApproach")); + differencingScheme_ = differencingSchemeFromString(getParamFromGroup<std::string>(paramGroup, "Discretization.DifferencingScheme")); + + // Assign the limiter_ depending on the differencing scheme + switch (differencingScheme_) + { + case DifferencingScheme::vanleer : + { + limiter_ = this->vanleer; + break; + } + case DifferencingScheme::vanalbada : + { + if (tvdApproach_ == TvdApproach::hou) + DUNE_THROW(ParameterException, "\nDifferencing scheme (Van Albada) is not implemented for the Tvd approach (Hou)."); + else + limiter_ = this->vanalbada; + break; + } + case DifferencingScheme::minmod : + { + limiter_ = this->minmod; + break; + } + case DifferencingScheme::superbee : + { + limiter_ = this->superbee; + break; + } + case DifferencingScheme::umist : + { + limiter_ = this->umist; + break; + } + case DifferencingScheme::mclimiter : + { + limiter_ = this->mclimiter; + break; + } + case DifferencingScheme::wahyd : + { + limiter_ = this->wahyd; + break; + } + default: + { + DUNE_THROW(ParameterException, "\nDifferencing scheme " << static_cast<std::string>(differencingSchemeToString(differencingScheme_)) << + " is not implemented.\n"); // should never be reached + break; + } + } + } + else + { + // If the runtime parameters are not specified we will use upwind + tvdApproach_ = TvdApproach::none; + differencingScheme_ = DifferencingScheme::none; + } + } + + /** + * \brief Convenience function to convert user input given as std::string + * to the corresponding enum class used for choosing the TVD Approach + */ + TvdApproach tvdApproachFromString(const std::string& tvd) + { + if (tvd == "Uniform") return TvdApproach::uniform; + if (tvd == "Li") return TvdApproach::li; + if (tvd == "Hou") return TvdApproach::hou; + DUNE_THROW(ParameterException, "\nThis tvd approach : \"" << tvd << "\" is not implemented.\n" + << "The available TVD approaches for uniform (and nonuniform) grids are as follows: \n" + << tvdApproachToString(TvdApproach::uniform) << ": Assumes a uniform cell size distribution\n" + << tvdApproachToString(TvdApproach::li) << ": Li's approach for nonuniform cell sizes\n" + << tvdApproachToString(TvdApproach::hou) << ": Hou's approach for nonuniform cell sizes"); + } + + /** + * \brief return the name of the TVD approach + */ + std::string tvdApproachToString(TvdApproach tvd) + { + switch (tvd) + { + case TvdApproach::uniform: return "Uniform"; + case TvdApproach::li: return "Li"; + case TvdApproach::hou: return "Hou"; + default: return "Invalid"; // should never be reached + } + } + + /** + * \brief Convenience function to convert user input given as std::string + * to the corresponding enum class used for choosing the Discretization Method + */ + DifferencingScheme differencingSchemeFromString(const std::string& differencingScheme) + { + if (differencingScheme == "vanleer") return DifferencingScheme::vanleer; + if (differencingScheme == "vanalbada") return DifferencingScheme::vanalbada; + if (differencingScheme == "minmod") return DifferencingScheme::minmod; + if (differencingScheme == "superbee") return DifferencingScheme::superbee; + if (differencingScheme == "umist") return DifferencingScheme::umist; + if (differencingScheme == "mclimiter") return DifferencingScheme::mclimiter; + if (differencingScheme == "wahyd") return DifferencingScheme::wahyd; + DUNE_THROW(ParameterException, "\nThis differencing scheme: \"" << differencingScheme << "\" is not implemented.\n" + << "The available differencing schemes are as follows: \n" + << differencingSchemeToString(DifferencingScheme::vanleer) << ": The Vanleer flux limiter\n" + << differencingSchemeToString(DifferencingScheme::vanalbada) << ": The VanAlbada flux limiter\n" + << differencingSchemeToString(DifferencingScheme::minmod) << ": The Min-Mod flux limiter\n" + << differencingSchemeToString(DifferencingScheme::superbee) << ": The SuperBEE flux limiter\n" + << differencingSchemeToString(DifferencingScheme::umist) << ": The UMist flux limiter\n" + << differencingSchemeToString(DifferencingScheme::mclimiter) << ": The McLimiter flux limiter\n" + << differencingSchemeToString(DifferencingScheme::wahyd) << ": The Wahyd flux limiter"); + } + + /** + * \brief return the name of the Discretization Method + */ + std::string differencingSchemeToString(DifferencingScheme differencingScheme) + { + switch (differencingScheme) + { + case DifferencingScheme::vanleer: return "vanleer"; + case DifferencingScheme::vanalbada: return "vanalbada"; + case DifferencingScheme::minmod: return "minmod"; + case DifferencingScheme::superbee: return "superbee"; + case DifferencingScheme::umist: return "umist"; + case DifferencingScheme::mclimiter: return "mclimiter"; + case DifferencingScheme::wahyd: return "wahyd"; + default: return "Invalid"; // should never be reached + } + } + + /** + * \brief Upwind Method + */ + Scalar upwind(const Scalar downstreamVelocity, + const Scalar upstreamVelocity, + const Scalar density, + const Scalar upwindWeight) const + { + return (upwindWeight * upstreamVelocity + (1.0 - upwindWeight) * downstreamVelocity) * density; + } + + /** + * \brief Central Differencing Method + */ + Scalar centralDifference(const Scalar downstreamVelocity, + const Scalar upstreamVelocity, + const Scalar density) const + { + return (0.5 * (upstreamVelocity + downstreamVelocity)) * density; + } + + /** + * \brief Linear Upwind Method + */ + Scalar linearUpwind(const Scalar upstreamVelocity, + const Scalar upUpstreamVelocity, + const Scalar upstreamToDownstreamDistance, + const Scalar upUpstreamToUpstreamDistance, + const Scalar density) const + { + Scalar zeroOrder = upstreamVelocity; + Scalar firstOrder = -1.0 * ((upstreamVelocity - upUpstreamVelocity) / upUpstreamToUpstreamDistance) * ( upstreamToDownstreamDistance / -2.0); + return (zeroOrder + firstOrder) * density; + } + + /** + * \brief QUICK upwinding Scheme: Quadratic Upstream Interpolation for Convective Kinematics + */ + Scalar upwindQUICK(const Scalar downstreamVelocity, + const Scalar upstreamVelocity, + const Scalar upUpstreamVelocity, + const Scalar upstreamToDownstreamDistance, + const Scalar upUpstreamToUpstreamDistance, + const Scalar density) const + { + Scalar normalDistance = (upUpstreamToUpstreamDistance + upstreamToDownstreamDistance) / 2.0; + Scalar zeroOrder = upstreamVelocity; + Scalar firstOrder = ((downstreamVelocity - upstreamVelocity) / 2.0); + Scalar secondOrder = -(((downstreamVelocity - upstreamVelocity) / upstreamToDownstreamDistance) - ((upstreamVelocity - upUpstreamVelocity) / upUpstreamToUpstreamDistance)) + * upstreamToDownstreamDistance * upstreamToDownstreamDistance / (8.0 * normalDistance); + return (zeroOrder + firstOrder + secondOrder) * density; + } + + /** + * \brief Tvd Scheme: Total Variation Diminishing + * + */ + Scalar tvd(const Scalar downstreamVelocity, + const Scalar upstreamVelocity, + const Scalar upUpstreamVelocity, + const Scalar upstreamToDownstreamDistance, + const Scalar upUpstreamToUpstreamDistance, + const Scalar downstreamStaggeredCellSize, + const bool selfIsUpstream, + const Scalar density, + const TvdApproach tvdApproach) const + { + Scalar momentum = 0.0; + switch(tvdApproach) + { + case TvdApproach::uniform : + { + momentum += tvdUniform(downstreamVelocity, upstreamVelocity, upUpstreamVelocity, density); + break; + } + case TvdApproach::li : + { + momentum += tvdLi(downstreamVelocity, upstreamVelocity, upUpstreamVelocity, upstreamToDownstreamDistance, upUpstreamToUpstreamDistance, selfIsUpstream, density); + break; + } + case TvdApproach::hou : + { + momentum += tvdHou(downstreamVelocity, upstreamVelocity, upUpstreamVelocity, upstreamToDownstreamDistance, upUpstreamToUpstreamDistance, downstreamStaggeredCellSize, density); + break; + } + default: + { + DUNE_THROW(ParameterException, "\nThis Tvd Approach is not implemented.\n"); + break; + } + } + return momentum; + } + + /** + * \brief Tvd Scheme: Total Variation Diminishing + * + * This function assumes the cell size distribution to be uniform. + */ + Scalar tvdUniform(const Scalar downstreamVelocity, + const Scalar upstreamVelocity, + const Scalar upUpstreamVelocity, + const Scalar density) const + { + using std::isfinite; + const Scalar ratio = (upstreamVelocity - upUpstreamVelocity) / (downstreamVelocity - upstreamVelocity); + + // If the velocity field is uniform (like at the first newton step) we get a NaN + if(ratio > 0.0 && isfinite(ratio)) + { + const Scalar secondOrderTerm = 0.5 * limiter_(ratio, 2.0) * (downstreamVelocity - upstreamVelocity); + return density * (upstreamVelocity + secondOrderTerm); + } + else + return density * upstreamVelocity; + } + + /** + * \brief Tvd Scheme: Total Variation Diminishing + * + * This function manages the non uniformities of the grid according to [Li, Liao 2007]. + * It tries to reconstruct the value for the velocity at the upstream-upstream point + * if the grid was uniform. + */ + Scalar tvdLi(const Scalar downstreamVelocity, + const Scalar upstreamVelocity, + const Scalar upUpstreamVelocity, + const Scalar upstreamToDownstreamDistance, + const Scalar upUpstreamToUpstreamDistance, + const bool selfIsUpstream, + const Scalar density) const + { + using std::isfinite; + // I need the information of selfIsUpstream to get the correct sign because upUpstreamToUpstreamDistance is always positive + const Scalar upUpstreamGradient = (upstreamVelocity - upUpstreamVelocity) / upUpstreamToUpstreamDistance * selfIsUpstream; + + // Distance between the upUpstream node and the position where it should be if the grid were uniform. + const Scalar correctionDistance = upUpstreamToUpstreamDistance - upstreamToDownstreamDistance; + const Scalar reconstrutedUpUpstreamVelocity = upUpstreamVelocity + upUpstreamGradient * correctionDistance; + const Scalar ratio = (upstreamVelocity - reconstrutedUpUpstreamVelocity) / (downstreamVelocity - upstreamVelocity); + + // If the velocity field is uniform (like at the first newton step) we get a NaN + if(ratio > 0.0 && isfinite(ratio)) + { + const Scalar secondOrderTerm = 0.5 * limiter_(ratio, 2.0) * (downstreamVelocity - upstreamVelocity); + return density * (upstreamVelocity + secondOrderTerm); + } + else + return density * upstreamVelocity; + } + + /** + * \brief Tvd Scheme: Total Variation Diminishing + * + * This function manages the non uniformities of the grid according to [Hou, Simons, Hinkelmann 2007]. + * It should behave better then the Li's version in very stretched grids. + */ + Scalar tvdHou(const Scalar downstreamVelocity, + const Scalar upstreamVelocity, + const Scalar upUpstreamVelocity, + const Scalar upstreamToDownstreamDistance, + const Scalar upUpstreamToUpstreamDistance, + const Scalar downstreamStaggeredCellSize, + const Scalar density) const + { + using std::isfinite; + const Scalar ratio = (upstreamVelocity - upUpstreamVelocity) / (downstreamVelocity - upstreamVelocity) + * upstreamToDownstreamDistance / upUpstreamToUpstreamDistance; + + // If the velocity field is uniform (like at the first newton step) we get a NaN + if(ratio > 0.0 && isfinite(ratio)) + { + const Scalar upstreamStaggeredCellSize = 0.5 * (upstreamToDownstreamDistance + upUpstreamToUpstreamDistance); + const Scalar R = (upstreamStaggeredCellSize + downstreamStaggeredCellSize) / upstreamStaggeredCellSize; + const Scalar secondOrderTerm = limiter_(ratio, R) / R * (downstreamVelocity - upstreamVelocity); + return density * (upstreamVelocity + secondOrderTerm); + } + else + return density * upstreamVelocity; + } + + /** + * \brief Van Leer flux limiter function [Van Leer 1974] + * + * With R != 2 is the modified Van Leer flux limiter function [Hou, Simons, Hinkelmann 2007] + */ + static Scalar vanleer(const Scalar r, const Scalar R) + { + return R * r / (R - 1.0 + r); + } + + /** + * \brief Van Albada flux limiter function [Van Albada et al. 1982] + */ + static Scalar vanalbada(const Scalar r, const Scalar R) + { + return r * (r + 1.0) / (1.0 + r * r); + } + + /** + * \brief MinMod flux limiter function [Roe 1985] + */ + static Scalar minmod(const Scalar r, const Scalar R) + { + using std::min; + return min(r, 1.0); + } + + /** + * \brief SUPERBEE flux limiter function [Roe 1985] + * + * With R != 2 is the modified SUPERBEE flux limiter function [Hou, Simons, Hinkelmann 2007] + */ + static Scalar superbee(const Scalar r, const Scalar R) + { + using std::min; + using std::max; + return max(min(R * r, 1.0), min(r, R)); + } + + /** + * \brief UMIST flux limiter function [Lien and Leschziner 1993] + */ + static Scalar umist(const Scalar r, const Scalar R) + { + using std::min; + return min({R * r, (r * (5.0 - R) + R - 1.0) / 4.0, (r * (R - 1.0) + 5.0 - R) / 4.0, R}); + } + + /* + * \brief Monotonized-Central limiter [Van Leer 1977] + */ + static Scalar mclimiter(const Scalar r, const Scalar R) + { + using std::min; + return min({R * r, (r + 1.0) / 2.0, R}); + } + + /** + * \brief WAHYD Scheme [Hou, Simons, Hinkelmann 2007]; + */ + static Scalar wahyd(const Scalar r, const Scalar R) + { + using std::min; + return r > 1 ? min((r + R * r * r) / (R + r * r), R) + : vanleer(r, R); + } + + //! Returns the Tvd approach + const TvdApproach& tvdApproach() const + { + return tvdApproach_; + } + + //! Returns the differencing scheme + const DifferencingScheme& differencingScheme() const + { + return differencingScheme_; + } + +private: + TvdApproach tvdApproach_; + DifferencingScheme differencingScheme_; + + std::function<Scalar(const Scalar, const Scalar)> limiter_; +}; + +} // end namespace Dumux + +#endif // DUMUX_HIGHER_ORDER_VELOCITY_APPROXIMATION_HH diff --git a/dumux/freeflow/navierstokes/fluxvariablescache.hh b/dumux/freeflow/navierstokes/fluxvariablescache.hh index 9f1c6ff9144b43bd215198fbaf2441212393eda0..a7651c0496c53499ea4843b6fe1b8b439956ee0f 100644 --- a/dumux/freeflow/navierstokes/fluxvariablescache.hh +++ b/dumux/freeflow/navierstokes/fluxvariablescache.hh @@ -59,6 +59,8 @@ class FreeFlowFluxVariablesCacheImplementation<TypeTag, DiscretizationMethod::st using Element = typename GridView::template Codim<0>::Entity; public: + using Scalar = GetPropType<TypeTag, Properties::Scalar>; + //! Do nothing for the staggered grid specialization. void update(const Problem& problem, const Element& element, diff --git a/dumux/freeflow/navierstokes/problem.hh b/dumux/freeflow/navierstokes/problem.hh index 58922e3fc8b2cece2feeb7f85a5858cfb7c0832e..d16dfbfe62318301ff529aab7a11a0ca2c9f30a4 100644 --- a/dumux/freeflow/navierstokes/problem.hh +++ b/dumux/freeflow/navierstokes/problem.hh @@ -28,6 +28,7 @@ #include <dumux/common/properties.hh> #include <dumux/common/staggeredfvproblem.hh> #include <dumux/discretization/method.hh> + #include "model.hh" namespace Dumux { @@ -215,7 +216,7 @@ public: using std::sqrt; const Scalar K = asImp_().permeability(element, normalFace); const Scalar alpha = asImp_().alphaBJ(normalFace); - return velocitySelf / (alpha / sqrt(K) * scvf.pairData(localSubFaceIdx).parallelDistance + 1.0); + return velocitySelf / (alpha / sqrt(K) * scvf.cellCenteredParallelDistance(localSubFaceIdx,0) + 1.0); } private: diff --git a/dumux/freeflow/navierstokes/staggered/fluxvariables.hh b/dumux/freeflow/navierstokes/staggered/fluxvariables.hh index 5bf038741a1b122e14e45804fce996d0d40c228c..a39cd4824f2866c0e120b8c90e98ab13e3781b03 100644 --- a/dumux/freeflow/navierstokes/staggered/fluxvariables.hh +++ b/dumux/freeflow/navierstokes/staggered/fluxvariables.hh @@ -24,10 +24,15 @@ #ifndef DUMUX_NAVIERSTOKES_STAGGERED_FLUXVARIABLES_HH #define DUMUX_NAVIERSTOKES_STAGGERED_FLUXVARIABLES_HH +#include <array> + #include <dumux/common/math.hh> +#include <dumux/common/exceptions.hh> #include <dumux/common/parameters.hh> #include <dumux/common/properties.hh> +#include <dumux/freeflow/higherorderapproximation.hh> + #include <dumux/flux/fluxvariablesbase.hh> #include <dumux/discretization/method.hh> @@ -102,7 +107,7 @@ public: { const Scalar velocity = elemFaceVars[scvf].velocitySelf(); const bool insideIsUpstream = scvf.directionSign() == sign(velocity); - static const Scalar upWindWeight = getParamFromGroup<Scalar>(problem.paramGroup(), "Flux.UpwindWeight"); + static const Scalar upwindWeight = getParamFromGroup<Scalar>(problem.paramGroup(), "Flux.UpwindWeight"); const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; const auto& outsideVolVars = elemVolVars[scvf.outsideScvIdx()]; @@ -110,8 +115,8 @@ public: const auto& upstreamVolVars = insideIsUpstream ? insideVolVars : outsideVolVars; const auto& downstreamVolVars = insideIsUpstream ? outsideVolVars : insideVolVars; - const Scalar flux = (upWindWeight * upwindTerm(upstreamVolVars) + - (1.0 - upWindWeight) * upwindTerm(downstreamVolVars)) + const Scalar flux = (upwindWeight * upwindTerm(upstreamVolVars) + + (1.0 - upwindWeight) * upwindTerm(downstreamVolVars)) * velocity * scvf.area() * scvf.directionSign(); return flux * extrusionFactor_(elemVolVars, scvf); @@ -158,10 +163,11 @@ public: const SubControlVolumeFace& scvf, const FVElementGeometry& fvGeometry, const ElementVolumeVariables& elemVolVars, - const ElementFaceVariables& elemFaceVars) + const ElementFaceVariables& elemFaceVars, + const GridFluxVariablesCache& gridFluxVarsCache) { - return computeFrontalMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars) + - computeLateralMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars); + return computeFrontalMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars, gridFluxVarsCache) + + computeLateralMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars, gridFluxVarsCache); } /*! @@ -186,13 +192,15 @@ public: const SubControlVolumeFace& scvf, const FVElementGeometry& fvGeometry, const ElementVolumeVariables& elemVolVars, - const ElementFaceVariables& elemFaceVars) + const ElementFaceVariables& elemFaceVars, + const GridFluxVariablesCache& gridFluxVarsCache) { FacePrimaryVariables frontalFlux(0.0); // The velocities of the dof at interest and the one of the opposite scvf. const Scalar velocitySelf = elemFaceVars[scvf].velocitySelf(); const Scalar velocityOpposite = elemFaceVars[scvf].velocityOpposite(); + static const Scalar upwindWeight = getParamFromGroup<Scalar>(problem.paramGroup(), "Flux.UpwindWeight"); // The volume variables within the current element. We only require those (and none of neighboring elements) // because the fluxes are calculated over the staggered face at the center of the element. @@ -207,17 +215,36 @@ public: // Check if the the velocity of the dof at interest lies up- or downstream w.r.t. to the transporting velocity. const bool selfIsUpstream = scvf.directionSign() != sign(transportingVelocity); - // Lamba function to evaluate the transported momentum, regarding an user-specified upwind weight. - auto computeMomentum = [&insideVolVars, &problem](const Scalar upstreamVelocity, const Scalar downstreamVelocity) - { - static const Scalar upwindWeight = getParamFromGroup<Scalar>(problem.paramGroup(), "Flux.UpwindWeight"); - return (upwindWeight * upstreamVelocity + (1.0 - upwindWeight) * downstreamVelocity) * insideVolVars.density(); - }; + Scalar momentum = 0.0; + + // Variables that will store the velocities of interest: + // velocities[0]: downstream velocity + // velocities[1]: upstream velocity + // velocities[2]: upstream-upstream velocity + std::array<Scalar, 3> velocities{0.0, 0.0, 0.0}; + // Variables that will store the distances between the dofs of interest: + // distances[0]: upstream to downstream distance + // distances[1]: upstream-upstream to upstream distance + // distances[2]: downstream staggered cell size + std::array<Scalar, 3> distances{0.0, 0.0, 0.0}; - // Get the momentum that is advectively transported and account for the flow direction. - const Scalar momentum = selfIsUpstream ? computeMomentum(velocitySelf, velocityOpposite) - : computeMomentum(velocityOpposite, velocitySelf); + const auto& highOrder = gridFluxVarsCache.higherOrderApproximation(); + + // If a Tvd approach has been specified and I am not too near to the boundary I can use a second order + // approximation for the velocity. In this frontal flux I use for the density always the value that I have on the scvf. + if (highOrder.tvdApproach() != TvdApproach::none) + { + if (canFrontalSecondOrder_(scvf, selfIsUpstream, velocities, distances, elemFaceVars[scvf])) + { + momentum = highOrder.tvd(velocities[0], velocities[1], velocities[2], distances[0], distances[1], distances[2], selfIsUpstream, insideVolVars.density(), highOrder.tvdApproach()); + } + else + momentum = highOrder.upwind(velocities[0], velocities[1], insideVolVars.density(), upwindWeight); + } + else + momentum = selfIsUpstream ? highOrder.upwind(velocityOpposite, velocitySelf, insideVolVars.density(), upwindWeight) + : highOrder.upwind(velocitySelf, velocityOpposite, insideVolVars.density(), upwindWeight); // Account for the orientation of the staggered face's normal outer normal vector // (pointing in opposite direction of the scvf's one). @@ -279,7 +306,8 @@ public: const SubControlVolumeFace& scvf, const FVElementGeometry& fvGeometry, const ElementVolumeVariables& elemVolVars, - const ElementFaceVariables& elemFaceVars) + const ElementFaceVariables& elemFaceVars, + const GridFluxVariablesCache& gridFluxVarsCache) { FacePrimaryVariables normalFlux(0.0); auto& faceVars = elemFaceVars[scvf]; @@ -290,18 +318,18 @@ public: { const auto eIdx = scvf.insideScvIdx(); // Get the face normal to the face the dof lives on. The staggered sub face conincides with half of this normal face. - const auto& normalFace = fvGeometry.scvf(eIdx, scvf.pairData()[localSubFaceIdx].localNormalFaceIdx); + const auto& normalFace = fvGeometry.scvf(eIdx, scvf.pairData(localSubFaceIdx).localNormalFaceIdx); bool lateralFaceHasDirichletPressure = false; // check for Dirichlet boundary condition for the pressure bool lateralFaceHasBJS = false; // check for Beavers-Joseph-Saffman boundary condition // Check if there is face/element parallel to our face of interest where the dof lives on. If there is no parallel neighbor, // we are on a boundary where we have to check for boundary conditions. - if(!scvf.hasParallelNeighbor(localSubFaceIdx)) + if(!scvf.hasParallelNeighbor(localSubFaceIdx,0)) { // Construct a temporary scvf which corresponds to the staggered sub face, featuring the location // the sub faces's center. - auto localSubFaceCenter = scvf.pairData(localSubFaceIdx).virtualOuterParallelFaceDofPos - normalFace.center(); + auto localSubFaceCenter = scvf.pairData(localSubFaceIdx).virtualFirstParallelFaceDofPos - normalFace.center(); localSubFaceCenter *= 0.5; localSubFaceCenter += normalFace.center(); const auto localSubFace = makeGhostFace_(normalFace, localSubFaceCenter); @@ -339,9 +367,9 @@ public: // If there is no symmetry or Neumann boundary condition for the given sub face, proceed to calculate the tangential momentum flux. if (problem.enableInertiaTerms()) - normalFlux += computeAdvectivePartOfLateralMomentumFlux_(problem, element, scvf, normalFace, elemVolVars, faceVars, localSubFaceIdx, lateralFaceHasDirichletPressure, lateralFaceHasBJS); + normalFlux += computeAdvectivePartOfLateralMomentumFlux_(problem, fvGeometry, element, scvf, normalFace, elemVolVars, faceVars, gridFluxVarsCache, localSubFaceIdx, lateralFaceHasDirichletPressure, lateralFaceHasBJS); - normalFlux += computeDiffusivePartOfLateralMomentumFlux_(problem, element, scvf, normalFace, elemVolVars, faceVars, localSubFaceIdx, lateralFaceHasDirichletPressure, lateralFaceHasBJS); + normalFlux += computeDiffusivePartOfLateralMomentumFlux_(problem, fvGeometry, element, scvf, normalFace, elemVolVars, faceVars, localSubFaceIdx, lateralFaceHasDirichletPressure, lateralFaceHasBJS); } return normalFlux; } @@ -370,11 +398,13 @@ private: * \endverbatim */ FacePrimaryVariables computeAdvectivePartOfLateralMomentumFlux_(const Problem& problem, + const FVElementGeometry& fvGeometry, const Element& element, const SubControlVolumeFace& scvf, const SubControlVolumeFace& normalFace, const ElementVolumeVariables& elemVolVars, const FaceVariables& faceVars, + const GridFluxVariablesCache& gridFluxVarsCache, const int localSubFaceIdx, const bool lateralFaceHasDirichletPressure, const bool lateralFaceHasBJS) @@ -383,55 +413,50 @@ private: // of interest is located. const Scalar transportingVelocity = faceVars.velocityNormalInside(localSubFaceIdx); - // Check whether the own or the neighboring element is upstream. - const bool ownElementIsUpstream = ( normalFace.directionSign() == sign(transportingVelocity) ); - - // Get the velocities at the current (own) scvf and at the parallel one at the neighboring scvf. - const Scalar velocitySelf = faceVars.velocitySelf(); + static const Scalar upwindWeight = getParamFromGroup<Scalar>(problem.paramGroup(), "Flux.UpwindWeight", 1.0); - // Lambda to conveniently get the outer parallel velocity for normal faces that are on the boundary - // and therefore have no neighbor. Calls the problem to retrieve a fixed value set on the boundary. - auto getParallelVelocityFromBoundary = [&]() - { - // If there is a Dirichlet condition for the pressure we assume zero gradient for the velocity, - // so the velocity at the boundary equal to that on the scvf. - if (lateralFaceHasDirichletPressure) - return velocitySelf; + // Check whether the own or the neighboring element is upstream. + const bool selfIsUpstream = ( normalFace.directionSign() == sign(transportingVelocity) ); - // Check if we have a Beavers-Joseph-Saffman condition. - // If yes, the parallel velocity at the boundary is calculated accordingly. - if (lateralFaceHasBJS) - return problem.bjsVelocity(element, scvf, normalFace, localSubFaceIdx, velocitySelf); + // Get the volume variables of the own and the neighboring element + const auto& insideVolVars = elemVolVars[normalFace.insideScvIdx()]; + const auto& outsideVolVars = elemVolVars[normalFace.outsideScvIdx()]; - const auto ghostFace = makeParallelGhostFace_(scvf, localSubFaceIdx); + Scalar momentum = 0.0; - return problem.dirichlet(element, ghostFace)[Indices::velocity(scvf.directionIndex())]; - }; + // Variables that will store the velocities of interest: + // velocities[0]: downstream velocity + // velocities[1]: upsteram velocity + // velocities[2]: upstream-upstream velocity + std::array<Scalar, 3> velocities{0.0, 0.0, 0.0}; - const Scalar velocityParallel = scvf.hasParallelNeighbor(localSubFaceIdx) - ? faceVars.velocityParallel(localSubFaceIdx) - : getParallelVelocityFromBoundary(); + // Variables that will store the distances between the dofs of interest: + // distances[0]: upstream to downstream distance + // distances[1]: upstream-upstream to upstream distance + // distances[2]: downstream staggered cell size + std::array<Scalar, 3> distances{0.0, 0.0, 0.0}; - // Get the volume variables of the own and the neighboring element - const auto& insideVolVars = elemVolVars[normalFace.insideScvIdx()]; - const auto& outsideVolVars = elemVolVars[normalFace.outsideScvIdx()]; + const auto& highOrder = gridFluxVarsCache.higherOrderApproximation(); - // Lamba function to evaluate the transported momentum, regarding an user-specified upwind weight. - auto computeMomentum = [&problem](const VolumeVariables& upstreamVolVars, - const VolumeVariables& downstreamVolVars, - const Scalar upstreamVelocity, - const Scalar downstreamVelocity) + // If a Tvd approach has been specified and I am not too near to the boundary I can use a second order approximation. + if (highOrder.tvdApproach() != TvdApproach::none) + { + if (canLateralSecondOrder_(scvf, fvGeometry, selfIsUpstream, localSubFaceIdx, velocities, distances, problem, element, faceVars, lateralFaceHasDirichletPressure, lateralFaceHasBJS)) + { + momentum = highOrder.tvd(velocities[0], velocities[1], velocities[2], distances[0], distances[1], distances[2], selfIsUpstream, selfIsUpstream ? insideVolVars.density() : outsideVolVars.density(), highOrder.tvdApproach()); + } + else + momentum = highOrder.upwind(velocities[0], velocities[1], selfIsUpstream ? insideVolVars.density() : outsideVolVars.density(), upwindWeight); + } + else { - static const Scalar upWindWeight = getParamFromGroup<Scalar>(problem.paramGroup(), "Flux.UpwindWeight"); - const Scalar density = upWindWeight * upstreamVolVars.density() + (1.0 - upWindWeight) * downstreamVolVars.density(); - const Scalar transportedVelocity = upWindWeight * upstreamVelocity + (1.0 - upWindWeight) * downstreamVelocity; - return transportedVelocity * density; - }; + const Scalar velocityFirstParallel = scvf.hasParallelNeighbor(localSubFaceIdx, 0) + ? faceVars.velocityParallel(localSubFaceIdx, 0) + : getParallelVelocityFromBoundary_(problem, scvf, normalFace, faceVars.velocitySelf(), localSubFaceIdx, element, lateralFaceHasDirichletPressure, lateralFaceHasBJS); - // Get the momentum that is advectively transported and account for the flow direction. - const Scalar momentum = ownElementIsUpstream ? - computeMomentum(insideVolVars, outsideVolVars, velocitySelf, velocityParallel) - : computeMomentum(outsideVolVars, insideVolVars, velocityParallel, velocitySelf); + momentum = selfIsUpstream ? highOrder.upwind(velocityFirstParallel, faceVars.velocitySelf(), insideVolVars.density(), upwindWeight) + : highOrder.upwind(faceVars.velocitySelf(), velocityFirstParallel, outsideVolVars.density(), upwindWeight); + } // Account for the orientation of the staggered normal face's outer normal vector // and its area (0.5 of the coinciding scfv). @@ -461,6 +486,7 @@ private: * \endverbatim */ FacePrimaryVariables computeDiffusivePartOfLateralMomentumFlux_(const Problem& problem, + const FVElementGeometry& fvGeometry, const Element& element, const SubControlVolumeFace& scvf, const SubControlVolumeFace& normalFace, @@ -519,24 +545,14 @@ private: // and at the parallel one at the neighboring scvf. const Scalar innerParallelVelocity = faceVars.velocitySelf(); - // Lambda to conveniently get the outer parallel velocity for normal faces that are on the boundary - // and therefore have no neighbor. Calls the problem to retrieve a fixed value set on the boundary. - auto getParallelVelocityFromBoundary = [&]() - { - const auto ghostFace = makeParallelGhostFace_(scvf, localSubFaceIdx); - if (lateralFaceHasBJS) - return problem.bjsVelocity(element, scvf, normalFace, localSubFaceIdx, innerParallelVelocity); - return problem.dirichlet(element, ghostFace)[Indices::velocity(scvf.directionIndex())]; - }; - - const Scalar outerParallelVelocity = scvf.hasParallelNeighbor(localSubFaceIdx) - ? faceVars.velocityParallel(localSubFaceIdx) - : getParallelVelocityFromBoundary(); + const Scalar velocityFirstParallel = scvf.hasParallelNeighbor(localSubFaceIdx,0) + ? faceVars.velocityParallel(localSubFaceIdx,0) + : getParallelVelocityFromBoundary_(problem, scvf, normalFace, innerParallelVelocity, localSubFaceIdx, element, false, lateralFaceHasBJS); // The velocity gradient already accounts for the orientation // of the staggered face's outer normal vector. - const Scalar parallelGradient = (outerParallelVelocity - innerParallelVelocity) - / scvf.pairData(localSubFaceIdx).parallelDistance; + const Scalar parallelGradient = (velocityFirstParallel - innerParallelVelocity) + / scvf.cellCenteredParallelDistance(localSubFaceIdx,0); normalDiffusiveFlux -= muAvg * parallelGradient; } @@ -597,13 +613,13 @@ private: //! helper function to conveniently create a ghost face used to retrieve boundary values from the problem SubControlVolumeFace makeGhostFace_(const SubControlVolumeFace& ownScvf, const GlobalPosition& pos) const { - return SubControlVolumeFace(pos, std::vector<unsigned int>{ownScvf.insideScvIdx(), ownScvf.outsideScvIdx()}, ownScvf.directionIndex(), ownScvf.dofIndex(), ownScvf.index()); + return SubControlVolumeFace(pos, std::vector<unsigned int>{ownScvf.insideScvIdx(), ownScvf.outsideScvIdx()}, ownScvf.directionIndex(), ownScvf.axisData().selfDof, ownScvf.index()); }; //! helper function to conveniently create a ghost face which is outside the domain, parallel to the scvf of interest SubControlVolumeFace makeParallelGhostFace_(const SubControlVolumeFace& ownScvf, const int localSubFaceIdx) const { - return makeGhostFace_(ownScvf, ownScvf.pairData(localSubFaceIdx).virtualOuterParallelFaceDofPos); + return makeGhostFace_(ownScvf, ownScvf.pairData(localSubFaceIdx).virtualFirstParallelFaceDofPos); }; //! helper function to get the averaged extrusion factor for a face @@ -613,7 +629,6 @@ private: const auto& outsideVolVars = elemVolVars[scvf.outsideScvIdx()]; return harmonicMean(insideVolVars.extrusionFactor(), outsideVolVars.extrusionFactor()); } - //! do nothing if no turbulence model is used template<class ...Args, bool turbulenceModel = ModelTraits::usesTurbulenceModel(), std::enable_if_t<!turbulenceModel, int> = 0> bool incorporateWallFunction_(Args&&... args) const @@ -639,9 +654,235 @@ private: } else return false; - }; + } + + /*! + * \brief Check if a second order approximation for the frontal part of the advective term can be used + * + * This helper function checks if the scvf of interest is not too near to the + * boundary so that a dof upstream with respect to the upstream dof is available. + * + * \param ownScvf The SubControlVolumeFace we are considering + * \param selfIsUpstream @c true if the velocity ownScvf is upstream wrt the transporting velocity + * \param velocities Variable that will store the velocities of interest + * \param distances Variable that will store the distances of interest + * \param faceVars The face variables related to ownScvf + */ + bool canFrontalSecondOrder_(const SubControlVolumeFace& ownScvf, + const bool selfIsUpstream, + std::array<Scalar, 3>& velocities, + std::array<Scalar, 3>& distances, + const FaceVariables& faceVars) const + { + // Depending on selfIsUpstream I can assign the downstream and the upstream velocities, + // then I have to check if I have a forward or a backward neighbor to retrieve + // an "upstream-upstream velocity" and be able to use a second order scheme. + if (selfIsUpstream) + { + velocities[0] = faceVars.velocityOpposite(); + velocities[1] = faceVars.velocitySelf(); + + if (ownScvf.hasForwardNeighbor(0)) + { + velocities[2] = faceVars.velocityForward(0); + distances[0] = ownScvf.selfToOppositeDistance(); + distances[1] = ownScvf.axisData().inAxisForwardDistances[0]; + distances[2] = 0.5 * (ownScvf.axisData().selfToOppositeDistance + ownScvf.axisData().inAxisBackwardDistances[0]); + return true; + } + else + return false; + } + else + { + velocities[0] = faceVars.velocitySelf(); + velocities[1] = faceVars.velocityOpposite(); + + if (ownScvf.hasBackwardNeighbor(0)) + { + velocities[2] = faceVars.velocityBackward(0); + distances[0] = ownScvf.selfToOppositeDistance(); + distances[1] = ownScvf.axisData().inAxisBackwardDistances[0]; + distances[2] = 0.5 * (ownScvf.axisData().selfToOppositeDistance + ownScvf.axisData().inAxisForwardDistances[0]); + return true; + } + else + return false; + } + } + + /*! + * \brief Check if a second order approximation for the lateral part of the advective term can be used + * + * This helper function checks if the scvf of interest is not too near to the + * boundary so that a dof upstream with respect to the upstream dof is available. + * + * \param ownScvf The SubControlVolumeFace we are considering + * \param selfIsUpstream @c true if the velocity ownScvf is upstream wrt the transporting velocity + * \param localSubFaceIdx The local subface index + * \param velocities Variable that will store the velocities of interest + * \param distances Variable that will store the distances of interest + */ + bool canLateralSecondOrder_(const SubControlVolumeFace& ownScvf, + const FVElementGeometry& fvGeometry, + const bool selfIsUpstream, + const int localSubFaceIdx, + std::array<Scalar, 3>& velocities, + std::array<Scalar, 3>& distances, + const Problem& problem, + const Element& element, + const FaceVariables& faceVars, + const bool lateralFaceHasDirichletPressure, + const bool lateralFaceHasBJS) const + { + const SubControlVolumeFace& normalFace = fvGeometry.scvf(ownScvf.insideScvIdx(), ownScvf.pairData(localSubFaceIdx).localNormalFaceIdx); + + // The local index of the faces that is opposite to localSubFaceIdx + const int oppositeSubFaceIdx = localSubFaceIdx % 2 ? localSubFaceIdx - 1 : localSubFaceIdx + 1; + + if (selfIsUpstream) + { + // I can assign the upstream velocity. The downstream velocity can be assigned or retrieved + // from the boundary if there is no parallel neighbor. + velocities[1] = faceVars.velocitySelf(); + + if(ownScvf.hasParallelNeighbor(localSubFaceIdx, 0)) + { + velocities[0] = faceVars.velocityParallel(localSubFaceIdx, 0); + distances[2] = ownScvf.pairData(localSubFaceIdx).parallelDistances[1]; + } + else + { + velocities[0] = getParallelVelocityFromBoundary_(problem, ownScvf, normalFace, faceVars.velocitySelf(), localSubFaceIdx, element, lateralFaceHasDirichletPressure, lateralFaceHasBJS); + distances[2] = ownScvf.area() / 2.0; + } + + // The "upstream-upsteram" velocity is retrieved from the other parallel neighbor + // or from the boundary. + if (ownScvf.hasParallelNeighbor(oppositeSubFaceIdx, 0)) + velocities[2] = faceVars.velocityParallel(oppositeSubFaceIdx, 0); + else + velocities[2] = getParallelVelocityFromOtherBoundary_(problem, fvGeometry, ownScvf, oppositeSubFaceIdx, element, velocities[1]); + + distances[0] = ownScvf.cellCenteredParallelDistance(localSubFaceIdx, 0); + distances[1] = ownScvf.cellCenteredParallelDistance(oppositeSubFaceIdx, 0); + + return true; + } + else + { + // The self velocity is downstream, then if there is no parallel neighbor I can not use + // a second order approximation beacuse I have only two velocities. + velocities[0] = faceVars.velocitySelf(); + + if (!ownScvf.hasParallelNeighbor(localSubFaceIdx, 0)) + { + velocities[1] = getParallelVelocityFromBoundary_(problem, ownScvf, normalFace, faceVars.velocitySelf(), localSubFaceIdx, element, lateralFaceHasDirichletPressure, lateralFaceHasBJS); + return false; + } + + velocities[1] = faceVars.velocityParallel(localSubFaceIdx, 0); + + // If there is another parallel neighbor I can assign the "upstream-upstream" + // velocity, otherwise I retrieve it from the boundary. + if (ownScvf.hasParallelNeighbor(localSubFaceIdx, 1)) + velocities[2] = faceVars.velocityParallel(localSubFaceIdx, 1); + else + { + const Element& elementParallel = fvGeometry.fvGridGeometry().element(fvGeometry.scv(normalFace.outsideScvIdx())); + const SubControlVolumeFace& firstParallelScvf = fvGeometry.scvf(normalFace.outsideScvIdx(), ownScvf.localFaceIdx()); + velocities[2] = getParallelVelocityFromOtherBoundary_(problem, fvGeometry, firstParallelScvf, localSubFaceIdx, elementParallel, velocities[1]); + } + + distances[0] = ownScvf.cellCenteredParallelDistance(localSubFaceIdx, 0); + distances[1] = ownScvf.cellCenteredParallelDistance(localSubFaceIdx, 1); + distances[2] = ownScvf.area(); + + return true; + } + } + + /*! + * \brief Return the outer parallel velocity for normal faces that are on the boundary and therefore have no neighbor. + * + * Calls the problem to retrieve a fixed value set on the boundary. + * + * \param problem The problem + * \param scvf The SubControlVolumeFace that is normal to the boundary + * \param normalFace The face at the boundary + * \param velocitySelf the velocity at scvf + * \param localSubFaceIdx The local index of the face that is on the boundary + * \param element The element that is on the boundary + * \param lateralFaceHasDirichletPressure @c true if there is a dirichlet condition for the pressure on the boundary + * \param lateralFaceHasBJS @c true if there is a BJS condition fot the velocity on the boundary + */ + Scalar getParallelVelocityFromBoundary_(const Problem& problem, + const SubControlVolumeFace& scvf, + const SubControlVolumeFace& normalFace, + const Scalar velocitySelf, + const int localSubFaceIdx, + const Element& element, + const bool lateralFaceHasDirichletPressure, + const bool lateralFaceHasBJS) const + { + // If there is a Dirichlet condition for the pressure we assume zero gradient for the velocity, + // so the velocity at the boundary equal to that on the scvf. + if (lateralFaceHasDirichletPressure) + return velocitySelf; + + const auto ghostFace = makeParallelGhostFace_(scvf, localSubFaceIdx); + if (lateralFaceHasBJS) + return problem.bjsVelocity(element, scvf, normalFace, localSubFaceIdx, velocitySelf); + return problem.dirichlet(element, ghostFace)[Indices::velocity(scvf.directionIndex())]; + } + + /*! + * \brief Return a velocity value from a boundary for which the boundary conditions have to be checked. + * + * \param problem The problem + * \param scvf The SubControlVolumeFace that is normal to the boundary + * \param localIdx The local index of the face that is on the boundary + * \param boundaryElement The element that is on the boundary + * \param parallelVelocity The velocity over scvf + */ + Scalar getParallelVelocityFromOtherBoundary_(const Problem& problem, + const FVElementGeometry& fvGeometry, + const SubControlVolumeFace& scvf, + const int localIdx, + const Element& boundaryElement, + const Scalar parallelVelocity) const + { + // A ghost subface at the boundary is created, featuring the location of the sub face's center + const SubControlVolumeFace& boundaryNormalFace = fvGeometry.scvf(scvf.insideScvIdx(), scvf.pairData(localIdx).localNormalFaceIdx); + GlobalPosition boundarySubFaceCenter = scvf.pairData(localIdx).virtualFirstParallelFaceDofPos + boundaryNormalFace.center(); + boundarySubFaceCenter *= 0.5; + const SubControlVolumeFace boundarySubFace = makeGhostFace_(boundaryNormalFace, boundarySubFaceCenter); + + // The boundary condition is checked, in case of symmetry or Dirichlet for the pressure + // a gradient of zero is assumed in the direction normal to the bounadry, while if there is + // Dirichlet of BJS for the velocity the related values are exploited. + const auto bcTypes = problem.boundaryTypes(boundaryElement, boundarySubFace); + + if (bcTypes.isDirichlet(Indices::velocity(scvf.directionIndex()))) + { + const SubControlVolumeFace ghostFace = makeParallelGhostFace_(scvf, localIdx); + return problem.dirichlet(boundaryElement, ghostFace)[Indices::velocity(scvf.directionIndex())]; + } + else if (bcTypes.isSymmetry() || bcTypes.isDirichlet(Indices::pressureIdx)) + return parallelVelocity; + else if (bcTypes.isBJS(Indices::velocity(scvf.directionIndex()))) + { + const SubControlVolumeFace ghostFace = makeParallelGhostFace_(scvf, localIdx); + return problem.bjsVelocity(boundaryElement, scvf, boundaryNormalFace, localIdx, parallelVelocity); + } + else + { + // Neumann conditions are not well implemented + DUNE_THROW(Dune::InvalidStateException, "Something went wrong with the boundary conditions for the momentum equations at global position " << boundarySubFaceCenter); + } + } }; -} // end namespace +} // end namespace Dumux -#endif +#endif // DUMUX_NAVIERSTOKES_STAGGERED_FLUXVARIABLES_HH diff --git a/dumux/freeflow/navierstokes/staggered/localresidual.hh b/dumux/freeflow/navierstokes/staggered/localresidual.hh index 3ddde3953667bc5e8706645799d5d8afb4948095..fe2039b902a09824a89356f1b146f26d8ed180ea 100644 --- a/dumux/freeflow/navierstokes/staggered/localresidual.hh +++ b/dumux/freeflow/navierstokes/staggered/localresidual.hh @@ -179,7 +179,7 @@ public: const ElementFluxVariablesCache& elemFluxVarsCache) const { FluxVariables fluxVars; - return fluxVars.computeMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars); + return fluxVars.computeMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars, elemFluxVarsCache.gridFluxVarsCache()); } /*! diff --git a/dumux/freeflow/rans/twoeq/kepsilon/staggered/fluxvariables.hh b/dumux/freeflow/rans/twoeq/kepsilon/staggered/fluxvariables.hh index 77d63bdd6af87dd33bd639e8f0acb9a250af653c..d831d5917bd6b2f47a28b67994ed7a63ebcd3a73 100644 --- a/dumux/freeflow/rans/twoeq/kepsilon/staggered/fluxvariables.hh +++ b/dumux/freeflow/rans/twoeq/kepsilon/staggered/fluxvariables.hh @@ -184,12 +184,13 @@ public: const SubControlVolumeFace& scvf, const FVElementGeometry& fvGeometry, const ElementVolumeVariables& elemVolVars, - const ElementFaceVariables& elemFaceVars) + const ElementFaceVariables& elemFaceVars, + const GridFluxVariablesCache& gridFluxVarsCache) { const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; - return ParentType::computeFrontalMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars) - + ParentType::computeLateralMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars) + return ParentType::computeFrontalMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars, gridFluxVarsCache) + + ParentType::computeLateralMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars, gridFluxVarsCache) + 2.0 / ModelTraits::dim() * insideVolVars.density() * insideVolVars.turbulentKineticEnergy() * scvf.area() * scvf.directionSign() * insideVolVars.extrusionFactor(); } diff --git a/dumux/freeflow/rans/twoeq/komega/staggered/fluxvariables.hh b/dumux/freeflow/rans/twoeq/komega/staggered/fluxvariables.hh index bc76b71421488e78856afd28241521bf6190b271..22b659dd06e034be428cf9b0def870718e03d050 100644 --- a/dumux/freeflow/rans/twoeq/komega/staggered/fluxvariables.hh +++ b/dumux/freeflow/rans/twoeq/komega/staggered/fluxvariables.hh @@ -175,12 +175,13 @@ public: const SubControlVolumeFace& scvf, const FVElementGeometry& fvGeometry, const ElementVolumeVariables& elemVolVars, - const ElementFaceVariables& elemFaceVars) + const ElementFaceVariables& elemFaceVars, + const GridFluxVariablesCache& gridFluxVarsCache) { const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; - return ParentType::computeFrontalMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars) - + ParentType::computeLateralMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars) + return ParentType::computeFrontalMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars, gridFluxVarsCache) + + ParentType::computeLateralMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars, gridFluxVarsCache) + 2.0 / ModelTraits::dim() * insideVolVars.density() * insideVolVars.turbulentKineticEnergy() * scvf.area() * scvf.directionSign() * insideVolVars.extrusionFactor(); } diff --git a/dumux/freeflow/rans/twoeq/lowrekepsilon/staggered/fluxvariables.hh b/dumux/freeflow/rans/twoeq/lowrekepsilon/staggered/fluxvariables.hh index 0add605a222922346538bf123f386ef98ec7a11a..a89108b327113bf87d8f0733e6fe58416be3d29e 100644 --- a/dumux/freeflow/rans/twoeq/lowrekepsilon/staggered/fluxvariables.hh +++ b/dumux/freeflow/rans/twoeq/lowrekepsilon/staggered/fluxvariables.hh @@ -176,12 +176,13 @@ public: const SubControlVolumeFace& scvf, const FVElementGeometry& fvGeometry, const ElementVolumeVariables& elemVolVars, - const ElementFaceVariables& elemFaceVars) + const ElementFaceVariables& elemFaceVars, + const GridFluxVariablesCache& gridFluxVarsCache) { const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; - return ParentType::computeFrontalMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars) - + ParentType::computeLateralMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars) + return ParentType::computeFrontalMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars, gridFluxVarsCache) + + ParentType::computeLateralMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elemFaceVars, gridFluxVarsCache) + 2.0 / ModelTraits::dim() * insideVolVars.density() * insideVolVars.turbulentKineticEnergy() * scvf.area() * scvf.directionSign() * insideVolVars.extrusionFactor(); } diff --git a/dumux/multidomain/boundary/stokesdarcy/couplingmapper.hh b/dumux/multidomain/boundary/stokesdarcy/couplingmapper.hh index 14d269594418274e152c43c445d240caf37dfa01..92196c501a9aa3b1fe4969575909824319563675 100644 --- a/dumux/multidomain/boundary/stokesdarcy/couplingmapper.hh +++ b/dumux/multidomain/boundary/stokesdarcy/couplingmapper.hh @@ -136,7 +136,6 @@ public: const auto darcyDofIdx = darcyElementIdx[0]; - stokesFaceToDarcyStencils[scvf.dofIndex()].push_back(darcyDofIdx); stokesCellCenterToDarcyStencils[stokesElementIdx].push_back(darcyDofIdx); diff --git a/test/discretization/staggered/CMakeLists.txt b/test/discretization/staggered/CMakeLists.txt index 6543839c23c5af168763f2334ce80aa20998a2fe..880e2afe20b93f965a38f7ddc7f8100ae7d3f8f3 100644 --- a/test/discretization/staggered/CMakeLists.txt +++ b/test/discretization/staggered/CMakeLists.txt @@ -1,3 +1,5 @@ +dune_symlink_to_source_files(FILES "params.input") + dune_add_test(NAME test_staggeredfvgeometry SOURCES test_staggeredfvgeometry.cc LABELS unit discretization) diff --git a/test/discretization/staggered/params.input b/test/discretization/staggered/params.input new file mode 100644 index 0000000000000000000000000000000000000000..6ada25190eb33362adf4f10c877ae023d0361a1f --- /dev/null +++ b/test/discretization/staggered/params.input @@ -0,0 +1,3 @@ +[Discretization] +TvdApproach = Uniform # Uniform, Li, Hou +DifferencingScheme = vanalbada # vanleer, vanalbada, minmod, superbee, umist, mclimiter, wahyd diff --git a/test/discretization/staggered/test_staggered_free_flow_geometry.cc b/test/discretization/staggered/test_staggered_free_flow_geometry.cc index 4ee8dcad5a99e359d047e5033544542107bb0473..59c12bf843499cb381d89778a0fbda8a7dc3497a 100644 --- a/test/discretization/staggered/test_staggered_free_flow_geometry.cc +++ b/test/discretization/staggered/test_staggered_free_flow_geometry.cc @@ -5,7 +5,7 @@ * * * This program is free software: you can redistribute it and/or modify * * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 3 of the License, or * + * 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, * @@ -30,6 +30,7 @@ #include <dune/common/test/iteratortest.hh> #include <dune/grid/utility/structuredgridfactory.hh> #include <dune/grid/yaspgrid.hh> +#include <dumux/common/parameters.hh> #include <dumux/common/intersectionmapper.hh> #include <dumux/common/defaultmappertraits.hh> @@ -82,9 +83,11 @@ int main (int argc, char *argv[]) try // maybe initialize mpi Dune::MPIHelper::instance(argc, argv); - std::cout << "Checking the FVGeometries, SCVs and SCV faces" << std::endl; + // parse command line arguments and input file + Parameters::init(argc, argv); + using Grid = Dune::YaspGrid<2>; constexpr int dim = Grid::dimension; @@ -98,11 +101,11 @@ int main (int argc, char *argv[]) try // make a grid GlobalPosition lower(0.0); - GlobalPosition upper(1.0); - std::array<unsigned int, dim> els{{2, 4}}; + GlobalPosition upper(10.0); + std::array<unsigned int, dim> els{{5, 5}}; std::shared_ptr<Grid> grid = Dune::StructuredGridFactory<Grid>::createCubeGrid(lower, upper, els); - auto leafGridView = grid->leafGridView(); + auto leafGridView = grid->leafGridView(); FVGridGeometry fvGridGeometry(leafGridView); fvGridGeometry.update(); @@ -120,43 +123,82 @@ int main (int argc, char *argv[]) try for (const auto& element : elements(leafGridView)) { auto eIdx = fvGridGeometry.elementMapper().index(element); - std::cout << std::endl << "Checking fvGeometry of element " << eIdx << std::endl; - auto fvGeometry = localView(fvGridGeometry); - fvGeometry.bind(element); - - auto range = scvs(fvGeometry); - Detail::NoopFunctor<SubControlVolume> op; - if(0 != testForwardIterator(range.begin(), range.end(), op)) - DUNE_THROW(Dune::Exception, "Iterator does not fulfill the forward iterator concept"); - - for (auto&& scv : scvs(fvGeometry)) - { - std::cout << "-- scv " << scv.dofIndex() << " center at: " << scv.center() << std::endl; - } - - auto range2 = scvfs(fvGeometry); - Detail::NoopFunctor<SubControlVolumeFace> op2; - if(0 != testForwardIterator(range2.begin(), range2.end(), op2)) - DUNE_THROW(Dune::Exception, "Iterator does not fulfill the forward iterator concept"); - - - for (auto&& scvf : scvfs(fvGeometry)) + if(eIdx == 12 || eIdx == 0) { - std::cout << std::fixed << std::left << std::setprecision(2) - << "pos "<< scvf.ipGlobal() - << "; fIdx " << std::setw(3) << scvf.index() - << "; dofIdx (self/oppo.) " << std::setw(3) << scvf.dofIndex() << "/" << std::setw(3) <<scvf.dofIndexOpposingFace() - << "; dist (self/oppo.) " << std::setw(3) << scvf.selfToOppositeDistance() - << ", norm1 in/out " << std::setw(3) << scvf.pairData(0).normalPair.first << "/" << std::setw(3) << scvf.pairData(0).normalPair.second - << ", norm2 in/out " << std::setw(3) << scvf.pairData(1).normalPair.first << "/" << std::setw(3) << scvf.pairData(1).normalPair.second - << ", par1 " << std::setw(3) << std::setw(3) << scvf.pairData(0).outerParallelFaceDofIdx - << ", par2 " << std::setw(3) << std::setw(3) << scvf.pairData(1).outerParallelFaceDofIdx - << ", normDist1 " << std::setw(3) << scvf.pairData(0).normalDistance - << ", normDist2 " << std::setw(3) << scvf.pairData(1).normalDistance - << ", parDist1 " << std::setw(3) << scvf.pairData(0).parallelDistance - << ", parDist2 " << std::setw(3) << scvf.pairData(1).parallelDistance; - if (scvf.boundary()) std::cout << " (on boundary)"; - std::cout << std::endl; + std::cout << std::endl << "Checking fvGeometry of element " << eIdx << std::endl; + auto fvGeometry = localView(fvGridGeometry); + fvGeometry.bind(element); + + auto range = scvs(fvGeometry); + Detail::NoopFunctor<SubControlVolume> op; + if(0 != testForwardIterator(range.begin(), range.end(), op)) + DUNE_THROW(Dune::Exception, "Iterator does not fulfill the forward iterator concept"); + + for (auto&& scv : scvs(fvGeometry)) + { + std::cout << "-- scv " << scv.dofIndex() << " center at: " << scv.center() << std::endl; + } + + auto range2 = scvfs(fvGeometry); + Detail::NoopFunctor<SubControlVolumeFace> op2; + if(0 != testForwardIterator(range2.begin(), range2.end(), op2)) + DUNE_THROW(Dune::Exception, "Iterator does not fulfill the forward iterator concept"); + + + for (auto&& scvf : scvfs(fvGeometry)) + { + std::cout << "\n"; + std::cout << " Scvf Index " << scvf.index() << " , local Index " << scvf.localFaceIdx() << "\n"; + std::cout << " Center pos "<< scvf.ipGlobal() << "\n"; + + if (scvf.boundary()) + {std::cout << " (on boundary)" << "\n";} + else + {std::cout << "\n";} + + std::cout << std::fixed << std::left << std::setprecision(2); + + std::cout << " On Axis Dof Index: \n"; + if(fvGridGeometry.order() > 1) + {std::cout << " | Forward dofIdx : " << std::setw(3) << scvf.axisData().inAxisForwardDofs[0] << "\n";} + std::cout << " | Self dofIdx : " << std::setw(3) << scvf.dofIndex() << "\n"; + std::cout << " | Opposite dofIdx : " << std::setw(3) << scvf.dofIndexOpposingFace() << "\n"; + if(fvGridGeometry.order() > 1) + {std::cout << " | Backward dofIdx : " << std::setw(3) << scvf.axisData().inAxisBackwardDofs[0] << "\n";} + + std::cout << " Normal Dof Index: \n"; + for(int i = 0; i < scvf.pairData().size(); i++) + { + std::cout << " | normal inner dofIdx "<< i <<": " << std::setw(3) << scvf.pairData(i).normalPair.first << "\n"; + std::cout << " | normal outer dofIdx "<< i <<": " << std::setw(3) << scvf.pairData(i).normalPair.second << "\n"; + } + + std::cout << " Parallel Dof Index: \n"; + for(int i = 0; i < scvf.pairData().size(); i++) + { + for(int j = 0; j < fvGridGeometry.order(); j++) + { + std::cout << " | Parallel Dof "<< j << " on axis " << i << ": "<< std::setw(3) << scvf.pairData(i).parallelDofs[j] << "\n"; + } + } + + std::cout << " Distances: \n"; + if(fvGridGeometry.order() > 1) + {std::cout << " | Opposite To Backwards Face Dist : " << std::setw(3) << scvf.axisData().inAxisBackwardDistances[0] << "\n";} + std::cout << " | self To Opposite Dist : " << std::setw(3) << scvf.selfToOppositeDistance() << "\n"; + if(fvGridGeometry.order() > 1) + {std::cout << " | Opposite To Backwards Face Dist : " << std::setw(3) << scvf.axisData().inAxisBackwardDistances[0] << "\n";} + + for(int i = 0; i < scvf.pairData().size(); i++) + { + for(int j = 0; j < fvGridGeometry.order(); j++) + { + std::cout << " | Parallel Distance "<< j << " on axis " << i << ": "<< std::setw(3) << scvf.pairData(i).parallelDistances[j] << "\n"; + } + } + std::cout << std::endl; + std::cout << std::endl; + } } } } diff --git a/test/discretization/staggered/test_staggeredfvgeometry.cc b/test/discretization/staggered/test_staggeredfvgeometry.cc index 08340c65448763f815aaab95d51f49cd2a5d08e9..3296aca99c8253429632cb41f0454d8db37e3b45 100644 --- a/test/discretization/staggered/test_staggeredfvgeometry.cc +++ b/test/discretization/staggered/test_staggeredfvgeometry.cc @@ -30,6 +30,7 @@ #include <dune/common/test/iteratortest.hh> #include <dune/grid/utility/structuredgridfactory.hh> #include <dune/grid/yaspgrid.hh> +#include <dumux/common/parameters.hh> #include <dumux/common/intersectionmapper.hh> #include <dumux/common/defaultmappertraits.hh> @@ -67,7 +68,10 @@ struct TestFVGGTraits : public DefaultMapperTraits<GridView> //! Dummy connectivity map, required by FVGridGeometry template<class FVGridGeometry> struct MockConnectivityMap - { void update(const FVGridGeometry& fvGridGeometry) {} }; + { + void update(const FVGridGeometry& fvGridGeometry) {} + void setStencilOrder(const int order) {} + }; template<class FVGridGeometry> using ConnectivityMap = MockConnectivityMap<FVGridGeometry>; @@ -86,6 +90,9 @@ int main (int argc, char *argv[]) try // maybe initialize mpi Dune::MPIHelper::instance(argc, argv); + // parse command line arguments and input file + Parameters::init(argc, argv); + std::cout << "Checking the FVGeometries, SCVs and SCV faces" << std::endl; using Grid = Dune::YaspGrid<2>; diff --git a/test/freeflow/navierstokes/angeli/CMakeLists.txt b/test/freeflow/navierstokes/angeli/CMakeLists.txt index 0d009f0ba10e12551c80f46567a0b2fcba488fa9..9d44798759f9814e1d99f44816bef86155478ba4 100644 --- a/test/freeflow/navierstokes/angeli/CMakeLists.txt +++ b/test/freeflow/navierstokes/angeli/CMakeLists.txt @@ -5,7 +5,7 @@ dune_add_test(NAME test_ff_navierstokes_angeli COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py CMD_ARGS --script fuzzy --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_navierstokes_angeli-reference.vtu - ${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_angeli-00045.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_angeli-00009.vtu --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_angeli params.input -Problem.Name test_ff_navierstokes_angeli") diff --git a/test/freeflow/navierstokes/angeli/params.input b/test/freeflow/navierstokes/angeli/params.input index a7f02d55826ca0fdab5e5d05758729a33217ef2a..de1b84e33d76c7fd565fdd67a94999cbbe44c9ce 100644 --- a/test/freeflow/navierstokes/angeli/params.input +++ b/test/freeflow/navierstokes/angeli/params.input @@ -1,5 +1,5 @@ [TimeLoop] -DtInitial = 1e-12 # [s] +DtInitial = 1e-4 # [s] TEnd = 1e-2 # [s] [Grid] diff --git a/test/freeflow/navierstokes/kovasznay/CMakeLists.txt b/test/freeflow/navierstokes/kovasznay/CMakeLists.txt index 01b5e3b1ad4abf4a6cb9bf1c5f850748372b7f23..018401d1af9346afc8a7bd5ea433b942f511cb87 100644 --- a/test/freeflow/navierstokes/kovasznay/CMakeLists.txt +++ b/test/freeflow/navierstokes/kovasznay/CMakeLists.txt @@ -8,4 +8,16 @@ dune_add_test(NAME test_ff_navierstokes_kovasznay ${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_kovasznay-00001.vtu --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_kovasznay params.input -Problem.Name test_ff_navierstokes_kovasznay") + +dune_add_test(NAME test_ff_navierstokes_kovasznay_higherorder + TARGET test_ff_navierstokes_kovasznay + LABELS freeflow + COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py + CMD_ARGS --script fuzzy + --files ${CMAKE_SOURCE_DIR}/test/references/test_ff_navierstokes_kovasznay_higherorder-reference.vtu + ${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_kovasznay_higherorder-00001.vtu + --command "${CMAKE_CURRENT_BINARY_DIR}/test_ff_navierstokes_kovasznay params.input + -Problem.Name test_ff_navierstokes_kovasznay_higherorder + -Discretization.TvdApproach Hou + -Discretization.DifferencingScheme vanleer") dune_symlink_to_source_files(FILES "params.input") diff --git a/test/references/test_ff_navierstokes_angeli-reference.vtu b/test/references/test_ff_navierstokes_angeli-reference.vtu index a9b1ce9858e20fc5cd1fdf20672c538ba0274aa4..8cb65572763a4b8adcb2f538e15f300a524d9ce8 100644 --- a/test/references/test_ff_navierstokes_angeli-reference.vtu +++ b/test/references/test_ff_navierstokes_angeli-reference.vtu @@ -8,207 +8,207 @@ -2.21788 -1.09715 0.00591258 1.0739 2.08998 3.03812 3.90337 4.67208 5.33213 5.87312 6.2865 6.56577 6.70651 6.70651 6.56577 6.2865 5.87312 5.33213 4.67208 3.90337 3.03812 2.08998 1.0739 0.00591258 -1.09715 -2.21788 -3.33862 -4.44168 -5.50967 -6.52574 -7.47388 -8.33913 -9.10784 -9.7679 -10.3089 -10.7223 - -11.0015 -11.1423 -11.0029 -10.8489 -10.5615 -10.1367 -9.58292 -8.90982 -8.1287 -7.25229 -6.29474 -5.27136 - -4.19846 -3.09308 -1.97276 -0.855247 0.241793 1.30103 2.30578 3.24024 4.08982 4.84133 5.48329 6.00617 - 6.40257 6.66753 6.7986 6.7986 6.66753 6.40257 6.00617 5.48329 4.84133 4.08982 3.24024 2.30578 - 1.30103 0.241793 -0.855247 -1.97276 -3.09308 -4.19846 -5.27136 -6.29474 -7.25229 -8.1287 -8.90982 -9.58292 - -10.1367 -10.5615 -10.8489 -11.0029 -10.733 -10.6092 -10.3179 -9.89058 -9.33498 -8.66066 -7.87874 -7.00191 - -6.04427 -5.0211 -3.9487 -2.84407 -1.72474 -0.608391 0.487317 1.5451 2.54829 3.48112 4.32902 5.07881 - 5.719 6.24002 6.6344 6.89699 7.02504 7.02504 6.89699 6.6344 6.24002 5.719 5.07881 4.32902 - 3.48112 2.54829 1.5451 0.487317 -0.608391 -1.72474 -2.84407 -3.9487 -5.0211 -6.04427 -7.00191 -7.87874 - -8.66066 -9.33498 -9.89058 -10.3179 -10.6092 -10.733 -10.3494 -10.2581 -9.96352 -9.53382 -8.9766 -8.30113 - -7.51841 -6.64107 -5.68315 -4.65992 -3.58765 -2.48333 -1.36446 -0.248732 0.846222 1.90312 2.90529 3.83698 - 4.68357 5.43186 6.07029 6.5892 6.98095 7.24017 7.36382 7.36382 7.24017 6.98095 6.5892 6.07029 - 5.43186 4.68357 3.83698 2.90529 1.90312 0.846222 -0.248732 -1.36446 -2.48333 -3.58765 -4.65992 -5.68315 - -6.64107 -7.51841 -8.30113 -8.9766 -9.53382 -9.96352 -10.2581 -10.3494 -9.87623 -9.81637 -9.51923 -9.08766 - -8.52905 -7.85253 -7.06901 -6.19105 -5.23266 -4.20909 -3.13658 -2.03213 -0.91324 0.202404 1.29716 2.35373 - 3.35543 4.28646 5.13214 5.87921 6.51601 7.03269 7.42144 7.67661 7.79482 7.79482 7.67661 7.42144 - 7.03269 6.51601 5.87921 5.13214 4.28646 3.35543 2.35373 1.29716 0.202404 -0.91324 -2.03213 -3.13658 - -4.20909 -5.23266 -6.19105 -7.06901 -7.85253 -8.52905 -9.08766 -9.51923 -9.81637 -9.87623 -9.34329 -9.31142 - -9.01239 -8.57938 -8.01961 -7.34212 -6.55775 -5.67902 -4.71992 -3.69569 -2.62256 -1.51755 -0.398136 0.717955 - 1.81307 2.86988 3.87165 4.80252 5.64776 6.39397 7.02936 7.54391 7.92953 8.18026 8.29235 8.29235 - 8.18026 7.92953 7.54391 7.02936 6.39397 5.64776 4.80252 3.87165 2.86988 1.81307 0.717955 -0.398136 - -1.51755 -2.62256 -3.69569 -4.71992 -5.67902 -6.55775 -7.34212 -8.01961 -8.57938 -9.01239 -9.31142 -9.34329 - -8.78403 -8.77516 -8.47479 -8.04068 -7.4799 -6.80144 -6.01612 -5.13642 -4.17634 -3.15109 -2.07693 -0.97088 - 0.149555 1.26664 2.36267 3.42028 4.42269 5.35396 6.19925 6.94506 7.5794 8.09205 8.47466 8.72088 - 8.82656 8.82656 8.72088 8.47466 8.09205 7.5794 6.94506 6.19925 5.35396 4.42269 3.42028 2.36267 - 1.26664 0.149555 -0.97088 -2.07693 -3.15109 -4.17634 -5.13642 -6.01612 -6.80144 -7.4799 -8.04068 -8.47479 - -8.77516 -8.78403 -8.23358 -8.24186 -7.94056 -7.50555 -6.94383 -6.26435 -5.4779 -4.59699 -3.63559 -2.60895 - -1.53333 -0.42576 0.696218 1.81483 2.91235 3.97134 4.97496 5.90719 6.75308 7.49899 8.13276 8.64393 - 9.02385 9.26581 9.36521 9.36521 9.26581 9.02385 8.64393 8.13276 7.49899 6.75308 5.90719 4.97496 - 3.97134 2.91235 1.81483 0.696218 -0.42576 -1.53333 -2.60895 -3.63559 -4.59699 -5.4779 -6.26435 -6.94383 - -7.50555 -7.94056 -8.24186 -8.23358 -7.72655 -7.74587 -7.44393 -7.00815 -6.44546 -5.76482 -4.97704 -4.09462 - -3.13156 -2.10312 -1.02558 0.0839889 1.20802 2.3287 3.42824 4.48917 5.49457 6.42832 7.27538 8.02195 - 8.6557 9.16594 9.54371 9.78194 9.87558 9.87558 9.78194 9.54371 9.16594 8.6557 8.02195 7.27538 - 6.42832 5.49457 4.48917 3.42824 2.3287 1.20802 0.0839889 -1.02558 -2.10312 -3.13156 -4.09462 -4.97704 - -5.76482 -6.44546 -7.00815 -7.44393 -7.74587 -7.72655 -7.29478 -7.31951 -7.01712 -6.58058 -6.01683 -5.33484 - -4.54546 -3.66121 -2.69611 -1.66546 -0.585566 0.526471 1.65304 2.77629 3.87838 4.94177 5.94947 6.88528 - 7.73405 8.48186 9.11619 9.62614 10.0025 10.2378 10.3266 10.3266 10.2378 10.0025 9.62614 9.11619 - 8.48186 7.73405 6.88528 5.94947 4.94177 3.87838 2.77629 1.65304 0.526471 -0.585566 -1.66546 -2.69611 - -3.66121 -4.54546 -5.33484 -6.01683 -6.58058 -7.01712 -7.31951 -7.29478 -6.9654 -6.9911 -6.68834 -6.25096 - -5.68597 -5.00238 -4.2111 -3.32467 -2.35716 -1.32389 -0.241217 0.873731 2.0033 3.12957 4.23467 5.30099 - 6.31147 7.24984 8.10084 8.85043 9.48596 9.99632 10.372 10.6054 10.6907 10.6907 10.6054 10.372 - 9.99632 9.48596 8.85043 8.10084 7.24984 6.31147 5.30099 4.23467 3.12957 2.0033 0.873731 -0.241217 - -1.32389 -2.35716 -3.32467 -4.2111 -5.00238 -5.68597 -6.25096 -6.68834 -6.9911 -6.9654 -6.75912 -6.78327 - -6.48004 -6.04162 -5.47512 -4.78965 -3.99613 -3.10718 -2.13688 -1.1006 -0.0147389 1.10353 2.23649 3.36621 - 4.47473 5.54439 6.55807 7.49943 8.35312 9.10502 9.74235 10.2539 10.6299 10.8626 10.9458 10.9458 - 10.8626 10.6299 10.2539 9.74235 9.10502 8.35312 7.49943 6.55807 5.54439 4.47473 3.36621 2.23649 - 1.10353 -0.0147389 -1.1006 -2.13688 -3.10718 -3.99613 -4.78965 -5.47512 -6.04162 -6.48004 -6.78327 -6.75912 - -6.68888 -6.71154 -6.40749 -5.96771 -5.3994 -4.71171 -3.9156 -3.02374 -2.05027 -1.0106 0.0788367 1.2008 - 2.33755 3.47108 4.58339 5.65676 6.67402 7.61875 8.47557 9.23025 9.86998 10.3834 10.7608 10.9941 - 11.0771 11.0771 10.9941 10.7608 10.3834 9.86998 9.23025 8.47557 7.61875 6.67402 5.65676 4.58339 - 3.47108 2.33755 1.2008 0.0788367 -1.0106 -2.05027 -3.02374 -3.9156 -4.71171 -5.3994 -5.96771 -6.40749 - -6.71154 -6.68888 -6.75912 -6.78366 -6.48043 -6.04206 -5.4757 -4.79046 -3.99728 -3.10878 -2.13903 -1.1034 - -0.0182447 1.09927 2.23148 3.36045 4.46828 5.53732 6.55046 7.49138 8.34473 9.09638 9.73355 10.245 - 10.621 10.8537 10.9369 10.9369 10.8537 10.621 10.245 9.73355 9.09638 8.34473 7.49138 6.55046 - 5.53732 4.46828 3.36045 2.23148 1.09927 -0.0182447 -1.1034 -2.13903 -3.10878 -3.99728 -4.79046 -5.4757 - -6.04206 -6.48043 -6.78366 -6.75912 -6.9654 -6.99186 -6.6891 -6.25182 -5.6871 -5.00398 -4.2134 -3.32791 - -2.36156 -1.32964 -0.248441 0.864943 1.99292 3.11765 4.2213 5.28632 6.29568 7.23313 8.08342 8.8325 - 9.4677 9.97787 10.3535 10.5869 10.6721 10.6721 10.5869 10.3535 9.97787 9.4677 8.8325 8.08342 - 7.23313 6.29568 5.28632 4.2213 3.11765 1.99292 0.864943 -0.248441 -1.32964 -2.36156 -3.32791 -4.2134 - -5.00398 -5.6871 -6.25182 -6.6891 -6.99186 -6.9654 -7.29478 -7.32063 -7.01819 -6.58176 -6.01838 -5.33709 - -4.54877 -3.66597 -2.70266 -1.67408 -0.596482 0.513137 1.63726 2.75812 3.85798 4.91937 5.92535 6.85976 - 7.70746 8.45451 9.08837 9.59805 9.97427 10.2095 10.2984 10.2984 10.2095 9.97427 9.59805 9.08837 - 8.45451 7.70746 6.85976 5.92535 4.91937 3.85798 2.75812 1.63726 0.513137 -0.596482 -1.67408 -2.70266 - -3.66597 -4.54877 -5.33709 -6.01838 -6.58176 -7.01819 -7.32063 -7.29478 -7.72655 -7.74732 -7.44518 -7.00944 - -6.44718 -5.76745 -4.98111 -4.10067 -3.14008 -2.11451 -1.04014 0.0660899 1.18675 2.30415 3.40064 4.45883 - 5.46189 6.39376 7.2394 7.985 8.61817 9.12812 9.5058 9.74404 9.83771 9.83771 9.74404 9.5058 - 9.12812 8.61817 7.985 7.2394 6.39376 5.46189 4.45883 3.40064 2.30415 1.18675 0.0660899 -1.04014 - -2.11451 -3.14008 -4.10067 -4.98111 -5.76745 -6.44718 -7.00944 -7.44518 -7.74732 -7.72655 -8.23358 -8.24357 - -7.9418 -7.50667 -6.94536 -6.26696 -5.48235 -4.604 -3.64583 -2.62294 -1.55146 -0.44824 0.669352 1.78372 - 2.8773 3.93278 4.93344 5.8633 6.70745 7.45221 8.08534 8.59625 8.97616 9.21823 9.31771 9.31771 - 9.21823 8.97616 8.59625 8.08534 7.45221 6.70745 5.8633 4.93344 3.93278 2.8773 1.78372 0.669352 - -0.44824 -1.55146 -2.62294 -3.64583 -4.604 -5.48235 -6.26696 -6.94536 -7.50667 -7.9418 -8.24357 -8.23358 - -8.78403 -8.77704 -8.47573 -8.04113 -7.48065 -6.80344 -6.02038 -5.14392 -4.18791 -3.16743 -2.09851 -0.997944 - 0.116985 1.22876 2.31989 3.37318 4.37197 5.3004 6.14365 6.88818 7.5219 8.03442 8.41719 8.66369 - 8.76956 8.76956 8.66369 8.41719 8.03442 7.5219 6.88818 6.14365 5.3004 4.37197 3.37318 2.31989 - 1.22876 0.116985 -0.997944 -2.09851 -3.16743 -4.18791 -5.14392 -6.02038 -6.80344 -7.48065 -8.04113 -8.47573 - -8.77704 -8.78403 -9.34329 -9.3133 -9.01248 -8.5784 -8.0187 -7.34261 -6.56101 -5.6863 -4.7323 -3.714 - -2.64738 -1.54914 -0.436503 0.673102 1.76226 2.81386 3.81133 4.7389 5.58185 6.32675 6.96165 7.47632 - 7.86241 8.11369 8.22614 8.22614 8.11369 7.86241 7.47632 6.96165 6.32675 5.58185 4.7389 3.81133 - 2.81386 1.76226 0.673102 -0.436503 -1.54914 -2.64738 -3.714 -4.7323 -5.6863 -6.56101 -7.34261 -8.0187 - -8.5784 -9.01248 -9.3133 -9.34329 -9.87623 -9.81783 -9.51749 -9.08396 -8.52509 -7.85018 -7.07006 -6.1971 - -5.24503 -4.22879 -3.16426 -2.06809 -0.95741 0.150414 1.23805 2.28845 3.28513 4.2124 5.05562 5.80145 - 6.43804 6.95529 7.345 7.60115 7.72 7.72 7.60115 7.345 6.95529 6.43804 5.80145 5.05562 - 4.2124 3.28513 2.28845 1.23805 0.150414 -0.95741 -2.06809 -3.16426 -4.22879 -5.24503 -6.1971 -7.07006 - -7.85018 -8.52509 -9.08396 -9.51749 -9.81783 -9.87623 -10.3494 -10.2581 -9.95817 -9.52531 -8.96747 -8.29393 - -7.51548 -6.64439 -5.69431 -4.68009 -3.61755 -2.52325 -1.41427 -0.307888 0.778622 1.82829 2.82467 3.75217 - 4.59619 5.34345 5.98218 6.50234 6.89582 7.15669 7.28141 7.28141 7.15669 6.89582 6.50234 5.98218 - 5.34345 4.59619 3.75217 2.82467 1.82829 0.778622 -0.307888 -1.41427 -2.52325 -3.61755 -4.68009 -5.69431 - -6.64439 -7.51548 -8.29393 -8.96747 -9.52531 -9.95817 -10.2581 -10.3494 -10.733 -10.6052 -10.3058 -9.87391 - -9.31751 -8.64576 -7.86932 -7.00037 -6.05246 -5.04036 -3.9798 -2.88728 -1.7798 -0.67459 0.411144 1.46048 - 2.45704 3.38524 4.23055 4.97971 5.62097 6.14429 6.54157 6.80686 6.93665 6.93665 6.80686 6.54157 - 6.14429 5.62097 4.97971 4.23055 3.38524 2.45704 1.46048 0.411144 -0.67459 -1.7798 -2.88728 -3.9798 - -5.04036 -6.05246 -7.00037 -7.86932 -8.64576 -9.31751 -9.87391 -10.3058 -10.6052 -10.733 -11.0029 -10.8357 - -10.5372 -10.107 -9.55276 -8.88343 -8.10954 -7.24317 -6.29774 -5.28795 -4.22947 -3.13871 -2.03262 -0.928374 - 0.156875 1.20624 2.20339 3.13275 3.97982 4.73132 5.37548 5.90221 6.3033 6.57266 6.70659 6.70659 - 6.57266 6.3033 5.90221 5.37548 4.73132 3.97982 3.13275 2.20339 1.20624 0.156875 -0.928374 -2.03262 - -3.13871 -4.22947 -5.28795 -6.29774 -7.24317 -8.10954 -8.88343 -9.55276 -10.107 -10.5372 -10.8357 -11.0029 - -11.1423 -10.9327 -10.6367 -10.2093 -9.65817 -8.99207 -8.22143 -7.35819 -6.41569 -5.40852 -4.35229 -3.26336 - -2.15862 -1.05518 0.0298349 1.07956 2.07769 3.00866 3.85794 4.61224 5.25971 5.79016 6.19519 6.46842 - 6.60568 6.60568 6.46842 6.19519 5.79016 5.25971 4.61224 3.85794 3.00866 2.07769 1.07956 0.0298349 - -1.05518 -2.15862 -3.26336 -4.35229 -5.40852 -6.41569 -7.35819 -8.22143 -8.99207 -9.65817 -10.2093 -10.6367 - -10.9327 -11.1423 -11.1423 -10.8882 -10.5965 -10.1731 -9.62592 -8.9638 -8.19701 -7.33739 -6.39819 -5.39393 - -4.34013 -3.25311 -2.1497 -1.04698 0.037945 1.08825 2.08763 3.02051 3.87233 4.62976 5.28085 5.81527 - 6.2244 6.50148 6.64166 6.64166 6.50148 6.2244 5.81527 5.28085 4.62976 3.87233 3.02051 2.08763 - 1.08825 0.037945 -1.04698 -2.1497 -3.25311 -4.34013 -5.39393 -6.39819 -7.33739 -8.19701 -8.9638 -9.62592 - -10.1731 -10.5965 -10.8882 -11.1423 -11.0029 -10.7048 -10.4176 -9.99871 -9.45598 -8.7982 -8.03555 -7.17975 - -6.24401 -5.24274 -4.19144 -3.10635 -2.00427 -0.902254 0.182636 1.23358 2.23426 3.16911 4.02353 4.78413 - 5.43888 5.9773 6.39059 6.67169 6.81526 6.81526 6.67169 6.39059 5.9773 5.43888 4.78413 4.02353 - 3.16911 2.23426 1.23358 0.182636 -0.902254 -2.00427 -3.10635 -4.19144 -5.24274 -6.24401 -7.17975 -8.03555 - -8.7982 -9.45598 -9.99871 -10.4176 -10.7048 -11.0029 -10.733 -10.3947 -10.1112 -9.69664 -9.15841 -8.50503 - -7.74656 -6.89462 -5.96232 -4.96404 -3.91521 -2.83203 -1.73126 -0.629918 0.454939 1.50651 2.50847 3.44525 - 4.30222 5.06593 5.7243 6.26675 6.68435 6.96985 7.11773 7.11773 6.96985 6.68435 6.26675 5.7243 - 5.06593 4.30222 3.44525 2.50847 1.50651 0.454939 -0.629918 -1.73126 -2.83203 -3.91521 -4.96404 -5.96232 - -6.89462 -7.74656 -8.50503 -9.15841 -9.69664 -10.1112 -10.3947 -10.733 -10.3494 -9.97663 -9.69659 -9.28623 - -8.75241 -8.10339 -7.34904 -6.50091 -5.572 -4.57666 -3.53024 -2.44893 -1.34943 -0.248749 0.836089 1.88829 - 2.89153 3.83023 4.68973 5.45658 6.11863 6.66526 7.08748 7.378 7.53126 7.53126 7.378 7.08748 - 6.66526 6.11863 5.45658 4.68973 3.83023 2.89153 1.88829 0.836089 -0.248749 -1.34943 -2.44893 -3.53024 - -4.57666 -5.572 -6.50091 -7.34904 -8.10339 -8.75241 -9.28623 -9.69659 -9.97663 -10.3494 -9.87623 -9.47606 - -9.19962 -8.79337 -8.2638 -7.61896 -6.86859 -6.02412 -5.0985 -4.106 -3.06193 -1.98242 -0.884161 0.215886 - 1.30071 2.35353 3.35804 4.29864 5.16069 5.9307 6.59652 7.14752 7.57472 7.87086 8.03049 8.03049 - 7.87086 7.57472 7.14752 6.59652 5.9307 5.16069 4.29864 3.35804 2.35353 1.30071 0.215886 -0.884161 - -1.98242 -3.06193 -4.106 -5.0985 -6.02412 -6.86859 -7.61896 -8.2638 -8.79337 -9.19962 -9.47606 -9.87623 - -9.34329 -8.92375 -8.65108 -8.2488 -7.72325 -7.08234 -6.33572 -5.49473 -4.57224 -3.58246 -2.54066 -1.46291 - -0.365853 0.73356 1.81835 2.87175 3.87748 4.81993 5.68447 6.45763 7.12726 7.68277 8.11521 8.41743 - 8.58413 8.58413 8.41743 8.11521 7.68277 7.12726 6.45763 5.68447 4.81993 3.87748 2.87175 1.81835 - 0.73356 -0.365853 -1.46291 -2.54066 -3.58246 -4.57224 -5.49473 -6.33572 -7.08234 -7.72325 -8.2488 -8.65108 - -8.92375 -9.34329 -8.78403 -8.35367 -8.08473 -7.68621 -7.16438 -6.52711 -5.78396 -4.94622 -4.0267 -3.03953 - -1.99992 -0.923907 0.171915 1.27064 2.3553 3.40918 4.41598 5.36014 6.22704 7.00322 7.67657 8.23656 - 8.67431 8.98279 9.15691 9.15691 8.98279 8.67431 8.23656 7.67657 7.00322 6.22704 5.36014 4.41598 - 3.40918 2.3553 1.27064 0.171915 -0.923907 -1.99992 -3.03953 -4.0267 -4.94622 -5.78396 -6.52711 -7.16438 - -7.68621 -8.08473 -8.35367 -8.78403 -8.23358 -7.80066 -7.53519 -7.14011 -6.62166 -5.98769 -5.24775 -4.41305 - -3.49635 -2.51171 -1.47428 -0.400047 0.694445 1.79233 2.87668 3.9308 4.93842 5.884 6.75296 7.53186 - 8.20866 8.77286 9.2157 9.53029 9.71175 9.71175 9.53029 9.2157 8.77286 8.20866 7.53186 6.75296 - 5.884 4.93842 3.9308 2.87668 1.79233 0.694445 -0.400047 -1.47428 -2.51171 -3.49635 -4.41305 -5.24775 - -5.98769 -6.62166 -7.14011 -7.53519 -7.80066 -8.23358 -7.72655 -7.29818 -7.0357 -6.64363 -6.1282 -5.49723 - -4.76025 -3.92844 -3.01447 -2.03237 -0.997197 0.0751133 1.16806 2.26483 3.34854 4.40251 5.41052 6.35706 - 7.22758 8.00868 8.68839 9.25627 9.70366 10.0238 10.2121 10.2121 10.0238 9.70366 9.25627 8.68839 - 8.00868 7.22758 6.35706 5.41052 4.40251 3.34854 2.26483 1.16806 0.0751133 -0.997197 -2.03237 -3.01447 - -3.92844 -4.76025 -5.49723 -6.1282 -6.64363 -7.0357 -7.29818 -7.72655 -7.29478 -6.87611 -6.616 -6.22649 - -5.71373 -5.08551 -4.35134 -3.52234 -2.61113 -1.63167 -0.59895 0.471153 1.5622 2.65742 3.73997 4.79322 - 5.80099 6.74781 7.61915 8.40169 9.08348 9.65418 10.1052 10.43 10.624 10.624 10.43 10.1052 - 9.65418 9.08348 8.40169 7.61915 6.74781 5.80099 4.79322 3.73997 2.65742 1.5622 0.471153 -0.59895 - -1.63167 -2.61113 -3.52234 -4.35134 -5.08551 -5.71373 -6.22649 -6.616 -6.87611 -7.29478 -6.9654 -6.55884 - -6.30047 -5.91309 -5.40274 -4.77713 -4.04571 -3.21957 -2.31128 -1.33469 -0.304774 0.762685 1.8513 2.94435 - 4.02505 5.0768 6.08348 7.02965 7.90085 8.68377 9.36655 9.9389 10.3924 10.7204 10.9188 10.9188 - 10.7204 10.3924 9.9389 9.36655 8.68377 7.90085 7.02965 6.08348 5.0768 4.02505 2.94435 1.8513 - 0.762685 -0.304774 -1.33469 -2.31128 -3.21957 -4.04571 -4.77713 -5.40274 -5.91309 -6.30047 -6.55884 -6.9654 - -6.75912 -6.36374 -6.10664 -5.72112 -5.21302 -4.58998 -3.8614 -3.03831 -2.1332 -1.15989 -0.13326 0.930957 - 2.01644 3.10652 4.18447 5.23375 6.23828 7.18267 8.0525 8.83452 9.51692 10.0895 10.5438 10.8735 - 11.0744 11.0744 10.8735 10.5438 10.0895 9.51692 8.83452 8.0525 7.18267 6.23828 5.23375 4.18447 - 3.10652 2.01644 0.930957 -0.13326 -1.15989 -2.1332 -3.03831 -3.8614 -4.58998 -5.21302 -5.72112 -6.10664 - -6.36374 -6.75912 -6.68888 -6.30012 -6.04417 -5.6604 -5.15451 -4.5341 -3.80852 -2.98872 -2.08717 -1.11761 - -0.0948645 0.965401 2.04693 3.13311 4.20728 5.25296 6.25412 7.19542 8.0625 8.84216 9.52263 10.0937 - 10.5471 10.8765 11.0779 11.0779 10.8765 10.5471 10.0937 9.52263 8.84216 8.0625 7.19542 6.25412 - 5.25296 4.20728 3.13311 2.04693 0.965401 -0.0948645 -1.11761 -2.08717 -2.98872 -3.80852 -4.5341 -5.15451 - -5.6604 -6.04417 -6.30012 -6.68888 -6.75912 -6.36819 -6.11152 -5.72646 -5.21883 -4.59627 -3.86815 -3.04548 - -2.14075 -1.16775 -0.141367 0.922676 2.00805 3.0981 4.17609 5.22545 6.23011 7.17466 8.04466 8.82686 - 9.50943 10.0821 10.5366 10.8664 11.0673 11.0673 10.8664 10.5366 10.0821 9.50943 8.82686 8.04466 - 7.17466 6.23011 5.22545 4.17609 3.0981 2.00805 0.922676 -0.141367 -1.16775 -2.14075 -3.04548 -3.86815 - -4.59627 -5.21883 -5.72646 -6.11152 -6.36819 -6.75912 -6.9654 -6.56769 -6.31021 -5.92379 -5.41441 -4.7898 - -4.05936 -3.23413 -2.32664 -1.35074 -0.321356 0.745716 1.8341 2.92706 4.00781 5.05973 6.06667 7.01317 - 7.88472 8.66803 9.35116 9.92384 10.3776 10.7058 10.9043 10.9043 10.7058 10.3776 9.92384 9.35116 - 8.66803 7.88472 7.01317 6.06667 5.05973 4.00781 2.92706 1.8341 0.745716 -0.321356 -1.35074 -2.32664 - -3.23413 -4.05936 -4.7898 -5.41441 -5.92379 -6.31021 -6.56769 -6.9654 -7.29478 -6.8892 -6.63045 -6.24241 - -5.73119 -5.10455 -4.37191 -3.54434 -2.63442 -1.65604 -0.62418 0.445307 1.53598 2.63107 3.7137 4.76722 - 5.77541 6.72276 7.5947 8.37786 9.06024 9.63147 10.0829 10.408 10.6022 10.6022 10.408 10.0829 - 9.63147 9.06024 8.37786 7.5947 6.72276 5.77541 4.76722 3.7137 2.63107 1.53598 0.445307 -0.62418 - -1.65604 -2.63442 -3.54434 -4.37191 -5.10455 -5.73119 -6.24241 -6.63045 -6.8892 -7.29478 -7.72655 -7.31525 - -7.05462 -6.66459 -6.15132 -5.52258 -4.78778 -3.958 -3.04587 -2.0653 -1.03135 0.0400914 1.13252 2.22912 - 3.31296 4.36733 5.37598 6.32331 7.19472 7.97676 8.65735 9.22603 9.67407 9.99466 10.1831 10.1831 - 9.99466 9.67407 9.22603 8.65735 7.97676 7.19472 6.32331 5.37598 4.36733 3.31296 2.22912 1.13252 - 0.0400914 -1.03135 -2.0653 -3.04587 -3.958 -4.78778 -5.52258 -6.15132 -6.66459 -7.05462 -7.31525 -7.72655 - -8.23358 -7.82132 -7.5582 -7.16579 -6.65024 -6.01926 -5.28226 -4.45033 -3.5361 -2.55354 -1.51775 -0.44467 - 0.649146 1.74682 2.83139 3.8861 4.89462 5.84135 6.71159 7.49183 8.16992 8.73528 9.17907 9.49431 - 9.67608 9.67608 9.49431 9.17907 8.73528 8.16992 7.49183 6.71159 5.84135 4.89462 3.8861 2.83139 - 1.74682 0.649146 -0.44467 -1.51775 -2.55354 -3.5361 -4.45033 -5.28226 -6.01926 -6.65024 -7.16579 -7.5582 - -7.82132 -8.23358 -8.78403 -8.37735 -8.1113 -7.71619 -7.19813 -6.56478 -5.82552 -4.99142 -4.07514 -3.0907 - -2.05322 -0.978699 0.116266 1.21475 2.29976 3.35447 4.36254 5.30829 6.17699 6.95505 7.63024 8.19188 - 8.63099 8.94042 9.11501 9.11501 8.94042 8.63099 8.19188 7.63024 6.95505 6.17699 5.30829 4.36254 - 3.35447 2.29976 1.21475 0.116266 -0.978699 -2.05322 -3.0907 -4.07514 -4.99142 -5.82552 -6.56478 -7.19813 - -7.71619 -8.1113 -8.37735 -8.78403 -9.34329 -8.94966 -8.68046 -8.28245 -7.76175 -7.12594 -6.38436 -5.5481 - -4.62981 -3.64354 -2.60446 -1.52861 -0.432615 0.666546 1.75184 2.80642 3.81388 4.75851 5.62553 6.40129 - 7.07348 7.63133 8.0657 8.36929 8.53669 8.53669 8.36929 8.0657 7.63133 7.07348 6.40129 5.62553 - 4.75851 3.81388 2.80642 1.75184 0.666546 -0.432615 -1.52861 -2.60446 -3.64354 -4.62981 -5.5481 -6.38436 - -7.12594 -7.76175 -8.28245 -8.68046 -8.94966 -9.34329 -9.87623 -9.50309 -9.23073 -8.82982 -8.30648 -7.66823 - -6.92439 -6.086 -5.16575 -4.17772 -3.1371 -2.05997 -0.963008 0.136787 1.22234 2.27676 3.28361 4.22716 - 5.09256 5.86612 6.53548 7.08975 7.51969 7.81781 7.97845 7.97845 7.81781 7.51969 7.08975 6.53548 - 5.86612 5.09256 4.22716 3.28361 2.27676 1.22234 0.136787 -0.963008 -2.05997 -3.1371 -4.17772 -5.16575 - -6.086 -6.92439 -7.66823 -8.30648 -8.82982 -9.23073 -9.50309 -9.87623 -10.3494 -10.0032 -9.72785 -9.32424 - -8.79847 -8.158 -7.41208 -6.57173 -5.64966 -4.65996 -3.61787 -2.5395 -1.44158 -0.341134 0.744714 1.79905 - 2.8054 3.748 4.61199 5.38364 6.05052 6.60169 7.02779 7.32116 7.47592 7.47592 7.32116 7.02779 - 6.60169 6.05052 5.38364 4.61199 3.748 2.8054 1.79905 0.744714 -0.341134 -1.44158 -2.5395 -3.61787 - -4.65996 -5.64966 -6.57173 -7.41208 -8.158 -8.79847 -9.32424 -9.72785 -10.0032 -10.3494 -10.733 -10.4184 - -10.1403 -9.73443 -9.20676 -8.56456 -7.81695 -6.97496 -6.0513 -5.06009 -4.01664 -2.93709 -1.8382 -0.737075 - 0.349149 1.40352 2.40954 3.35142 4.21429 4.9844 5.64931 6.19803 6.62111 6.91076 7.06087 7.06087 - 6.91076 6.62111 6.19803 5.64931 4.9844 4.21429 3.35142 2.40954 1.40352 0.349149 -0.737075 -1.8382 - -2.93709 -4.01664 -5.06009 -6.0513 -6.97496 -7.81695 -8.56456 -9.20676 -9.73443 -10.1403 -10.4184 -10.733 - -11.0029 -10.7217 -10.441 -10.0338 -9.50523 -8.86216 -8.11353 -7.27038 -6.34547 -5.353 -4.30833 -3.22768 - -2.12786 -1.02601 0.0606809 1.11522 2.1211 3.06251 3.92457 4.69357 5.35708 5.90411 6.32519 6.61238 - 6.75938 6.75938 6.61238 6.32519 5.90411 5.35708 4.69357 3.92457 3.06251 2.1211 1.11522 0.0606809 - -1.02601 -2.12786 -3.22768 -4.30833 -5.353 -6.34547 -7.27038 -8.11353 -8.86216 -9.50523 -10.0338 -10.441 - -10.7217 -11.0029 -11.1423 -11.0015 -10.7223 -10.3089 -9.7679 -9.10784 -8.33913 -7.47388 -6.52574 -5.50967 + -11.0015 -11.1423 -11.0029 -10.8489 -10.5615 -10.1367 -9.58282 -8.90968 -8.12851 -7.25207 -6.29448 -5.27107 + -4.19813 -3.09273 -1.97239 -0.854858 0.242196 1.30145 2.3062 3.24067 4.09024 4.84175 5.48371 6.00658 + 6.40298 6.66792 6.799 6.799 6.66792 6.40298 6.00658 5.48371 4.84175 4.09024 3.24067 2.3062 + 1.30145 0.242196 -0.854858 -1.97239 -3.09273 -4.19813 -5.27107 -6.29448 -7.25207 -8.12851 -8.90968 -9.58282 + -10.1367 -10.5615 -10.8489 -11.0029 -10.733 -10.6093 -10.318 -9.89056 -9.33492 -8.66055 -7.87859 -7.00172 + -6.04404 -5.02085 -3.94842 -2.84377 -1.72441 -0.608054 0.487665 1.54545 2.54865 3.48148 4.32938 5.07917 + 5.71936 6.24037 6.63475 6.89733 7.02538 7.02538 6.89733 6.63475 6.24037 5.71936 5.07917 4.32938 + 3.48148 2.54865 1.54545 0.487665 -0.608054 -1.72441 -2.84377 -3.94842 -5.02085 -6.04404 -7.00172 -7.87859 + -8.66055 -9.33492 -9.89056 -10.318 -10.6093 -10.733 -10.3494 -10.2582 -9.9636 -9.53385 -8.97657 -8.30106 + -7.5183 -6.64092 -5.68297 -4.65971 -3.58741 -2.48307 -1.36419 -0.248449 0.846514 1.90342 2.90559 3.83728 + 4.68387 5.43215 6.07059 6.58949 6.98124 7.24045 7.3641 7.3641 7.24045 6.98124 6.58949 6.07059 + 5.43215 4.68387 3.83728 2.90559 1.90342 0.846514 -0.248449 -1.36419 -2.48307 -3.58741 -4.65971 -5.68297 + -6.64092 -7.5183 -8.30106 -8.97657 -9.53385 -9.9636 -10.2582 -10.3494 -9.87623 -9.81659 -9.51937 -9.08774 + -8.52908 -7.85251 -7.06895 -6.19095 -5.23253 -4.20892 -3.13639 -2.03193 -0.913024 0.20263 1.29739 2.35397 + 3.35567 4.2867 5.13238 5.87945 6.51624 7.03292 7.42167 7.67684 7.79504 7.79504 7.67684 7.42167 + 7.03292 6.51624 5.87945 5.13238 4.2867 3.35567 2.35397 1.29739 0.20263 -0.913024 -2.03193 -3.13639 + -4.20892 -5.23253 -6.19095 -7.06895 -7.85251 -8.52908 -9.08774 -9.51937 -9.81659 -9.87623 -9.34329 -9.3117 + -9.0126 -8.57952 -8.01969 -7.34215 -6.55774 -5.67897 -4.71984 -3.69558 -2.62243 -1.5174 -0.397978 0.718123 + 1.81324 2.87005 3.87183 4.8027 5.64794 6.39415 7.02954 7.54408 7.9297 8.18043 8.29252 8.29252 + 8.18043 7.9297 7.54408 7.02954 6.39415 5.64794 4.8027 3.87183 2.87005 1.81324 0.718123 -0.397978 + -1.5174 -2.62243 -3.69558 -4.71984 -5.67897 -6.55774 -7.34215 -8.01969 -8.57952 -9.0126 -9.3117 -9.34329 + -8.78403 -8.7755 -8.47505 -8.04087 -7.48003 -6.80152 -6.01616 -5.13643 -4.17631 -3.15104 -2.07686 -0.970791 + 0.149657 1.26675 2.36278 3.4204 4.42281 5.35408 6.19937 6.94518 7.57952 8.09217 8.47478 8.721 + 8.82668 8.82668 8.721 8.47478 8.09217 7.57952 6.94518 6.19937 5.35408 4.42281 3.4204 2.36278 + 1.26675 0.149657 -0.970791 -2.07686 -3.15104 -4.17631 -5.13643 -6.01616 -6.80152 -7.48003 -8.04087 -8.47505 + -8.7755 -8.78403 -8.23358 -8.24225 -7.94087 -7.50579 -6.94401 -6.26448 -5.47799 -4.59705 -3.63562 -2.60895 + -1.53331 -0.425725 0.696265 1.81489 2.91241 3.9714 4.97502 5.90725 6.75315 7.49906 8.13283 8.64401 + 9.02392 9.26589 9.36528 9.36528 9.26589 9.02392 8.64401 8.13283 7.49906 6.75315 5.90725 4.97502 + 3.9714 2.91241 1.81489 0.696265 -0.425725 -1.53331 -2.60895 -3.63562 -4.59705 -5.47799 -6.26448 -6.94401 + -7.50579 -7.94087 -8.24225 -8.23358 -7.72655 -7.7463 -7.44428 -7.00843 -6.44569 -5.765 -4.97717 -4.09472 + -3.13163 -2.10316 -1.02561 0.0839757 1.20802 2.3287 3.42826 4.48919 5.49459 6.42834 7.2754 8.02197 + 8.65573 9.16597 9.54374 9.78198 9.87562 9.87562 9.78198 9.54374 9.16597 8.65573 8.02197 7.2754 + 6.42834 5.49459 4.48919 3.42826 2.3287 1.20802 0.0839757 -1.02561 -2.10316 -3.13163 -4.09472 -4.97717 + -5.765 -6.44569 -7.00843 -7.44428 -7.7463 -7.72655 -7.29478 -7.31997 -7.01751 -6.5809 -6.01709 -5.33506 + -4.54563 -3.66135 -2.69622 -1.66555 -0.585636 0.526416 1.653 2.77626 3.87835 4.94175 5.94945 6.88527 + 7.73404 8.48184 9.11618 9.62613 10.0025 10.2378 10.3266 10.3266 10.2378 10.0025 9.62613 9.11618 + 8.48184 7.73404 6.88527 5.94945 4.94175 3.87835 2.77626 1.653 0.526416 -0.585636 -1.66555 -2.69622 + -3.66135 -4.54563 -5.33506 -6.01709 -6.5809 -7.01751 -7.31997 -7.29478 -6.9654 -6.99157 -6.68875 -6.2513 + -5.68625 -5.00262 -4.2113 -3.32484 -2.35731 -1.32401 -0.24132 0.873641 2.00322 3.1295 4.23461 5.30093 + 6.31142 7.24979 8.10079 8.85038 9.48592 9.99628 10.372 10.6054 10.6906 10.6906 10.6054 10.372 + 9.99628 9.48592 8.85038 8.10079 7.24979 6.31142 5.30093 4.23461 3.1295 2.00322 0.873641 -0.24132 + -1.32401 -2.35731 -3.32484 -4.2113 -5.00262 -5.68625 -6.2513 -6.68875 -6.99157 -6.9654 -6.75912 -6.78376 + -6.48046 -6.04198 -5.47543 -4.78992 -3.99636 -3.10737 -2.13705 -1.10075 -0.0148687 1.10341 2.23639 3.36611 + 4.47463 5.5443 6.55799 7.49935 8.35305 9.10495 9.74228 10.2538 10.6299 10.8626 10.9458 10.9458 + 10.8626 10.6299 10.2538 9.74228 9.10495 8.35305 7.49935 6.55799 5.5443 4.47463 3.36611 2.23639 + 1.10341 -0.0148687 -1.10075 -2.13705 -3.10737 -3.99636 -4.78992 -5.47543 -6.04198 -6.48046 -6.78376 -6.75912 + -6.68888 -6.71203 -6.40791 -5.96808 -5.39972 -4.71198 -3.91584 -3.02395 -2.05046 -1.01076 0.0786886 1.20067 + 2.33743 3.47096 4.58327 5.65665 6.67391 7.61865 8.47547 9.23016 9.86989 10.3833 10.7607 10.994 + 11.077 11.077 10.994 10.7607 10.3833 9.86989 9.23016 8.47547 7.61865 6.67391 5.65665 4.58327 + 3.47096 2.33743 1.20067 0.0786886 -1.01076 -2.05046 -3.02395 -3.91584 -4.71198 -5.39972 -5.96808 -6.40791 + -6.71203 -6.68888 -6.75912 -6.78415 -6.48085 -6.04243 -5.47602 -4.79074 -3.99752 -3.10899 -2.13922 -1.10357 + -0.0184007 1.09913 2.23134 3.36032 4.46815 5.53719 6.55033 7.49125 8.34461 9.09626 9.73344 10.2449 + 10.6209 10.8536 10.9368 10.9368 10.8536 10.6209 10.2449 9.73344 9.09626 8.34461 7.49125 6.55033 + 5.53719 4.46815 3.36032 2.23134 1.09913 -0.0184007 -1.10357 -2.13922 -3.10899 -3.99752 -4.79074 -5.47602 + -6.04243 -6.48085 -6.78415 -6.75912 -6.9654 -6.99234 -6.68952 -6.25218 -5.6874 -5.00425 -4.21363 -3.32812 + -2.36175 -1.3298 -0.248597 0.864796 1.99278 3.11751 4.22117 5.28618 6.29554 7.23299 8.08328 8.83237 + 9.46757 9.97774 10.3534 10.5867 10.672 10.672 10.5867 10.3534 9.97774 9.46757 8.83237 8.08328 + 7.23299 6.29554 5.28618 4.22117 3.11751 1.99278 0.864796 -0.248597 -1.3298 -2.36175 -3.32812 -4.21363 + -5.00425 -5.6874 -6.25218 -6.68952 -6.99234 -6.9654 -7.29478 -7.3211 -7.01858 -6.5821 -6.01867 -5.33734 + -4.54899 -3.66616 -2.70283 -1.67424 -0.59663 0.512995 1.63712 2.75799 3.85784 4.91923 5.9252 6.85962 + 7.70732 8.45437 9.08823 9.59791 9.97413 10.2094 10.2982 10.2982 10.2094 9.97413 9.59791 9.08823 + 8.45437 7.70732 6.85962 5.9252 4.91923 3.85784 2.75799 1.63712 0.512995 -0.59663 -1.67424 -2.70283 + -3.66616 -4.54899 -5.33734 -6.01867 -6.5821 -7.01858 -7.3211 -7.29478 -7.72655 -7.74776 -7.44555 -7.00976 + -6.44745 -5.76767 -4.9813 -4.10084 -3.14023 -2.11465 -1.04027 0.0659615 1.18662 2.30402 3.4005 4.45869 + 5.46175 6.39362 7.23925 7.98485 8.61801 9.12796 9.50564 9.74389 9.83756 9.83756 9.74389 9.50564 + 9.12796 8.61801 7.98485 7.23925 6.39362 5.46175 4.45869 3.4005 2.30402 1.18662 0.0659615 -1.04027 + -2.11465 -3.14023 -4.10084 -4.9813 -5.76767 -6.44745 -7.00976 -7.44555 -7.74776 -7.72655 -8.23358 -8.24398 + -7.94214 -7.50694 -6.94558 -6.26715 -5.48251 -4.60414 -3.64595 -2.62305 -1.55157 -0.448349 0.669241 1.78361 + 2.87717 3.93265 4.9333 5.86316 6.7073 7.45205 8.08518 8.59609 8.976 9.21807 9.31755 9.31755 + 9.21807 8.976 8.59609 8.08518 7.45205 6.7073 5.86316 4.9333 3.93265 2.87717 1.78361 0.669241 + -0.448349 -1.55157 -2.62305 -3.64595 -4.60414 -5.48251 -6.26715 -6.94558 -7.50694 -7.94214 -8.24398 -8.23358 + -8.78403 -8.7774 -8.47601 -8.04136 -7.48083 -6.80359 -6.0205 -5.14402 -4.188 -3.16751 -2.09859 -0.998027 + 0.116896 1.22866 2.31979 3.37306 4.37184 5.30026 6.14351 6.88803 7.52174 8.03426 8.41703 8.66352 + 8.76939 8.76939 8.66352 8.41703 8.03426 7.52174 6.88803 6.14351 5.30026 4.37184 3.37306 2.31979 + 1.22866 0.116896 -0.998027 -2.09859 -3.16751 -4.188 -5.14402 -6.0205 -6.80359 -7.48083 -8.04136 -8.47601 + -8.7774 -8.78403 -9.34329 -9.3136 -9.01271 -8.57858 -8.01883 -7.34271 -6.56108 -5.68636 -4.73235 -3.71405 + -2.64743 -1.5492 -0.436566 0.673029 1.76218 2.81376 3.81122 4.73877 5.58172 6.3266 6.96149 7.47615 + 7.86225 8.11352 8.22597 8.22597 8.11352 7.86225 7.47615 6.96149 6.3266 5.58172 4.73877 3.81122 + 2.81376 1.76218 0.673029 -0.436566 -1.5492 -2.64743 -3.71405 -4.73235 -5.68636 -6.56108 -7.34271 -8.01883 + -8.57858 -9.01271 -9.3136 -9.34329 -9.87623 -9.81806 -9.51766 -9.08408 -8.52517 -7.85022 -7.07009 -6.19712 + -5.24504 -4.2288 -3.16427 -2.06811 -0.957445 0.150366 1.23799 2.28837 3.28503 4.21229 5.05549 5.80131 + 6.43789 6.95513 7.34484 7.60098 7.71983 7.71983 7.60098 7.34484 6.95513 6.43789 5.80131 5.05549 + 4.21229 3.28503 2.28837 1.23799 0.150366 -0.957445 -2.06811 -3.16427 -4.2288 -5.24504 -6.19712 -7.07009 + -7.85022 -8.52517 -9.08408 -9.51766 -9.81806 -9.87623 -10.3494 -10.2582 -9.95827 -9.52536 -8.96748 -8.29392 + -7.51545 -6.64435 -5.69427 -4.68006 -3.61752 -2.52324 -1.41428 -0.307912 0.778581 1.82823 2.8246 3.75207 + 4.59607 5.34332 5.98204 6.50218 6.89566 7.15653 7.28124 7.28124 7.15653 6.89566 6.50218 5.98204 + 5.34332 4.59607 3.75207 2.8246 1.82823 0.778581 -0.307912 -1.41428 -2.52324 -3.61752 -4.68006 -5.69427 + -6.64435 -7.51545 -8.29392 -8.96748 -9.52536 -9.95827 -10.2582 -10.3494 -10.733 -10.6053 -10.3058 -9.87389 + -9.31746 -8.64569 -7.86924 -7.00029 -6.05239 -5.04029 -3.97974 -2.88724 -1.77978 -0.674589 0.411124 1.46044 + 2.45697 3.38515 4.23045 4.97959 5.62084 6.14414 6.54141 6.8067 6.93649 6.93649 6.8067 6.54141 + 6.14414 5.62084 4.97959 4.23045 3.38515 2.45697 1.46044 0.411124 -0.674589 -1.77978 -2.88724 -3.97974 + -5.04029 -6.05239 -7.00029 -7.86924 -8.64569 -9.31746 -9.87389 -10.3058 -10.6053 -10.733 -11.0029 -10.8357 + -10.5372 -10.1069 -9.55264 -8.8833 -8.10941 -7.24304 -6.29762 -5.28785 -4.22938 -3.13865 -2.03258 -0.928352 + 0.156874 1.20622 2.20334 3.13268 3.97973 4.73121 5.37535 5.90207 6.30314 6.5725 6.70643 6.70643 + 6.5725 6.30314 5.90207 5.37535 4.73121 3.97973 3.13268 2.20334 1.20622 0.156874 -0.928352 -2.03258 + -3.13865 -4.22938 -5.28785 -6.29762 -7.24304 -8.10941 -8.8833 -9.55264 -10.1069 -10.5372 -10.8357 -11.0029 + -11.1423 -10.9326 -10.6366 -10.2092 -9.65798 -8.99188 -8.22124 -7.35801 -6.41552 -5.40838 -4.35217 -3.26327 + -2.15855 -1.05514 0.029848 1.07955 2.07765 3.00859 3.85785 4.61213 5.25959 5.79002 6.19503 6.46826 + 6.60552 6.60552 6.46826 6.19503 5.79002 5.25959 4.61213 3.85785 3.00859 2.07765 1.07955 0.029848 + -1.05514 -2.15855 -3.26327 -4.35217 -5.40838 -6.41552 -7.35801 -8.22124 -8.99188 -9.65798 -10.2092 -10.6366 + -10.9326 -11.1423 -11.1423 -10.888 -10.5962 -10.1728 -9.62565 -8.96354 -8.19677 -7.33717 -6.39799 -5.39375 + -4.33999 -3.253 -2.14961 -1.04693 0.0379686 1.08825 2.08759 3.02045 3.87225 4.62965 5.28073 5.81513 + 6.22425 6.50132 6.6415 6.6415 6.50132 6.22425 5.81513 5.28073 4.62965 3.87225 3.02045 2.08759 + 1.08825 0.0379686 -1.04693 -2.14961 -3.253 -4.33999 -5.39375 -6.39799 -7.33717 -8.19677 -8.96354 -9.62565 + -10.1728 -10.5962 -10.888 -11.1423 -11.0029 -10.7045 -10.4173 -9.99838 -9.45565 -8.79788 -8.03525 -7.17949 + -6.24377 -5.24254 -4.19127 -3.10622 -2.00418 -0.902192 0.182665 1.23358 2.23423 3.16905 4.02345 4.78402 + 5.43874 5.97715 6.39043 6.67153 6.81509 6.81509 6.67153 6.39043 5.97715 5.43874 4.78402 4.02345 + 3.16905 2.23423 1.23358 0.182665 -0.902192 -2.00418 -3.10622 -4.19127 -5.24254 -6.24377 -7.17949 -8.03525 + -8.79788 -9.45565 -9.99838 -10.4173 -10.7045 -11.0029 -10.733 -10.3943 -10.1108 -9.69623 -9.15801 -8.50466 + -7.74621 -6.89431 -5.96205 -4.96382 -3.91502 -2.83188 -1.73115 -0.629852 0.454969 1.5065 2.50844 3.44519 + 4.30213 5.06582 5.72416 6.26659 6.68418 6.96968 7.11755 7.11755 6.96968 6.68418 6.26659 5.72416 + 5.06582 4.30213 3.44519 2.50844 1.5065 0.454969 -0.629852 -1.73115 -2.83188 -3.91502 -4.96382 -5.96205 + -6.89431 -7.74621 -8.50466 -9.15801 -9.69623 -10.1108 -10.3943 -10.733 -10.3494 -9.97612 -9.69609 -9.28575 + -8.75195 -8.10296 -7.34866 -6.50057 -5.57171 -4.57642 -3.53005 -2.44878 -1.34932 -0.248683 0.836116 1.88828 + 2.89148 3.83015 4.68963 5.45645 6.11847 6.66509 7.0873 7.37781 7.53107 7.53107 7.37781 7.0873 + 6.66509 6.11847 5.45645 4.68963 3.83015 2.89148 1.88828 0.836116 -0.248683 -1.34932 -2.44878 -3.53005 + -4.57642 -5.57171 -6.50057 -7.34866 -8.10296 -8.75195 -9.28575 -9.69609 -9.97612 -10.3494 -9.87623 -9.47545 + -9.19904 -8.79281 -8.26328 -7.61848 -6.86817 -6.02375 -5.09819 -4.10575 -3.06173 -1.98227 -0.884055 0.215948 + 1.30073 2.35351 3.35799 4.29856 5.16057 5.93055 6.59635 7.14734 7.57453 7.87066 8.03029 8.03029 + 7.87066 7.57453 7.14734 6.59635 5.93055 5.16057 4.29856 3.35799 2.35351 1.30073 0.215948 -0.884055 + -1.98227 -3.06173 -4.10575 -5.09819 -6.02375 -6.86817 -7.61848 -8.26328 -8.79281 -9.19904 -9.47545 -9.87623 + -9.34329 -8.92304 -8.65041 -8.24818 -7.72268 -7.08183 -6.33527 -5.49434 -4.57192 -3.5822 -2.54045 -1.46275 + -0.365751 0.733614 1.81836 2.87172 3.87741 4.81983 5.68435 6.45747 7.12709 7.68258 8.11501 8.41721 + 8.58391 8.58391 8.41721 8.11501 7.68258 7.12709 6.45747 5.68435 4.81983 3.87741 2.87172 1.81836 + 0.733614 -0.365751 -1.46275 -2.54045 -3.5822 -4.57192 -5.49434 -6.33527 -7.08183 -7.72268 -8.24818 -8.65041 + -8.92304 -9.34329 -8.78403 -8.35286 -8.08399 -7.68553 -7.16377 -6.52656 -5.78349 -4.94582 -4.02637 -3.03927 + -1.99972 -0.923759 0.172009 1.27068 2.3553 3.40914 4.4159 5.36003 6.2269 7.00305 7.67639 8.23635 + 8.67409 8.98256 9.15668 9.15668 8.98256 8.67409 8.23635 7.67639 7.00305 6.2269 5.36003 4.4159 + 3.40914 2.3553 1.27068 0.172009 -0.923759 -1.99972 -3.03927 -4.02637 -4.94582 -5.78349 -6.52656 -7.16377 + -7.68553 -8.08399 -8.35286 -8.78403 -8.23358 -7.79977 -7.53439 -7.13939 -6.62102 -5.98712 -5.24726 -4.41264 + -3.49601 -2.51144 -1.47408 -0.399906 0.694531 1.79236 2.87667 3.93074 4.93832 5.88388 6.7528 7.53168 + 8.20846 8.77265 9.21548 9.53006 9.71151 9.71151 9.53006 9.21548 8.77265 8.20846 7.53168 6.7528 + 5.88388 4.93832 3.93074 2.87667 1.79236 0.694531 -0.399906 -1.47408 -2.51144 -3.49601 -4.41264 -5.24726 + -5.98712 -6.62102 -7.13939 -7.53439 -7.79977 -8.23358 -7.72655 -7.29722 -7.03484 -6.64287 -6.12753 -5.49665 + -4.75975 -3.92802 -3.01414 -2.0321 -0.997001 0.0752466 1.16814 2.26486 3.34852 4.40244 5.41041 6.35692 + 7.22741 8.0085 8.68818 9.25604 9.70343 10.0236 10.2118 10.2118 10.0236 9.70343 9.25604 8.68818 + 8.0085 7.22741 6.35692 5.41041 4.40244 3.34852 2.26486 1.16814 0.0752466 -0.997001 -2.0321 -3.01414 + -3.92802 -4.75975 -5.49665 -6.12753 -6.64287 -7.03484 -7.29722 -7.72655 -7.29478 -6.8751 -6.6151 -6.2257 + -5.71304 -5.08492 -4.35083 -3.52192 -2.6108 -1.63141 -0.598761 0.471278 1.56227 2.65743 3.73994 4.79315 + 5.80088 6.74766 7.61898 8.40149 9.08326 9.65395 10.105 10.4298 10.6238 10.6238 10.4298 10.105 + 9.65395 9.08326 8.40149 7.61898 6.74766 5.80088 4.79315 3.73994 2.65743 1.56227 0.471278 -0.598761 + -1.63141 -2.6108 -3.52192 -4.35083 -5.08492 -5.71304 -6.2257 -6.6151 -6.8751 -7.29478 -6.9654 -6.55779 + -6.29955 -5.91229 -5.40203 -4.77653 -4.04521 -3.21916 -2.31095 -1.33444 -0.304593 0.762801 1.85135 2.94435 + 4.025 5.07672 6.08336 7.0295 7.90066 8.68356 9.36632 9.93867 10.3921 10.7202 10.9186 10.9186 + 10.7202 10.3921 9.93867 9.36632 8.68356 7.90066 7.0295 6.08336 5.07672 4.025 2.94435 1.85135 + 0.762801 -0.304593 -1.33444 -2.31095 -3.21916 -4.04521 -4.77653 -5.40203 -5.91229 -6.29955 -6.55779 -6.9654 + -6.75912 -6.36268 -6.1057 -5.7203 -5.21231 -4.58938 -3.8609 -3.0379 -2.13288 -1.15964 -0.133087 0.931063 + 2.01648 3.10651 4.18441 5.23365 6.23814 7.1825 8.0523 8.83431 9.51669 10.0892 10.5436 10.8733 + 11.0742 11.0742 10.8733 10.5436 10.0892 9.51669 8.83431 8.0523 7.1825 6.23814 5.23365 4.18441 + 3.10651 2.01648 0.931063 -0.133087 -1.15964 -2.13288 -3.0379 -3.8609 -4.58938 -5.21231 -5.7203 -6.1057 + -6.36268 -6.75912 -6.68888 -6.29905 -6.04323 -5.65958 -5.15381 -4.53351 -3.80802 -2.98832 -2.08685 -1.11737 + -0.0947012 0.965497 2.04696 3.13309 4.20721 5.25285 6.25397 7.19524 8.06229 8.84194 9.52238 10.0935 + 10.5469 10.8763 11.0776 11.0776 10.8763 10.5469 10.0935 9.52238 8.84194 8.06229 7.19524 6.25397 + 5.25285 4.20721 3.13309 2.04696 0.965497 -0.0947012 -1.11737 -2.08685 -2.98832 -3.80802 -4.53351 -5.15381 + -5.65958 -6.04323 -6.29905 -6.68888 -6.75912 -6.36713 -6.1106 -5.72566 -5.21814 -4.59568 -3.86766 -3.04508 + -2.14044 -1.16753 -0.141216 0.922759 2.00807 3.09807 4.176 5.22533 6.22995 7.17446 8.04444 8.82662 + 9.50917 10.0819 10.5363 10.8661 11.0671 11.0671 10.8661 10.5363 10.0819 9.50917 8.82662 8.04444 + 7.17446 6.22995 5.22533 4.176 3.09807 2.00807 0.922759 -0.141216 -1.16753 -2.14044 -3.04508 -3.86766 + -4.59568 -5.21814 -5.72566 -6.1106 -6.36713 -6.75912 -6.9654 -6.56666 -6.30931 -5.923 -5.41374 -4.78923 + -4.05888 -3.23375 -2.32634 -1.35052 -0.321219 0.745785 1.8341 2.92701 4.00771 5.05959 6.06649 7.01296 + 7.88449 8.66777 9.35089 9.92355 10.3773 10.7055 10.904 10.904 10.7055 10.3773 9.92355 9.35089 + 8.66777 7.88449 7.01296 6.06649 5.05959 4.00771 2.92701 1.8341 0.745785 -0.321219 -1.35052 -2.32634 + -3.23375 -4.05888 -4.78923 -5.41374 -5.923 -6.30931 -6.56666 -6.9654 -7.29478 -6.88821 -6.62959 -6.24166 + -5.73054 -5.10399 -4.37145 -3.54398 -2.63414 -1.65584 -0.624058 0.445362 1.53598 2.631 3.71359 4.76707 + 5.77522 6.72253 7.59445 8.37758 9.05995 9.63116 10.0826 10.4077 10.6019 10.6019 10.4077 10.0826 + 9.63116 9.05995 8.37758 7.59445 6.72253 5.77522 4.76707 3.71359 2.631 1.53598 0.445362 -0.624058 + -1.65584 -2.63414 -3.54398 -4.37145 -5.10399 -5.73054 -6.24166 -6.62959 -6.88821 -7.29478 -7.72655 -7.31432 + -7.0538 -6.66387 -6.1507 -5.52205 -4.78734 -3.95766 -3.04561 -2.06512 -1.03124 0.0401307 1.1325 2.22904 + 3.31283 4.36716 5.37577 6.32307 7.19445 7.97647 8.65704 9.22571 9.67373 9.99433 10.1828 10.1828 + 9.99433 9.67373 9.22571 8.65704 7.97647 7.19445 6.32307 5.37577 4.36716 3.31283 2.22904 1.1325 + 0.0401307 -1.03124 -2.06512 -3.04561 -3.95766 -4.78734 -5.52205 -6.1507 -6.66387 -7.0538 -7.31432 -7.72655 + -8.23358 -7.82047 -7.55745 -7.16513 -6.64966 -6.01877 -5.28186 -4.45001 -3.53586 -2.55338 -1.51766 -0.444648 + 0.649107 1.74672 2.83125 3.88591 4.8944 5.84109 6.7113 7.49152 8.16959 8.73494 9.17872 9.49395 + 9.67573 9.67573 9.49395 9.17872 8.73494 8.16959 7.49152 6.7113 5.84109 4.8944 3.88591 2.83125 + 1.74672 0.649107 -0.444648 -1.51766 -2.55338 -3.53586 -4.45001 -5.28186 -6.01877 -6.64966 -7.16513 -7.55745 + -7.82047 -8.23358 -8.78403 -8.37659 -8.11063 -7.71559 -7.1976 -6.56433 -5.82515 -4.99113 -4.07493 -3.09056 + -2.05315 -0.978697 0.116209 1.21464 2.2996 3.35427 4.3623 5.30802 6.17669 6.95473 7.6299 8.19153 + 8.63062 8.94005 9.11464 9.11464 8.94005 8.63062 8.19153 7.6299 6.95473 6.17669 5.30802 4.3623 + 3.35427 2.2996 1.21464 0.116209 -0.978697 -2.05315 -3.09056 -4.07493 -4.99113 -5.82515 -6.56433 -7.1976 + -7.71559 -8.11063 -8.37659 -8.78403 -9.34329 -8.94901 -8.67986 -8.28192 -7.76127 -7.12554 -6.38404 -5.54784 + -4.62963 -3.64343 -2.60442 -1.52863 -0.432694 0.666416 1.75166 2.8062 3.81363 4.75823 5.62522 6.40095 + 7.07313 7.63096 8.06533 8.36891 8.5363 8.5363 8.36891 8.06533 7.63096 7.07313 6.40095 5.62522 + 4.75823 3.81363 2.8062 1.75166 0.666416 -0.432694 -1.52863 -2.60442 -3.64343 -4.62963 -5.54784 -6.38404 + -7.12554 -7.76127 -8.28192 -8.67986 -8.94901 -9.34329 -9.87623 -9.50254 -9.23022 -8.82936 -8.30607 -7.66789 + -6.92411 -6.08579 -5.16562 -4.17765 -3.13709 -2.06002 -0.963113 0.136633 1.22214 2.27652 3.28334 4.22685 + 5.09223 5.86577 6.53511 7.08937 7.51931 7.81742 7.97806 7.97806 7.81742 7.51931 7.08937 6.53511 + 5.86577 5.09223 4.22685 3.28334 2.27652 1.22214 0.136633 -0.963113 -2.06002 -3.13709 -4.17765 -5.16562 + -6.08579 -6.92411 -7.66789 -8.30607 -8.82936 -9.23022 -9.50254 -9.87623 -10.3494 -10.0027 -9.72744 -9.32387 + -8.79814 -8.15772 -7.41186 -6.57158 -5.64957 -4.65993 -3.6179 -2.53959 -1.44171 -0.341317 0.744489 1.79879 + 2.80511 3.74768 4.61165 5.38328 6.05015 6.60131 7.0274 7.32076 7.47552 7.47552 7.32076 7.0274 + 6.60131 6.05015 5.38328 4.61165 3.74768 2.80511 1.79879 0.744489 -0.341317 -1.44171 -2.53959 -3.6179 + -4.65993 -5.64957 -6.57158 -7.41186 -8.15772 -8.79814 -9.32387 -9.72744 -10.0027 -10.3494 -10.733 -10.4181 + -10.14 -9.73414 -9.20651 -8.56436 -7.81681 -6.97487 -6.05127 -5.06012 -4.01672 -2.93722 -1.83838 -0.737294 + 0.348892 1.40323 2.40922 3.35108 4.21393 4.98402 5.64893 6.19764 6.62072 6.91037 7.06048 7.06048 + 6.91037 6.62072 6.19764 5.64893 4.98402 4.21393 3.35108 2.40922 1.40323 0.348892 -0.737294 -1.83838 + -2.93722 -4.01672 -5.06012 -6.05127 -6.97487 -7.81681 -8.56436 -9.20651 -9.73414 -10.14 -10.4181 -10.733 + -11.0029 -10.7215 -10.4407 -10.0336 -9.50506 -8.86204 -8.11346 -7.27037 -6.34551 -5.3531 -4.30847 -3.22787 + -2.12809 -1.02627 0.0603844 1.1149 2.12075 3.06214 3.92419 4.69318 5.35668 5.90371 6.32479 6.61199 + 6.75899 6.75899 6.61199 6.32479 5.90371 5.35668 4.69318 3.92419 3.06214 2.12075 1.1149 0.0603844 + -1.02627 -2.12809 -3.22787 -4.30847 -5.3531 -6.34551 -7.27037 -8.11346 -8.86204 -9.50506 -10.0336 -10.4407 + -10.7215 -11.0029 -11.1423 -11.0015 -10.7223 -10.3089 -9.7679 -9.10784 -8.33913 -7.47388 -6.52574 -5.50967 -4.44168 -3.33862 -2.21788 -1.09715 0.00591258 1.0739 2.08998 3.03812 3.90337 4.67208 5.33213 5.87312 6.2865 6.56577 6.70651 6.70651 6.56577 6.2865 5.87312 5.33213 4.67208 3.90337 3.03812 2.08998 1.0739 0.00591258 -1.09715 -2.21788 -3.33862 -4.44168 -5.50967 -6.52574 -7.47388 -8.33913 -9.10784 -9.7679 @@ -426,631 +426,631 @@ 1 1 1 1 </DataArray> <DataArray type="Float32" Name="velocity_liq (m/s)" NumberOfComponents="3" format="ascii"> - -0.377844 0.0942446 0 -0.381716 0.281191 0 -0.383958 0.466528 0 -0.384405 0.649772 0 - -0.382983 0.830342 0 -0.379661 1.0076 0 -0.374427 1.18088 0 -0.367281 1.34953 0 - -0.358238 1.5129 0 -0.347321 1.67035 0 -0.334569 1.82128 0 -0.320034 1.96509 0 - -0.30378 2.10122 0 -0.285885 2.22914 0 -0.266438 2.34834 0 -0.24554 2.45836 0 - -0.223304 2.55876 0 -0.199851 2.64913 0 -0.175315 2.72912 0 -0.149838 2.7984 0 - -0.123571 2.85668 0 -0.0966766 2.90372 0 -0.0693225 2.93928 0 -0.04168 2.96319 0 - -0.013904 2.97524 0 0.013904 2.97524 0 0.04168 2.96319 0 0.0693225 2.93928 0 - 0.0966766 2.90372 0 0.123571 2.85668 0 0.149838 2.7984 0 0.175315 2.72912 0 - 0.199851 2.64913 0 0.223304 2.55876 0 0.24554 2.45836 0 0.266438 2.34834 0 - 0.285885 2.22914 0 0.30378 2.10122 0 0.320034 1.96509 0 0.334569 1.82128 0 - 0.347321 1.67035 0 0.358238 1.5129 0 0.367281 1.34953 0 0.374427 1.18088 0 - 0.379661 1.0076 0 0.382983 0.830342 0 0.384405 0.649772 0 0.383958 0.466528 0 - 0.381716 0.281191 0 0.377844 0.0942446 0 -1.12067 0.0939797 0 -1.11866 0.278948 0 - -1.11254 0.461172 0 -1.10212 0.6409 0 -1.08722 0.817834 0 -1.06783 0.99145 0 - -1.04401 1.16115 0 -1.01583 1.32631 0 -0.983372 1.48631 0 -0.946756 1.64056 0 - -0.906113 1.78845 0 -0.861594 1.92943 0 -0.813374 2.06294 0 -0.761645 2.18849 0 - -0.706623 2.30556 0 -0.648542 2.41371 0 -0.587654 2.51251 0 -0.524234 2.60156 0 - -0.458571 2.68051 0 -0.390977 2.74903 0 -0.321782 2.80682 0 -0.251334 2.85363 0 - -0.179996 2.88921 0 -0.10813 2.9133 0 -0.0360548 2.92558 0 0.0360548 2.92558 0 - 0.10813 2.9133 0 0.179996 2.88921 0 0.251334 2.85363 0 0.321782 2.80682 0 - 0.390977 2.74903 0 0.458571 2.68051 0 0.524234 2.60156 0 0.587654 2.51251 0 - 0.648542 2.41371 0 0.706623 2.30556 0 0.761645 2.18849 0 0.813374 2.06294 0 - 0.861594 1.92943 0 0.906113 1.78845 0 0.946756 1.64056 0 0.983372 1.48631 0 - 1.01583 1.32631 0 1.04401 1.16115 0 1.06783 0.99145 0 1.08722 0.817834 0 - 1.10212 0.6409 0 1.11254 0.461172 0 1.11866 0.278948 0 1.12067 0.0939797 0 - -1.84515 0.0917841 0 -1.83713 0.271873 0 -1.82347 0.448467 0 -1.80267 0.622386 0 - -1.77473 0.793515 0 -1.73975 0.961398 0 -1.69783 1.12546 0 -1.64914 1.28511 0 - -1.59384 1.43975 0 -1.53214 1.5888 0 -1.46427 1.73169 0 -1.39049 1.86789 0 - -1.31109 1.99686 0 -1.22636 2.11812 0 -1.13666 2.2312 0 -1.04235 2.33567 0 - -0.943805 2.43111 0 -0.841449 2.51717 0 -0.735718 2.5935 0 -0.627077 2.6598 0 - -0.516014 2.71579 0 -0.40304 2.76124 0 -0.288684 2.79591 0 -0.173467 2.81952 0 - -0.0578535 2.83167 0 0.0578535 2.83167 0 0.173467 2.81952 0 0.288684 2.79591 0 - 0.40304 2.76124 0 0.516014 2.71579 0 0.627077 2.6598 0 0.735718 2.5935 0 - 0.841449 2.51717 0 0.943805 2.43111 0 1.04235 2.33567 0 1.13666 2.2312 0 - 1.22636 2.11812 0 1.31109 1.99686 0 1.39049 1.86789 0 1.46427 1.73169 0 - 1.53214 1.5888 0 1.59384 1.43975 0 1.64914 1.28511 0 1.69783 1.12546 0 - 1.73975 0.961398 0 1.77473 0.793515 0 1.80267 0.622386 0 1.82347 0.448467 0 - 1.83713 0.271873 0 1.84515 0.0917841 0 -2.54034 0.0876101 0 -2.52655 0.25913 0 - -2.50617 0.427165 0 -2.47587 0.592587 0 -2.43582 0.755328 0 -2.38618 0.914965 0 - -2.32717 1.07096 0 -2.259 1.22275 0 -2.18195 1.36976 0 -2.09631 1.51145 0 - -2.0024 1.64727 0 -1.9006 1.77672 0 -1.79129 1.89931 0 -1.6749 2.01456 0 - -1.55189 2.12205 0 -1.42275 2.22136 0 -1.28799 2.31212 0 -1.14817 2.39398 0 - -1.00385 2.46664 0 -0.855647 2.52981 0 -0.70419 2.58326 0 -0.550135 2.62675 0 - -0.394156 2.66006 0 -0.236918 2.6829 0 -0.0790331 2.69478 0 0.0790331 2.69478 0 - 0.236918 2.6829 0 0.394156 2.66006 0 0.550135 2.62675 0 0.70419 2.58326 0 - 0.855647 2.52981 0 1.00385 2.46664 0 1.14817 2.39398 0 1.28799 2.31212 0 - 1.42275 2.22136 0 1.55189 2.12205 0 1.6749 2.01456 0 1.79129 1.89931 0 - 1.9006 1.77672 0 2.0024 1.64727 0 2.09631 1.51145 0 2.18195 1.36976 0 - 2.259 1.22275 0 2.32717 1.07096 0 2.38618 0.914965 0 2.43582 0.755328 0 - 2.47587 0.592587 0 2.50617 0.427165 0 2.52655 0.25913 0 2.54034 0.0876101 0 - -3.19545 0.0816655 0 -3.17633 0.241465 0 -3.15004 0.398158 0 -3.11122 0.552476 0 - -3.06016 0.704318 0 -2.99709 0.853275 0 -2.92229 0.998841 0 -2.83607 1.14048 0 - -2.73876 1.27767 0 -2.63076 1.40989 0 -2.51247 1.53664 0 -2.38436 1.65745 0 - -2.24694 1.77185 0 -2.10073 1.87942 0 -1.94631 1.97976 0 -1.78428 2.07248 0 - -1.61529 2.15725 0 -1.44001 2.23375 0 -1.25913 2.30169 0 -1.07341 2.36083 0 - -0.883589 2.41096 0 -0.690467 2.45187 0 -0.494846 2.48334 0 -0.297527 2.50507 0 - -0.0992713 2.51648 0 0.0992713 2.51648 0 0.297527 2.50507 0 0.494846 2.48334 0 - 0.690467 2.45187 0 0.883589 2.41096 0 1.07341 2.36083 0 1.25913 2.30169 0 - 1.44001 2.23375 0 1.61529 2.15725 0 1.78428 2.07248 0 1.94631 1.97976 0 - 2.10073 1.87942 0 2.24694 1.77185 0 2.38436 1.65745 0 2.51247 1.53664 0 - 2.63076 1.40989 0 2.73876 1.27767 0 2.83607 1.14048 0 2.92229 0.998841 0 - 2.99709 0.853275 0 3.06016 0.704318 0 3.11122 0.552476 0 3.15004 0.398158 0 - 3.17633 0.241465 0 3.19545 0.0816655 0 -3.80025 0.0741889 0 -3.77636 0.219546 0 - -3.74493 0.362363 0 -3.69862 0.503141 0 -3.63775 0.641716 0 -3.56262 0.777688 0 - -3.47358 0.910583 0 -3.37097 1.03991 0 -3.25521 1.16518 0 -3.12677 1.28593 0 - -2.98614 1.40169 0 -2.83388 1.51203 0 -2.67058 1.61654 0 -2.49688 1.71482 0 - -2.31346 1.80651 0 -2.12102 1.89127 0 -1.92033 1.96878 0 -1.71217 2.03877 0 - -1.49735 2.10098 0 -1.27674 2.1552 0 -1.05121 2.20124 0 -0.82167 2.23892 0 - -0.589042 2.26804 0 -0.354255 2.28827 0 -0.118219 2.29899 0 0.118219 2.29899 0 - 0.354255 2.28827 0 0.589042 2.26804 0 0.82167 2.23892 0 1.05121 2.20124 0 - 1.27674 2.1552 0 1.49735 2.10098 0 1.71217 2.03877 0 1.92033 1.96878 0 - 2.12102 1.89127 0 2.31346 1.80651 0 2.49688 1.71482 0 2.67058 1.61654 0 - 2.83388 1.51203 0 2.98614 1.40169 0 3.12677 1.28593 0 3.25521 1.16518 0 - 3.37097 1.03991 0 3.47358 0.910583 0 3.56262 0.777688 0 3.63775 0.641716 0 - 3.69862 0.503141 0 3.74493 0.362363 0 3.77636 0.219546 0 3.80025 0.0741889 0 - -4.3453 0.0654221 0 -4.31731 0.194008 0 -4.28152 0.320694 0 -4.22875 0.445722 0 - -4.15935 0.568863 0 -4.07366 0.689728 0 -3.97205 0.807883 0 -3.85493 0.922885 0 - -3.72278 1.0343 0 -3.57611 1.1417 0 -3.41552 1.24469 0 -3.24162 1.34287 0 - -3.05509 1.43588 0 -2.85666 1.52336 0 -2.6471 1.60499 0 -2.42721 1.68047 0 - -2.19786 1.74953 0 -1.95993 1.81192 0 -1.71435 1.86743 0 -1.46208 1.91586 0 - -1.20409 1.95707 0 -0.941403 1.99088 0 -0.67505 2.01711 0 -0.406075 2.03544 0 - -0.135532 2.04524 0 0.135532 2.04524 0 0.406075 2.03544 0 0.67505 2.01711 0 - 0.941403 1.99088 0 1.20409 1.95707 0 1.46208 1.91586 0 1.71435 1.86743 0 - 1.95993 1.81192 0 2.19786 1.74953 0 2.42721 1.68047 0 2.6471 1.60499 0 - 2.85666 1.52336 0 3.05509 1.43588 0 3.24162 1.34287 0 3.41552 1.24469 0 - 3.57611 1.1417 0 3.72278 1.0343 0 3.85493 0.922885 0 3.97205 0.807883 0 - 4.07366 0.689728 0 4.15935 0.568863 0 4.22875 0.445722 0 4.28152 0.320694 0 - 4.31731 0.194008 0 4.3453 0.0654221 0 -4.82207 0.0556171 0 -4.79077 0.165483 0 - -4.75142 0.274086 0 -4.69327 0.381414 0 -4.61669 0.487188 0 -4.52202 0.591045 0 - -4.40967 0.692601 0 -4.28009 0.791468 0 -4.1338 0.887271 0 -3.97137 0.979643 0 - -3.79345 1.06823 0 -3.60072 1.1527 0 -3.39395 1.23274 0 -3.17392 1.30804 0 - -2.94149 1.37832 0 -2.69755 1.44333 0 -2.44305 1.50283 0 -2.17896 1.55661 0 - -1.90629 1.6045 0 -1.62611 1.64633 0 -1.33947 1.68198 0 -1.04749 1.7113 0 - -0.751296 1.73413 0 -0.452034 1.75017 0 -0.150891 1.75882 0 0.150891 1.75882 0 - 0.452034 1.75017 0 0.751296 1.73413 0 1.04749 1.7113 0 1.33947 1.68198 0 - 1.62611 1.64633 0 1.90629 1.6045 0 2.17896 1.55661 0 2.44305 1.50283 0 - 2.69755 1.44333 0 2.94149 1.37832 0 3.17392 1.30804 0 3.39395 1.23274 0 - 3.60072 1.1527 0 3.79345 1.06823 0 3.97137 0.979643 0 4.1338 0.887271 0 - 4.28009 0.791468 0 4.40967 0.692601 0 4.52202 0.591045 0 4.61669 0.487188 0 - 4.69327 0.381414 0 4.75142 0.274086 0 4.79077 0.165483 0 4.82207 0.0556171 0 - -5.22309 0.0450402 0 -5.18936 0.134619 0 -5.14726 0.223496 0 -5.08486 0.311454 0 - -5.00249 0.398197 0 -4.90052 0.4834 0 -4.77937 0.56674 0 -4.63951 0.647895 0 - -4.48151 0.726551 0 -4.30599 0.802408 0 -4.11361 0.875174 0 -3.90515 0.944573 0 - -3.6814 1.01034 0 -3.44322 1.07223 0 -3.19154 1.13001 0 -2.92731 1.18347 0 - -2.65156 1.23242 0 -2.36533 1.27669 0 -2.06972 1.31614 0 -1.76585 1.35063 0 - -1.45488 1.38007 0 -1.13798 1.40433 0 -0.816361 1.42329 0 -0.491268 1.43667 0 - -0.164006 1.44392 0 0.164006 1.44392 0 0.491268 1.43667 0 0.816361 1.42329 0 - 1.13798 1.40433 0 1.45488 1.38007 0 1.76585 1.35063 0 2.06972 1.31614 0 - 2.36533 1.27669 0 2.65156 1.23242 0 2.92731 1.18347 0 3.19154 1.13001 0 - 3.44322 1.07223 0 3.6814 1.01034 0 3.90515 0.944573 0 4.11361 0.875174 0 - 4.30599 0.802408 0 4.48151 0.726551 0 4.63951 0.647895 0 4.77937 0.56674 0 - 4.90052 0.4834 0 5.00249 0.398197 0 5.08486 0.311454 0 5.14726 0.223496 0 - 5.18936 0.134619 0 5.22309 0.0450402 0 -5.54204 0.0339654 0 -5.50679 0.102068 0 - -5.46275 0.169899 0 -5.39723 0.237121 0 -5.31052 0.303456 0 -5.20298 0.368639 0 - -5.07505 0.432417 0 -4.92723 0.494539 0 -4.76008 0.554764 0 -4.57427 0.612859 0 - -4.37052 0.6686 0 -4.14961 0.721773 0 -3.9124 0.772175 0 -3.6598 0.819616 0 - -3.39277 0.863918 0 -3.11235 0.904919 0 -2.8196 0.942473 0 -2.51563 0.97645 0 - -2.2016 1.00674 0 -1.87869 1.03325 0 -1.54811 1.0559 0 -1.21112 1.07461 0 - -0.868981 1.08926 0 -0.523012 1.09964 0 -0.17462 1.10529 0 0.17462 1.10529 0 - 0.523012 1.09964 0 0.868981 1.08926 0 1.21112 1.07461 0 1.54811 1.0559 0 - 1.87869 1.03325 0 2.2016 1.00674 0 2.51563 0.97645 0 2.8196 0.942473 0 - 3.11235 0.904919 0 3.39277 0.863918 0 3.6598 0.819616 0 3.9124 0.772175 0 - 4.14961 0.721773 0 4.37052 0.6686 0 4.57427 0.612859 0 4.76008 0.554764 0 - 4.92723 0.494539 0 5.07505 0.432417 0 5.20298 0.368639 0 5.31052 0.303456 0 - 5.39723 0.237121 0 5.46275 0.169899 0 5.50679 0.102068 0 5.54204 0.0339654 0 - -5.77381 0.0226571 0 -5.73788 0.0684681 0 -5.69268 0.114259 0 -5.62514 0.159694 0 - -5.53552 0.204556 0 -5.42417 0.248656 0 -5.29152 0.291818 0 -5.13808 0.333873 0 - -4.96445 0.374656 0 -4.7713 0.414007 0 -4.55938 0.451772 0 -4.32949 0.487806 0 - -4.08253 0.521969 0 -3.81944 0.554131 0 -3.54123 0.584171 0 -3.24897 0.611978 0 - -2.94376 0.637452 0 -2.62676 0.660507 0 -2.29918 0.681068 0 -1.96224 0.699072 0 - -1.6172 0.714467 0 -1.26535 0.727198 0 -0.908016 0.737189 0 -0.546571 0.744289 0 - -0.182499 0.748175 0 0.182499 0.748175 0 0.546571 0.744289 0 0.908016 0.737189 0 - 1.26535 0.727198 0 1.6172 0.714467 0 1.96224 0.699072 0 2.29918 0.681068 0 - 2.62676 0.660507 0 2.94376 0.637452 0 3.24897 0.611978 0 3.54123 0.584171 0 - 3.81944 0.554131 0 4.08253 0.521969 0 4.32949 0.487806 0 4.55938 0.451772 0 - 4.7713 0.414007 0 4.96445 0.374656 0 5.13808 0.333873 0 5.29152 0.291818 0 - 5.42417 0.248656 0 5.53552 0.204556 0 5.62514 0.159694 0 5.69268 0.114259 0 - 5.73788 0.0684681 0 5.77381 0.0226571 0 -5.91458 0.0113315 0 -5.87856 0.034376 0 - -5.83287 0.057466 0 -5.76432 0.0803969 0 -5.67314 0.10305 0 -5.55966 0.12533 0 - -5.42431 0.147147 0 -5.26762 0.168413 0 -5.09018 0.189045 0 -4.89267 0.20896 0 - -4.67586 0.228079 0 -4.44057 0.246327 0 -4.18772 0.263631 0 -3.91826 0.279923 0 - -3.63323 0.295141 0 -3.33371 0.309228 0 -3.02085 0.322132 0 -2.69583 0.33381 0 - -2.35988 0.344224 0 -2.01425 0.353344 0 -1.66024 0.361144 0 -1.29916 0.367597 0 - -0.932368 0.372667 0 -0.561277 0.376276 0 -0.187419 0.378257 0 0.187419 0.378257 0 - 0.561277 0.376276 0 0.932368 0.372667 0 1.29916 0.367597 0 1.66024 0.361144 0 - 2.01425 0.353344 0 2.35988 0.344224 0 2.69583 0.33381 0 3.02085 0.322132 0 - 3.33371 0.309228 0 3.63323 0.295141 0 3.91826 0.279923 0 4.18772 0.263631 0 - 4.44057 0.246327 0 4.67586 0.228079 0 4.89267 0.20896 0 5.09018 0.189045 0 - 5.26762 0.168413 0 5.42431 0.147147 0 5.55966 0.12533 0 5.67314 0.10305 0 - 5.76432 0.0803969 0 5.83287 0.057466 0 5.87856 0.034376 0 5.91458 0.0113315 0 - -5.96183 8.68541e-05 0 -5.92592 0.000173221 0 -5.88017 0.000233038 0 -5.81138 0.000291512 0 - -5.71977 0.000357693 0 -5.60566 0.000434863 0 -5.46949 0.000523753 0 -5.31177 0.000623568 0 - -5.13311 0.000732407 0 -4.93419 0.000847554 0 -4.71578 0.000965742 0 -4.47871 0.00108343 0 - -4.22388 0.00119704 0 -3.95229 0.00130324 0 -3.66496 0.00139913 0 -3.36299 0.00148244 0 - -3.04752 0.00155171 0 -2.71976 0.00160638 0 -2.38093 0.00164679 0 -2.03231 0.00167424 0 - -1.6752 0.00169079 0 -1.31093 0.00169904 0 -0.940855 0.00170186 0 -0.566407 0.00170195 0 - -0.189136 0.00170144 0 0.189136 0.00170144 0 0.566407 0.00170195 0 0.940855 0.00170186 0 - 1.31093 0.00169904 0 1.6752 0.00169079 0 2.03231 0.00167424 0 2.38093 0.00164679 0 - 2.71976 0.00160638 0 3.04752 0.00155171 0 3.36299 0.00148244 0 3.66496 0.00139913 0 - 3.95229 0.00130324 0 4.22388 0.00119704 0 4.47871 0.00108343 0 4.71578 0.000965742 0 - 4.93419 0.000847554 0 5.13311 0.000732407 0 5.31177 0.000623568 0 5.46949 0.000523753 0 - 5.60566 0.000434863 0 5.71977 0.000357693 0 5.81138 0.000291512 0 5.88017 0.000233038 0 - 5.92592 0.000173221 0 5.96183 8.68541e-05 0 -5.91455 -0.0111602 0 -5.87849 -0.0340346 0 - -5.83279 -0.0570072 0 -5.76423 -0.0798229 0 -5.67302 -0.102345 0 -5.55952 -0.12447 0 - -5.42416 -0.146108 0 -5.26745 -0.167173 0 -5.08999 -0.187585 0 -4.89248 -0.207267 0 - -4.67567 -0.226146 0 -4.44039 -0.244155 0 -4.18755 -0.261229 0 -3.91811 -0.277306 0 - -3.6331 -0.292331 0 -3.33361 -0.30625 0 -3.02077 -0.319016 0 -2.69578 -0.330585 0 - -2.35984 -0.34092 0 -2.01423 -0.349987 0 -1.66024 -0.357756 0 -1.29917 -0.364196 0 - -0.932379 -0.369263 0 -0.561286 -0.372874 0 -0.187422 -0.374857 0 0.187422 -0.374857 0 - 0.561286 -0.372874 0 0.932379 -0.369263 0 1.29917 -0.364196 0 1.66024 -0.357756 0 - 2.01423 -0.349987 0 2.35984 -0.34092 0 2.69578 -0.330585 0 3.02077 -0.319016 0 - 3.33361 -0.30625 0 3.6331 -0.292331 0 3.91811 -0.277306 0 4.18755 -0.261229 0 - 4.44039 -0.244155 0 4.67567 -0.226146 0 4.89248 -0.207267 0 5.08999 -0.187585 0 - 5.26745 -0.167173 0 5.42416 -0.146108 0 5.55952 -0.12447 0 5.67302 -0.102345 0 - 5.76423 -0.0798229 0 5.83279 -0.0570072 0 5.87849 -0.0340346 0 5.91455 -0.0111602 0 - -5.77375 -0.0224934 0 -5.73774 -0.0681427 0 -5.69251 -0.113824 0 -5.62494 -0.159149 0 - -5.53528 -0.203882 0 -5.42388 -0.247828 0 -5.29119 -0.290808 0 -5.13772 -0.332656 0 - -4.96406 -0.37321 0 -4.7709 -0.412319 0 -4.55897 -0.449835 0 -4.32909 -0.48562 0 - -4.08216 -0.519544 0 -3.81911 -0.551484 0 -3.54094 -0.581325 0 -3.24873 -0.608961 0 - -2.94358 -0.634296 0 -2.62663 -0.657244 0 -2.2991 -0.67773 0 -1.9622 -0.695689 0 - -1.61719 -0.711062 0 -1.26536 -0.723788 0 -0.908033 -0.733784 0 -0.546586 -0.740892 0 - -0.182505 -0.744785 0 0.182505 -0.744785 0 0.546586 -0.740892 0 0.908033 -0.733784 0 - 1.26536 -0.723788 0 1.61719 -0.711062 0 1.9622 -0.695689 0 2.2991 -0.67773 0 - 2.62663 -0.657244 0 2.94358 -0.634296 0 3.24873 -0.608961 0 3.54094 -0.581325 0 - 3.81911 -0.551484 0 4.08216 -0.519544 0 4.32909 -0.48562 0 4.55897 -0.449835 0 - 4.7709 -0.412319 0 4.96406 -0.37321 0 5.13772 -0.332656 0 5.29119 -0.290808 0 - 5.42388 -0.247828 0 5.53528 -0.203882 0 5.62494 -0.159149 0 5.69251 -0.113824 0 - 5.73774 -0.0681427 0 5.77375 -0.0224934 0 -5.54194 -0.0338153 0 -5.50658 -0.101773 0 - -5.46249 -0.169508 0 -5.3969 -0.236631 0 -5.31012 -0.302843 0 -5.20251 -0.367872 0 - -5.07451 -0.431461 0 -4.92662 -0.493365 0 -4.75943 -0.553347 0 -4.5736 -0.611183 0 - -4.36984 -0.666656 0 -4.14895 -0.719564 0 -3.91177 -0.769711 0 -3.65922 -0.816916 0 - -3.39227 -0.861009 0 -3.11193 -0.901832 0 -2.81926 -0.939245 0 -2.51538 -0.973119 0 - -2.20143 -1.00334 0 -1.87859 -1.02982 0 -1.54807 -1.05246 0 -1.21112 -1.07117 0 - -0.868996 -1.08585 0 -0.523029 -1.09625 0 -0.174626 -1.10192 0 0.174626 -1.10192 0 - 0.523029 -1.09625 0 0.868996 -1.08585 0 1.21112 -1.07117 0 1.54807 -1.05246 0 - 1.87859 -1.02982 0 2.20143 -1.00334 0 2.51538 -0.973119 0 2.81926 -0.939245 0 - 3.11193 -0.901832 0 3.39227 -0.861009 0 3.65922 -0.816916 0 3.91177 -0.769711 0 - 4.14895 -0.719564 0 4.36984 -0.666656 0 4.5736 -0.611183 0 4.75943 -0.553347 0 - 4.92662 -0.493365 0 5.07451 -0.431461 0 5.20251 -0.367872 0 5.31012 -0.302843 0 - 5.3969 -0.236631 0 5.46249 -0.169508 0 5.50658 -0.101773 0 5.54194 -0.0338153 0 - -5.22296 -0.0449113 0 -5.18907 -0.134372 0 -5.14689 -0.223178 0 -5.08439 -0.311056 0 - -5.0019 -0.397684 0 -4.89981 -0.482733 0 -4.77854 -0.565875 0 -4.63859 -0.646794 0 - -4.48051 -0.725185 0 -4.30493 -0.800756 0 -4.11255 -0.873227 0 -3.9041 -0.942333 0 - -3.68039 -1.00782 0 -3.4423 -1.06945 0 -3.19071 -1.12701 0 -2.92661 -1.18028 0 - -2.65099 -1.22909 0 -2.36489 -1.27326 0 -2.06941 -1.31264 0 -1.76565 -1.34712 0 - -1.45476 -1.37656 0 -1.13793 -1.40086 0 -0.816352 -1.41986 0 -0.491274 -1.43328 0 - -0.16401 -1.44055 0 0.16401 -1.44055 0 0.491274 -1.43328 0 0.816352 -1.41986 0 - 1.13793 -1.40086 0 1.45476 -1.37656 0 1.76565 -1.34712 0 2.06941 -1.31264 0 - 2.36489 -1.27326 0 2.65099 -1.22909 0 2.92661 -1.18028 0 3.19071 -1.12701 0 - 3.4423 -1.06945 0 3.68039 -1.00782 0 3.9041 -0.942333 0 4.11255 -0.873227 0 - 4.30493 -0.800756 0 4.48051 -0.725185 0 4.63859 -0.646794 0 4.77854 -0.565875 0 - 4.89981 -0.482733 0 5.0019 -0.397684 0 5.08439 -0.311056 0 5.14689 -0.223178 0 - 5.18907 -0.134372 0 5.22296 -0.0449113 0 -4.8219 -0.0555206 0 -4.79038 -0.165315 0 - -4.75091 -0.273888 0 -4.6926 -0.381164 0 -4.61582 -0.486838 0 -4.52095 -0.590538 0 - -4.40841 -0.69188 0 -4.27867 -0.790486 0 -4.13225 -0.885989 0 -3.96974 -0.978037 0 - -3.79178 -1.06629 0 -3.59907 -1.15043 0 -3.39235 -1.23015 0 -3.17242 -1.30515 0 - -2.94013 -1.37518 0 -2.69636 -1.43998 0 -2.44204 -1.49932 0 -2.17815 -1.55301 0 - -1.90568 -1.60085 0 -1.62567 -1.64268 0 -1.33918 -1.67836 0 -1.04732 -1.70775 0 - -0.751211 -1.73066 0 -0.451999 -1.74676 0 -0.150882 -1.75544 0 0.150882 -1.75544 0 - 0.451999 -1.74676 0 0.751211 -1.73066 0 1.04732 -1.70775 0 1.33918 -1.67836 0 - 1.62567 -1.64268 0 1.90568 -1.60085 0 2.17815 -1.55301 0 2.44204 -1.49932 0 - 2.69636 -1.43998 0 2.94013 -1.37518 0 3.17242 -1.30515 0 3.39235 -1.23015 0 - 3.59907 -1.15043 0 3.79178 -1.06629 0 3.96974 -0.978037 0 4.13225 -0.885989 0 - 4.27867 -0.790486 0 4.40841 -0.69188 0 4.52095 -0.590538 0 4.61582 -0.486838 0 - 4.6926 -0.381164 0 4.75091 -0.273888 0 4.79038 -0.165315 0 4.8219 -0.0555206 0 - -4.34509 -0.065377 0 -4.31679 -0.193973 0 -4.28079 -0.320698 0 -4.22774 -0.445721 0 - -4.15802 -0.56878 0 -4.072 -0.689481 0 -3.97008 -0.807397 0 -3.8527 -0.922097 0 - -3.72033 -1.03316 0 -3.57352 -1.14018 0 -3.41285 -1.24278 0 -3.23894 -1.34056 0 - -3.05247 -1.43319 0 -2.85417 -1.52033 0 -2.6448 -1.60167 0 -2.42515 -1.67691 0 - -2.19607 -1.74579 0 -1.95843 -1.80807 0 -1.71314 -1.86354 0 -1.46115 -1.91199 0 - -1.20342 -1.95326 0 -0.940957 -1.98718 0 -0.674779 -2.01352 0 -0.405935 -2.03196 0 - -0.135489 -2.04182 0 0.135489 -2.04182 0 0.405935 -2.03196 0 0.674779 -2.01352 0 - 0.940957 -1.98718 0 1.20342 -1.95326 0 1.46115 -1.91199 0 1.71314 -1.86354 0 - 1.95843 -1.80807 0 2.19607 -1.74579 0 2.42515 -1.67691 0 2.6448 -1.60167 0 - 2.85417 -1.52033 0 3.05247 -1.43319 0 3.23894 -1.34056 0 3.41285 -1.24278 0 - 3.57352 -1.14018 0 3.72033 -1.03316 0 3.8527 -0.922097 0 3.97008 -0.807397 0 - 4.072 -0.689481 0 4.15802 -0.56878 0 4.22774 -0.445721 0 4.28079 -0.320698 0 - 4.31679 -0.193973 0 4.34509 -0.065377 0 -3.79996 -0.0742335 0 -3.77562 -0.21975 0 - -3.74382 -0.36272 0 -3.69701 -0.50356 0 -3.63559 -0.642075 0 -3.55993 -0.777868 0 - -3.47038 -0.91048 0 -3.36733 -1.03944 0 -3.25122 -1.16429 0 -3.12252 -1.28457 0 - -2.98174 -1.39985 0 -2.82944 -1.50971 0 -2.66619 -1.61376 0 -2.49265 -1.71162 0 - -2.30948 -1.80294 0 -2.11737 -1.88739 0 -1.91708 -1.96469 0 -1.70936 -2.03454 0 - -1.49501 -2.0967 0 -1.27486 -2.15096 0 -1.04978 -2.19711 0 -0.820649 -2.23494 0 - -0.588374 -2.26422 0 -0.353884 -2.28459 0 -0.118101 -2.29541 0 0.118101 -2.29541 0 - 0.353884 -2.28459 0 0.588374 -2.26422 0 0.820649 -2.23494 0 1.04978 -2.19711 0 - 1.27486 -2.15096 0 1.49501 -2.0967 0 1.70936 -2.03454 0 1.91708 -1.96469 0 - 2.11737 -1.88739 0 2.30948 -1.80294 0 2.49265 -1.71162 0 2.66619 -1.61376 0 - 2.82944 -1.50971 0 2.98174 -1.39985 0 3.12252 -1.28457 0 3.25122 -1.16429 0 - 3.36733 -1.03944 0 3.47038 -0.91048 0 3.55993 -0.777868 0 3.63559 -0.642075 0 - 3.69701 -0.50356 0 3.74382 -0.36272 0 3.77562 -0.21975 0 3.79996 -0.0742335 0 - -3.19504 -0.0818804 0 -3.17522 -0.242119 0 -3.14822 -0.399152 0 -3.10853 -0.553622 0 - -3.05654 -0.705417 0 -2.99258 -0.854156 0 -2.91696 -0.999364 0 -2.83002 -1.14054 0 - -2.73213 -1.27719 0 -2.62368 -1.40881 0 -2.50512 -1.53495 0 -2.37689 -1.65514 0 - -2.23951 -1.76895 0 -2.0935 -1.87597 0 -1.93943 -1.97583 0 -1.77788 -2.06815 0 - -1.60948 -2.15262 0 -1.43488 -2.22892 0 -1.25476 -2.29679 0 -1.0698 -2.35597 0 - -0.880756 -2.40623 0 -0.688369 -2.44734 0 -0.493424 -2.47904 0 -0.296712 -2.50097 0 - -0.0990067 -2.51251 0 0.0990067 -2.51251 0 0.296712 -2.50097 0 0.493424 -2.47904 0 - 0.688369 -2.44734 0 0.880756 -2.40623 0 1.0698 -2.35597 0 1.25476 -2.29679 0 - 1.43488 -2.22892 0 1.60948 -2.15262 0 1.77788 -2.06815 0 1.93943 -1.97583 0 - 2.0935 -1.87597 0 2.23951 -1.76895 0 2.37689 -1.65514 0 2.50512 -1.53495 0 - 2.62368 -1.40881 0 2.73213 -1.27719 0 2.83002 -1.14054 0 2.91696 -0.999364 0 - 2.99258 -0.854156 0 3.05654 -0.705417 0 3.10853 -0.553622 0 3.14822 -0.399152 0 - 3.17522 -0.242119 0 3.19504 -0.0818804 0 -2.53975 -0.0881633 0 -2.52481 -0.260649 0 - -2.50311 -0.42931 0 -2.47128 -0.594982 0 -2.42967 -0.757657 0 -2.37857 -0.916987 0 - -2.31823 -1.07249 0 -2.24892 -1.22366 0 -2.17094 -1.36995 0 -2.0846 -1.51085 0 - -1.99023 -1.64585 0 -1.88821 -1.77448 0 -1.77893 -1.89627 0 -1.66281 -2.01078 0 - -1.54031 -2.1176 0 -1.41188 -2.21635 0 -1.27803 -2.30667 0 -1.13926 -2.38824 0 - -0.996122 -2.46074 0 -0.849173 -2.52392 0 -0.699 -2.5775 0 -0.546213 -2.62124 0 - -0.391444 -2.65485 0 -0.235339 -2.67798 0 -0.0785161 -2.69004 0 0.0785161 -2.69004 0 - 0.235339 -2.67798 0 0.391444 -2.65485 0 0.546213 -2.62124 0 0.699 -2.5775 0 - 0.849173 -2.52392 0 0.996122 -2.46074 0 1.13926 -2.38824 0 1.27803 -2.30667 0 - 1.41188 -2.21635 0 1.54031 -2.1176 0 1.66281 -2.01078 0 1.77893 -1.89627 0 - 1.88821 -1.77448 0 1.99023 -1.64585 0 2.0846 -1.51085 0 2.17094 -1.36995 0 - 2.24892 -1.22366 0 2.31823 -1.07249 0 2.37857 -0.916987 0 2.42967 -0.757657 0 - 2.47128 -0.594982 0 2.50311 -0.42931 0 2.52481 -0.260649 0 2.53975 -0.0881633 0 - -1.84432 -0.0930122 0 -1.8344 -0.275041 0 -1.81836 -0.452646 0 -1.79497 -0.62687 0 - -1.76452 -0.797827 0 -1.72723 -0.965213 0 -1.68328 -1.12856 0 -1.63286 -1.28732 0 - -1.57616 -1.44096 0 -1.51342 -1.58892 0 -1.44487 -1.73069 0 -1.37077 -1.86576 0 - -1.29142 -1.99363 0 -1.2071 -2.11385 0 -1.11815 -2.22599 0 -1.0249 -2.32964 0 - -0.927713 -2.42443 0 -0.826956 -2.51001 0 -0.723023 -2.58605 0 -0.616324 -2.65226 0 - -0.507285 -2.70837 0 -0.396357 -2.75409 0 -0.284007 -2.78912 0 -0.170717 -2.8131 0 - -0.0569487 -2.8255 0 0.0569487 -2.8255 0 0.170717 -2.8131 0 0.284007 -2.78912 0 - 0.396357 -2.75409 0 0.507285 -2.70837 0 0.616324 -2.65226 0 0.723023 -2.58605 0 - 0.826956 -2.51001 0 0.927713 -2.42443 0 1.0249 -2.32964 0 1.11815 -2.22599 0 - 1.2071 -2.11385 0 1.29142 -1.99363 0 1.37077 -1.86576 0 1.44487 -1.73069 0 - 1.51342 -1.58892 0 1.57616 -1.44096 0 1.63286 -1.28732 0 1.68328 -1.12856 0 - 1.72723 -0.965213 0 1.76452 -0.797827 0 1.79497 -0.62687 0 1.81836 -0.452646 0 - 1.8344 -0.275041 0 1.84432 -0.0930122 0 -1.11964 -0.0965093 0 -1.11465 -0.285142 0 - -1.10447 -0.468757 0 -1.08994 -0.64868 0 -1.07125 -0.825155 0 -1.0485 -0.997923 0 - -1.02178 -1.16651 0 -0.991183 -1.33038 0 -0.956812 -1.48896 0 -0.918792 -1.64169 0 - -0.87726 -1.78801 0 -0.83237 -1.92742 0 -0.784285 -2.0594 0 -0.733185 -2.18349 0 - -0.679258 -2.29923 0 -0.622707 -2.4062 0 -0.563745 -2.50402 0 -0.502595 -2.59232 0 - -0.439494 -2.67077 0 -0.374688 -2.73905 0 -0.308437 -2.79687 0 -0.241012 -2.84394 0 - -0.172702 -2.87993 0 -0.103808 -2.90448 0 -0.0346269 -2.91708 0 0.0346269 -2.91708 0 - 0.103808 -2.90448 0 0.172702 -2.87993 0 0.241012 -2.84394 0 0.308437 -2.79687 0 - 0.374688 -2.73905 0 0.439494 -2.67077 0 0.502595 -2.59232 0 0.563745 -2.50402 0 - 0.622707 -2.4062 0 0.679258 -2.29923 0 0.733185 -2.18349 0 0.784285 -2.0594 0 - 0.83237 -1.92742 0 0.87726 -1.78801 0 0.918792 -1.64169 0 0.956812 -1.48896 0 - 0.991183 -1.33038 0 1.02178 -1.16651 0 1.0485 -0.997923 0 1.07125 -0.825155 0 - 1.08994 -0.64868 0 1.10447 -0.468757 0 1.11465 -0.285142 0 1.11964 -0.0965093 0 - -0.37704 -0.0990906 0 -0.37674 -0.290923 0 -0.372534 -0.477358 0 -0.367167 -0.659972 0 - -0.360629 -0.839091 0 -0.352891 -1.01447 0 -0.343934 -1.18564 0 -0.333752 -1.35204 0 - -0.322354 -1.51308 0 -0.309759 -1.66818 0 -0.295997 -1.81681 0 -0.281105 -1.95841 0 - -0.265128 -2.09248 0 -0.248114 -2.21853 0 -0.230119 -2.33611 0 -0.211203 -2.44479 0 - -0.191431 -2.54417 0 -0.170874 -2.63388 0 -0.149607 -2.71358 0 -0.127708 -2.78294 0 - -0.105261 -2.84167 0 -0.0823541 -2.88947 0 -0.0590803 -2.92599 0 -0.0355442 -2.95085 0 - -0.0118622 -2.96357 0 0.0118622 -2.96357 0 0.0355442 -2.95085 0 0.0590803 -2.92599 0 - 0.0823541 -2.88947 0 0.105261 -2.84167 0 0.127708 -2.78294 0 0.149607 -2.71358 0 - 0.170874 -2.63388 0 0.191431 -2.54417 0 0.211203 -2.44479 0 0.230119 -2.33611 0 - 0.248114 -2.21853 0 0.265128 -2.09248 0 0.281105 -1.95841 0 0.295997 -1.81681 0 - 0.309759 -1.66818 0 0.322354 -1.51308 0 0.333752 -1.35204 0 0.343934 -1.18564 0 - 0.352891 -1.01447 0 0.360629 -0.839091 0 0.367167 -0.659972 0 0.372534 -0.477358 0 - 0.37674 -0.290923 0 0.37704 -0.0990906 0 0.371753 -0.10132 0 0.367611 -0.292368 0 - 0.365762 -0.478271 0 0.361834 -0.660497 0 0.356067 -0.839336 0 0.348622 -1.01452 0 - 0.339626 -1.18556 0 0.329184 -1.35186 0 0.317387 -1.51285 0 0.30432 -1.66794 0 - 0.29006 -1.81656 0 0.274687 -1.95818 0 0.258279 -2.09228 0 0.240914 -2.21838 0 - 0.222674 -2.33602 0 0.203639 -2.44476 0 0.183893 -2.54422 0 0.163521 -2.63401 0 - 0.142609 -2.7138 0 0.121246 -2.78326 0 0.0995268 -2.84209 0 0.0775496 -2.88998 0 - 0.0554174 -2.92661 0 0.0332309 -2.95158 0 0.0110681 -2.96436 0 -0.0110681 -2.96436 0 - -0.0332309 -2.95158 0 -0.0554174 -2.92661 0 -0.0775496 -2.88998 0 -0.0995268 -2.84209 0 - -0.121246 -2.78326 0 -0.142609 -2.7138 0 -0.163521 -2.63401 0 -0.183893 -2.54422 0 - -0.203639 -2.44476 0 -0.222674 -2.33602 0 -0.240914 -2.21838 0 -0.258279 -2.09228 0 - -0.274687 -1.95818 0 -0.29006 -1.81656 0 -0.30432 -1.66794 0 -0.317387 -1.51285 0 - -0.329184 -1.35186 0 -0.339626 -1.18556 0 -0.348622 -1.01452 0 -0.356067 -0.839336 0 - -0.361834 -0.660497 0 -0.365762 -0.478271 0 -0.367611 -0.292368 0 -0.371753 -0.10132 0 - 1.11475 -0.102984 0 1.10623 -0.289382 0 1.09828 -0.471458 0 1.08514 -0.650241 0 - 1.06719 -0.825884 0 1.04473 -0.998065 0 1.01797 -1.16626 0 0.987123 -1.32987 0 - 0.95237 -1.4883 0 0.913899 -1.64095 0 0.871895 -1.78728 0 0.82655 -1.92674 0 - 0.778062 -2.05882 0 0.726636 -2.18304 0 0.672485 -2.29896 0 0.61583 -2.40613 0 - 0.5569 -2.50417 0 0.495932 -2.59272 0 0.433171 -2.67142 0 0.36887 -2.73997 0 - 0.303296 -2.79808 0 0.236727 -2.84544 0 0.169453 -2.88175 0 0.101767 -2.90657 0 - 0.0339284 -2.91936 0 -0.0339284 -2.91936 0 -0.101767 -2.90657 0 -0.169453 -2.88175 0 - -0.236727 -2.84544 0 -0.303296 -2.79808 0 -0.36887 -2.73997 0 -0.433171 -2.67142 0 - -0.495932 -2.59272 0 -0.5569 -2.50417 0 -0.61583 -2.40613 0 -0.672485 -2.29896 0 - -0.726636 -2.18304 0 -0.778062 -2.05882 0 -0.82655 -1.92674 0 -0.871895 -1.78728 0 - -0.913899 -1.64095 0 -0.95237 -1.4883 0 -0.987123 -1.32987 0 -1.01797 -1.16626 0 - -1.04473 -0.998065 0 -1.06719 -0.825884 0 -1.08514 -0.650241 0 -1.09828 -0.471458 0 - -1.10623 -0.289382 0 -1.11475 -0.102984 0 1.84016 -0.103164 0 1.82727 -0.281836 0 - 1.81325 -0.457033 0 1.79115 -0.629422 0 1.76141 -0.799021 0 1.72439 -0.965446 0 - 1.68041 -1.12814 0 1.62975 -1.28648 0 1.57271 -1.43988 0 1.50955 -1.58774 0 - 1.44057 -1.72951 0 1.36606 -1.86466 0 1.28635 -1.99269 0 1.20175 -2.11314 0 - 1.1126 -2.22556 0 1.01927 -2.32954 0 0.922112 -2.42469 0 0.821522 -2.51065 0 - 0.717891 -2.5871 0 0.611632 -2.65374 0 0.503173 -2.71028 0 0.392961 -2.75646 0 - 0.281457 -2.79195 0 0.169129 -2.81635 0 0.0564086 -2.82903 0 -0.0564086 -2.82903 0 - -0.169129 -2.81635 0 -0.281457 -2.79195 0 -0.392961 -2.75646 0 -0.503173 -2.71028 0 - -0.611632 -2.65374 0 -0.717891 -2.5871 0 -0.821522 -2.51065 0 -0.922112 -2.42469 0 - -1.01927 -2.32954 0 -1.1126 -2.22556 0 -1.20175 -2.11314 0 -1.28635 -1.99269 0 - -1.36606 -1.86466 0 -1.44057 -1.72951 0 -1.50955 -1.58774 0 -1.57271 -1.43988 0 - -1.62975 -1.28648 0 -1.68041 -1.12814 0 -1.72439 -0.965446 0 -1.76141 -0.799021 0 - -1.79115 -0.629422 0 -1.81325 -0.457033 0 -1.82727 -0.281836 0 -1.84016 -0.103164 0 - 2.5366 -0.101214 0 2.51949 -0.269645 0 2.49951 -0.435214 0 2.46881 -0.598446 0 - 2.42784 -0.759284 0 2.37698 -0.917305 0 2.31661 -1.07193 0 2.2471 -1.22253 0 - 2.1688 -1.36849 0 2.08209 -1.50926 0 1.98735 -1.64427 0 1.88497 -1.77302 0 - 1.77538 -1.89503 0 1.65902 -2.00985 0 1.53635 -2.11704 0 1.40785 -2.21622 0 - 1.27402 -2.30702 0 1.13539 -2.38909 0 0.992488 -2.46213 0 0.845882 -2.52584 0 - 0.69615 -2.57998 0 0.543892 -2.62429 0 0.389727 -2.65846 0 0.234284 -2.68208 0 - 0.0781607 -2.69446 0 -0.0781607 -2.69446 0 -0.234284 -2.68208 0 -0.389727 -2.65846 0 - -0.543892 -2.62429 0 -0.69615 -2.57998 0 -0.845882 -2.52584 0 -0.992488 -2.46213 0 - -1.13539 -2.38909 0 -1.27402 -2.30702 0 -1.40785 -2.21622 0 -1.53635 -2.11704 0 - -1.65902 -2.00985 0 -1.77538 -1.89503 0 -1.88497 -1.77302 0 -1.98735 -1.64427 0 - -2.08209 -1.50926 0 -2.1688 -1.36849 0 -2.2471 -1.22253 0 -2.31661 -1.07193 0 - -2.37698 -0.917305 0 -2.42784 -0.759284 0 -2.46881 -0.598446 0 -2.49951 -0.435214 0 - -2.51949 -0.269645 0 -2.5366 -0.101214 0 3.19312 -0.0969534 0 3.17211 -0.252837 0 - 3.14639 -0.406313 0 3.1076 -0.557863 0 3.05612 -0.707417 0 2.99235 -0.854547 0 - 2.91671 -0.998666 0 2.82959 -1.13916 0 2.73144 -1.27541 0 2.62269 -1.40688 0 - 2.50381 -1.53303 0 2.3753 -1.65337 0 2.23766 -1.76745 0 2.09145 -1.87485 0 - 1.93724 -1.97515 0 1.77562 -2.068 0 1.60723 -2.15303 0 1.43271 -2.22993 0 - 1.25273 -2.29841 0 1.068 -2.35822 0 0.87923 -2.4091 0 0.68716 -2.45084 0 - 0.492557 -2.48314 0 0.296195 -2.50559 0 0.0988357 -2.51746 0 -0.0988357 -2.51746 0 - -0.296195 -2.50559 0 -0.492557 -2.48314 0 -0.68716 -2.45084 0 -0.87923 -2.4091 0 - -1.068 -2.35822 0 -1.25273 -2.29841 0 -1.43271 -2.22993 0 -1.60723 -2.15303 0 - -1.77562 -2.068 0 -1.93724 -1.97515 0 -2.09145 -1.87485 0 -2.23766 -1.76745 0 - -2.3753 -1.65337 0 -2.50381 -1.53303 0 -2.62269 -1.40688 0 -2.73144 -1.27541 0 - -2.82959 -1.13916 0 -2.91671 -0.998666 0 -2.99235 -0.854547 0 -3.05612 -0.707417 0 - -3.1076 -0.557863 0 -3.14639 -0.406313 0 -3.17211 -0.252837 0 -3.19312 -0.0969534 0 - 3.79941 -0.0904085 0 3.77492 -0.231597 0 3.74385 -0.370766 0 3.6976 -0.508369 0 - 3.63652 -0.64435 0 3.56098 -0.778306 0 3.47139 -0.909673 0 3.36821 -1.03785 0 - 3.25191 -1.16226 0 3.12298 -1.28236 0 2.98197 -1.39766 0 2.82945 -1.5077 0 - 2.66603 -1.61206 0 2.49233 -1.71034 0 2.30905 -1.80217 0 2.11688 -1.8872 0 - 1.91655 -1.96511 0 1.70885 -2.03562 0 1.49456 -2.09846 0 1.2745 -2.15338 0 - 1.04952 -2.20019 0 0.820485 -2.23865 0 0.588294 -2.26853 0 0.353858 -2.2894 0 - 0.118097 -2.30053 0 -0.118097 -2.30053 0 -0.353858 -2.2894 0 -0.588294 -2.26853 0 - -0.820485 -2.23865 0 -1.04952 -2.20019 0 -1.2745 -2.15338 0 -1.49456 -2.09846 0 - -1.70885 -2.03562 0 -1.91655 -1.96511 0 -2.11688 -1.8872 0 -2.30905 -1.80217 0 - -2.49233 -1.71034 0 -2.66603 -1.61206 0 -2.82945 -1.5077 0 -2.98197 -1.39766 0 - -3.12298 -1.28236 0 -3.25191 -1.16226 0 -3.36821 -1.03785 0 -3.47139 -0.909673 0 - -3.56098 -0.778306 0 -3.63652 -0.64435 0 -3.6976 -0.508369 0 -3.74385 -0.370766 0 - -3.77492 -0.231597 0 -3.79941 -0.0904085 0 4.34589 -0.081721 0 4.31844 -0.206264 0 - 4.28256 -0.32916 0 4.22965 -0.450814 0 4.16002 -0.57119 0 4.07402 -0.689928 0 - 3.97206 -0.806506 0 3.85459 -0.920364 0 3.72211 -1.03096 0 3.57518 -1.1378 0 - 3.41439 -1.24042 0 3.24036 -1.3384 0 3.0538 -1.43137 0 2.85541 -1.51895 0 - 2.64596 -1.60082 0 2.42625 -1.67666 0 2.19712 -1.7462 0 1.95944 -1.80915 0 - 1.71412 -1.8653 0 1.46207 -1.91443 0 1.20428 -1.95636 0 0.941708 -1.99088 0 - 0.675379 -2.01778 0 0.406329 -2.03667 0 0.135628 -2.0468 0 -0.135628 -2.0468 0 - -0.406329 -2.03667 0 -0.675379 -2.01778 0 -0.941708 -1.99088 0 -1.20428 -1.95636 0 - -1.46207 -1.91443 0 -1.71412 -1.8653 0 -1.95944 -1.80915 0 -2.19712 -1.7462 0 - -2.42625 -1.67666 0 -2.64596 -1.60082 0 -2.85541 -1.51895 0 -3.0538 -1.43137 0 - -3.24036 -1.3384 0 -3.41439 -1.24042 0 -3.57518 -1.1378 0 -3.72211 -1.03096 0 - -3.85459 -0.920364 0 -3.97206 -0.806506 0 -4.07402 -0.689928 0 -4.16002 -0.57119 0 - -4.22965 -0.450814 0 -4.28256 -0.32916 0 -4.31844 -0.206264 0 -4.34589 -0.081721 0 - 4.82393 -0.0711081 0 4.79409 -0.177301 0 4.75406 -0.282221 0 4.69542 -0.386198 0 - 4.61845 -0.489208 0 4.52348 -0.590941 0 4.41089 -0.690938 0 4.28112 -0.788696 0 - 4.1347 -0.88373 0 3.97219 -0.975594 0 3.79425 -1.06388 0 3.60155 -1.14822 0 - 3.39484 -1.22827 0 3.17491 -1.30373 0 2.94261 -1.37429 0 2.6988 -1.43968 0 - 2.44443 -1.49967 0 2.18045 -1.55402 0 1.90785 -1.60252 0 1.62767 -1.645 0 - 1.34097 -1.68129 0 1.04883 -1.71124 0 0.752363 -1.73463 0 0.45273 -1.75113 0 - 0.151134 -1.76004 0 -0.151134 -1.76004 0 -0.45273 -1.75113 0 -0.752363 -1.73463 0 - -1.04883 -1.71124 0 -1.34097 -1.68129 0 -1.62767 -1.645 0 -1.90785 -1.60252 0 - -2.18045 -1.55402 0 -2.44443 -1.49967 0 -2.6988 -1.43968 0 -2.94261 -1.37429 0 - -3.17491 -1.30373 0 -3.39484 -1.22827 0 -3.60155 -1.14822 0 -3.79425 -1.06388 0 - -3.97219 -0.975594 0 -4.1347 -0.88373 0 -4.28112 -0.788696 0 -4.41089 -0.690938 0 - -4.52348 -0.590941 0 -4.61845 -0.489208 0 -4.69542 -0.386198 0 -4.75406 -0.282221 0 - -4.79409 -0.177301 0 -4.82393 -0.0711081 0 5.22596 -0.0588431 0 5.19433 -0.145272 0 - 5.15091 -0.230795 0 5.08758 -0.315653 0 5.00461 -0.399819 0 4.90229 -0.483037 0 - 4.78096 -0.564921 0 4.64106 -0.645047 0 4.48311 -0.723002 0 4.30769 -0.798404 0 - 4.11548 -0.870912 0 3.9072 -0.940211 0 3.68364 -1.00602 0 3.44566 -1.06807 0 - 3.19415 -1.12613 0 2.93006 -1.17996 0 2.6544 -1.22936 0 2.36819 -1.27414 0 - 2.07252 -1.31413 0 1.7685 -1.34919 0 1.45728 -1.37917 0 1.14002 -1.40395 0 - 0.817926 -1.42336 0 0.492261 -1.4371 0 0.164347 -1.44456 0 -0.164347 -1.44456 0 - -0.492261 -1.4371 0 -0.817926 -1.42336 0 -1.14002 -1.40395 0 -1.45728 -1.37917 0 - -1.7685 -1.34919 0 -2.07252 -1.31413 0 -2.36819 -1.27414 0 -2.6544 -1.22936 0 - -2.93006 -1.17996 0 -3.19415 -1.12613 0 -3.44566 -1.06807 0 -3.68364 -1.00602 0 - -3.9072 -0.940211 0 -4.11548 -0.870912 0 -4.30769 -0.798404 0 -4.48311 -0.723002 0 - -4.64106 -0.645047 0 -4.78096 -0.564921 0 -4.90229 -0.483037 0 -5.00461 -0.399819 0 - -5.08758 -0.315653 0 -5.15091 -0.230795 0 -5.19433 -0.145272 0 -5.22596 -0.0588431 0 - 5.54559 -0.0452414 0 5.51276 -0.110817 0 5.46676 -0.175827 0 5.39988 -0.240416 0 - 5.31235 -0.30455 0 5.20439 -0.368028 0 5.07634 -0.430549 0 4.9286 -0.49178 0 - 4.76168 -0.551394 0 4.57617 -0.609093 0 4.37277 -0.664606 0 4.15222 -0.717689 0 - 3.91535 -0.768119 0 3.66306 -0.815692 0 3.39629 -0.86022 0 3.11604 -0.901527 0 - 2.82337 -0.939452 0 2.51938 -0.973849 0 2.20522 -1.00459 0 1.88206 -1.03155 0 - 1.55111 -1.05464 0 1.21362 -1.07374 0 0.870872 -1.08874 0 0.524195 -1.09938 0 - 0.175023 -1.10519 0 -0.175023 -1.10519 0 -0.524195 -1.09938 0 -0.870872 -1.08874 0 - -1.21362 -1.07374 0 -1.55111 -1.05464 0 -1.88206 -1.03155 0 -2.20522 -1.00459 0 - -2.51938 -0.973849 0 -2.82337 -0.939452 0 -3.11604 -0.901527 0 -3.39629 -0.86022 0 - -3.66306 -0.815692 0 -3.91535 -0.768119 0 -4.15222 -0.717689 0 -4.37277 -0.664606 0 - -4.57617 -0.609093 0 -4.76168 -0.551394 0 -4.9286 -0.49178 0 -5.07634 -0.430549 0 - -5.20439 -0.368028 0 -5.31235 -0.30455 0 -5.39988 -0.240416 0 -5.46676 -0.175827 0 - -5.51276 -0.110817 0 -5.54559 -0.0452414 0 5.77772 -0.0306487 0 5.74423 -0.074623 0 - 5.69652 -0.118315 0 5.62726 -0.161785 0 5.53661 -0.204996 0 5.42479 -0.247804 0 - 5.29207 -0.290001 0 5.13884 -0.331358 0 4.96559 -0.37165 0 4.77293 -0.410669 0 - 4.56153 -0.448229 0 4.33218 -0.484162 0 4.08571 -0.518315 0 3.82306 -0.550547 0 - 3.5452 -0.58073 0 3.25317 -0.608742 0 2.94807 -0.634473 0 2.63105 -0.657822 0 - 2.3033 -0.678698 0 1.96605 -0.697024 0 1.62056 -0.712726 0 1.26813 -0.725738 0 - 0.910103 -0.735966 0 0.547867 -0.743245 0 0.182939 -0.747229 0 -0.182939 -0.747229 0 - -0.547867 -0.743245 0 -0.910103 -0.735966 0 -1.26813 -0.725738 0 -1.62056 -0.712726 0 - -1.96605 -0.697024 0 -2.3033 -0.678698 0 -2.63105 -0.657822 0 -2.94807 -0.634473 0 - -3.25317 -0.608742 0 -3.5452 -0.58073 0 -3.82306 -0.550547 0 -4.08571 -0.518315 0 - -4.33218 -0.484162 0 -4.56153 -0.448229 0 -4.77293 -0.410669 0 -4.96559 -0.37165 0 - -5.13884 -0.331358 0 -5.29207 -0.290001 0 -5.42479 -0.247804 0 -5.53661 -0.204996 0 - -5.62726 -0.161785 0 -5.69652 -0.118315 0 -5.74423 -0.074623 0 -5.77772 -0.0306487 0 - 5.9186 -0.0154254 0 5.88491 -0.0373806 0 5.83632 -0.0592548 0 5.76579 -0.081052 0 - 5.67344 -0.102743 0 5.55946 -0.12425 0 5.42409 -0.145466 0 5.2677 -0.166274 0 - 5.09077 -0.186559 0 4.89389 -0.206215 0 4.67775 -0.225147 0 4.44313 -0.243269 0 - 4.19089 -0.260504 0 3.92197 -0.276779 0 3.63736 -0.292029 0 3.33814 -0.306192 0 - 3.02542 -0.31921 0 2.70039 -0.33103 0 2.36426 -0.341606 0 2.01829 -0.350897 0 - 1.66379 -0.358864 0 1.30209 -0.365471 0 0.934556 -0.370671 0 0.562631 -0.374378 0 - 0.187877 -0.376413 0 -0.187877 -0.376413 0 -0.562631 -0.374378 0 -0.934556 -0.370671 0 - -1.30209 -0.365471 0 -1.66379 -0.358864 0 -2.01829 -0.350897 0 -2.36426 -0.341606 0 - -2.70039 -0.33103 0 -3.02542 -0.31921 0 -3.33814 -0.306192 0 -3.63736 -0.292029 0 - -3.92197 -0.276779 0 -4.19089 -0.260504 0 -4.44313 -0.243269 0 -4.67775 -0.225147 0 - -4.89389 -0.206215 0 -5.09077 -0.186559 0 -5.2677 -0.166274 0 -5.42409 -0.145466 0 - -5.55946 -0.12425 0 -5.67344 -0.102743 0 -5.76579 -0.081052 0 -5.83632 -0.0592548 0 - -5.88491 -0.0373806 0 -5.9186 -0.0154254 0 5.96589 8.40442e-05 0 5.93226 0.000292989 0 - 5.88346 0.000466106 0 5.8126 0.000613726 0 5.71979 0.000743168 0 5.60518 0.000858883 0 - 5.46901 0.000962992 0 5.31164 0.00105598 0 5.13354 0.00113734 0 4.93531 0.00120614 0 - 4.71762 0.00126142 0 4.48126 0.00130249 0 4.22709 0.00132907 0 3.95607 0.00134144 0 - 3.66918 0.0013404 0 3.36752 0.00132733 0 3.0522 0.00130407 0 2.72442 0.00127291 0 - 2.3854 0.00123648 0 2.03643 0.0011976 0 1.67882 0.00115924 0 1.3139 0.00112425 0 - 0.94307 0.00109528 0 0.567775 0.00107455 0 0.189599 0.00106371 0 -0.189599 0.00106371 0 - -0.567775 0.00107455 0 -0.94307 0.00109528 0 -1.3139 0.00112425 0 -1.67882 0.00115924 0 - -2.03643 0.0011976 0 -2.3854 0.00123648 0 -2.72442 0.00127291 0 -3.0522 0.00130407 0 - -3.36752 0.00132733 0 -3.66918 0.0013404 0 -3.95607 0.00134144 0 -4.22709 0.00132907 0 - -4.48126 0.00130249 0 -4.71762 0.00126142 0 -4.93531 0.00120614 0 -5.13354 0.00113734 0 - -5.31164 0.00105598 0 -5.46901 0.000962992 0 -5.60518 0.000858883 0 -5.71979 0.000743168 0 - -5.8126 0.000613726 0 -5.88346 0.000466106 0 -5.93226 0.000292989 0 -5.96589 8.40442e-05 0 - 5.9187 0.0155937 0 5.88512 0.0379656 0 5.83653 0.0601854 0 5.766 0.0822782 0 - 5.67367 0.104229 0 5.55968 0.12597 0 5.4243 0.147397 0 5.2679 0.168394 0 - 5.09096 0.188844 0 4.89405 0.208639 0 4.67789 0.227683 0 4.44324 0.245888 0 - 4.19097 0.263176 0 3.92202 0.279476 0 3.63738 0.294723 0 3.33814 0.308858 0 - 3.0254 0.321827 0 2.70035 0.333583 0 2.36421 0.344084 0 2.01823 0.353293 0 - 1.66373 0.361181 0 1.30204 0.367715 0 0.934516 0.372855 0 0.562605 0.37652 0 - 0.187868 0.378531 0 -0.187868 0.378531 0 -0.562605 0.37652 0 -0.934516 0.372855 0 - -1.30204 0.367715 0 -1.66373 0.361181 0 -2.01823 0.353293 0 -2.36421 0.344084 0 - -2.70035 0.333583 0 -3.0254 0.321827 0 -3.33814 0.308858 0 -3.63738 0.294723 0 - -3.92202 0.279476 0 -4.19097 0.263176 0 -4.44324 0.245888 0 -4.67789 0.227683 0 - -4.89405 0.208639 0 -5.09096 0.188844 0 -5.2679 0.168394 0 -5.4243 0.147397 0 - -5.55968 0.12597 0 -5.67367 0.104229 0 -5.766 0.0822782 0 -5.83653 0.0601854 0 - -5.88512 0.0379656 0 -5.9187 0.0155937 0 5.77793 0.0308172 0 5.74466 0.0752036 0 - 5.69696 0.11924 0 5.62771 0.163007 0 5.53706 0.206482 0 5.42524 0.24953 0 - 5.2925 0.291946 0 5.13925 0.333499 0 4.96597 0.373964 0 4.77326 0.413129 0 - 4.56182 0.450806 0 4.3324 0.486825 0 4.08588 0.521032 0 3.82317 0.553288 0 - 3.54525 0.583464 0 3.25317 0.611444 0 2.94803 0.63712 0 2.63097 0.660396 0 - 2.3032 0.681189 0 1.96593 0.699425 0 1.62044 0.715039 0 1.26803 0.727969 0 - 0.91002 0.73813 0 0.547814 0.745361 0 0.18292 0.74932 0 -0.18292 0.74932 0 - -0.547814 0.745361 0 -0.91002 0.73813 0 -1.26803 0.727969 0 -1.62044 0.715039 0 - -1.96593 0.699425 0 -2.3032 0.681189 0 -2.63097 0.660396 0 -2.94803 0.63712 0 - -3.25317 0.611444 0 -3.54525 0.583464 0 -3.82317 0.553288 0 -4.08588 0.521032 0 - -4.3324 0.486825 0 -4.56182 0.450806 0 -4.77326 0.413129 0 -4.96597 0.373964 0 - -5.13925 0.333499 0 -5.2925 0.291946 0 -5.42524 0.24953 0 -5.53706 0.206482 0 - -5.62771 0.163007 0 -5.69696 0.11924 0 -5.74466 0.0752036 0 -5.77793 0.0308172 0 - 5.54591 0.0454094 0 5.51341 0.111388 0 5.46743 0.176738 0 5.40057 0.241626 0 - 5.31304 0.306033 0 5.20508 0.369763 0 5.07701 0.432517 0 4.92924 0.493958 0 - 4.76226 0.553759 0 4.57669 0.611615 0 4.3732 0.667253 0 4.15257 0.720426 0 - 3.91561 0.770913 0 3.66322 0.818508 0 3.39636 0.863024 0 3.11603 0.904291 0 - 2.8233 0.94215 0 2.51925 0.976462 0 2.20505 1.0071 0 1.88187 1.03396 0 - 1.55092 1.05694 0 1.21345 1.07595 0 0.870739 1.09087 0 0.524109 1.10146 0 - 0.174993 1.10723 0 -0.174993 1.10723 0 -0.524109 1.10146 0 -0.870739 1.09087 0 - -1.21345 1.07595 0 -1.55092 1.05694 0 -1.88187 1.03396 0 -2.20505 1.0071 0 - -2.51925 0.976462 0 -2.8233 0.94215 0 -3.11603 0.904291 0 -3.39636 0.863024 0 - -3.66322 0.818508 0 -3.91561 0.770913 0 -4.15257 0.720426 0 -4.3732 0.667253 0 - -4.57669 0.611615 0 -4.76226 0.553759 0 -4.92924 0.493958 0 -5.07701 0.432517 0 - -5.20508 0.369763 0 -5.31304 0.306033 0 -5.40057 0.241626 0 -5.46743 0.176738 0 - -5.51341 0.111388 0 -5.54591 0.0454094 0 5.22639 0.0590089 0 5.19521 0.145824 0 - 5.15181 0.231681 0 5.08852 0.316842 0 5.00557 0.401294 0 4.90324 0.484782 0 - 4.78189 0.566921 0 4.64194 0.64728 0 4.48391 0.725441 0 4.3084 0.801017 0 - 4.11608 0.873662 0 3.90767 0.943059 0 3.68399 1.00892 0 3.44587 1.071 0 - 3.19424 1.12903 0 2.93004 1.18281 0 2.65428 1.23213 0 2.36799 1.27681 0 - 2.07227 1.31668 0 1.76823 1.35161 0 1.457 1.38147 0 1.13977 1.40613 0 - 0.817731 1.42544 0 0.492135 1.43911 0 0.164303 1.44653 0 -0.164303 1.44653 0 - -0.492135 1.43911 0 -0.817731 1.42544 0 -1.13977 1.40613 0 -1.457 1.38147 0 - -1.76823 1.35161 0 -2.07227 1.31668 0 -2.36799 1.27681 0 -2.65428 1.23213 0 - -2.93004 1.18281 0 -3.19424 1.12903 0 -3.44587 1.071 0 -3.68399 1.00892 0 - -3.90767 0.943059 0 -4.11608 0.873662 0 -4.3084 0.801017 0 -4.48391 0.725441 0 - -4.64194 0.64728 0 -4.78189 0.566921 0 -4.90324 0.484782 0 -5.00557 0.401294 0 - -5.08852 0.316842 0 -5.15181 0.231681 0 -5.19521 0.145824 0 -5.22639 0.0590089 0 - 4.82448 0.0712683 0 4.7952 0.177819 0 4.75522 0.283063 0 4.69663 0.38735 0 - 4.61969 0.490666 0 4.52473 0.592698 0 4.4121 0.692981 0 4.28227 0.791003 0 - 4.13575 0.886272 0 3.97311 0.978332 0 3.79501 1.06677 0 3.60215 1.15122 0 - 3.39527 1.23133 0 3.17517 1.3068 0 2.9427 1.37733 0 2.69875 1.44266 0 - 2.44424 1.50254 0 2.18016 1.55676 0 1.90749 1.60511 0 1.62728 1.64743 0 - 1.34058 1.68357 0 1.04848 1.71337 0 0.752087 1.73664 0 0.452552 1.75304 0 - 0.151072 1.76191 0 -0.151072 1.76191 0 -0.452552 1.75304 0 -0.752087 1.73664 0 - -1.04848 1.71337 0 -1.34058 1.68357 0 -1.62728 1.64743 0 -1.90749 1.60511 0 - -2.18016 1.55676 0 -2.44424 1.50254 0 -2.69875 1.44266 0 -2.9427 1.37733 0 - -3.17517 1.3068 0 -3.39527 1.23133 0 -3.60215 1.15122 0 -3.79501 1.06677 0 - -3.97311 0.978332 0 -4.13575 0.886272 0 -4.28227 0.791003 0 -4.4121 0.692981 0 - -4.52473 0.592698 0 -4.61969 0.490666 0 -4.69663 0.38735 0 -4.75522 0.283063 0 - -4.7952 0.177819 0 -4.82448 0.0712683 0 4.34654 0.081869 0 4.31978 0.206726 0 - 4.28398 0.329931 0 4.23115 0.451906 0 4.16158 0.572618 0 4.0756 0.691696 0 - 3.9736 0.808606 0 3.85604 0.922771 0 3.72343 1.03364 0 3.57633 1.1407 0 - 3.41533 1.24349 0 3.2411 1.3416 0 3.05431 1.43463 0 2.8557 1.52222 0 - 2.64604 1.60404 0 2.42614 1.6798 0 2.19684 1.7492 0 1.95904 1.812 0 - 1.71362 1.86796 0 1.46154 1.91689 0 1.20374 1.95861 0 0.941227 1.99294 0 - 0.674996 2.01968 0 0.406083 2.03845 0 0.135543 2.04852 0 -0.135543 2.04852 0 - -0.406083 2.03845 0 -0.674996 2.01968 0 -0.941227 1.99294 0 -1.20374 1.95861 0 - -1.46154 1.91689 0 -1.71362 1.86796 0 -1.95904 1.812 0 -2.19684 1.7492 0 - -2.42614 1.6798 0 -2.64604 1.60404 0 -2.8557 1.52222 0 -3.05431 1.43463 0 - -3.2411 1.3416 0 -3.41533 1.24349 0 -3.57633 1.1407 0 -3.72343 1.03364 0 - -3.85604 0.922771 0 -3.9736 0.808606 0 -4.0756 0.691696 0 -4.16158 0.572618 0 - -4.23115 0.451906 0 -4.28398 0.329931 0 -4.31978 0.206726 0 -4.34654 0.081869 0 - 3.80017 0.0905321 0 3.77649 0.231966 0 3.74556 0.371421 0 3.69944 0.509364 0 - 3.63845 0.645729 0 3.56293 0.780086 0 3.4733 0.911847 0 3.37 1.04039 0 - 3.25352 1.16511 0 3.12437 1.28548 0 2.98311 1.40097 0 2.83032 1.51115 0 - 2.66661 1.61557 0 2.49264 1.71385 0 2.30909 1.80562 0 2.11668 1.89053 0 - 1.91616 1.96828 0 1.70829 2.03859 0 1.49389 2.10119 0 1.27377 2.15586 0 - 1.0488 2.2024 0 0.819834 2.24063 0 0.587775 2.27029 0 0.353522 2.29101 0 - 0.117981 2.30204 0 -0.117981 2.30204 0 -0.353522 2.29101 0 -0.587775 2.27029 0 - -0.819834 2.24063 0 -1.0488 2.2024 0 -1.27377 2.15586 0 -1.49389 2.10119 0 - -1.70829 2.03859 0 -1.91616 1.96828 0 -2.11668 1.89053 0 -2.30909 1.80562 0 - -2.49264 1.71385 0 -2.66661 1.61557 0 -2.83032 1.51115 0 -2.98311 1.40097 0 - -3.12437 1.28548 0 -3.25352 1.16511 0 -3.37 1.04039 0 -3.4733 0.911847 0 - -3.56293 0.780086 0 -3.63845 0.645729 0 -3.69944 0.509364 0 -3.74556 0.371421 0 - -3.77649 0.231966 0 -3.80017 0.0905321 0 3.19398 0.0970283 0 3.17392 0.253048 0 - 3.14841 0.406783 0 3.10982 0.558712 0 3.05847 0.708724 0 2.99474 0.856342 0 - 2.91903 1.00094 0 2.83176 1.14186 0 2.73338 1.2785 0 2.62435 1.41026 0 - 2.50516 1.53664 0 2.3763 1.65713 0 2.23832 1.77128 0 2.09177 1.87867 0 - 1.93724 1.97889 0 1.77533 2.07158 0 1.60669 2.15641 0 1.43196 2.23305 0 - 1.25185 2.30124 0 1.06705 2.36072 0 0.87828 2.41128 0 0.6863 2.45269 0 - 0.491866 2.48471 0 0.295746 2.50695 0 0.0986799 2.51871 0 -0.0986799 2.51871 0 - -0.295746 2.50695 0 -0.491866 2.48471 0 -0.6863 2.45269 0 -0.87828 2.41128 0 - -1.06705 2.36072 0 -1.25185 2.30124 0 -1.43196 2.23305 0 -1.60669 2.15641 0 - -1.77533 2.07158 0 -1.93724 1.97889 0 -2.09177 1.87867 0 -2.23832 1.77128 0 - -2.3763 1.65713 0 -2.50516 1.53664 0 -2.62435 1.41026 0 -2.73338 1.2785 0 - -2.83176 1.14186 0 -2.91903 1.00094 0 -2.99474 0.856342 0 -3.05847 0.708724 0 - -3.10982 0.558712 0 -3.14841 0.406783 0 -3.17392 0.253048 0 -3.19398 0.0970283 0 - 2.53754 0.101188 0 2.52155 0.269593 0 2.5019 0.435403 0 2.47149 0.599089 0 - 2.43068 0.7605 0 2.37986 0.919128 0 2.31939 1.07433 0 2.24967 1.22545 0 - 2.17109 1.37186 0 2.08404 1.51298 0 1.98891 1.64825 0 1.88613 1.77716 0 - 1.77613 1.89923 0 1.65937 2.01403 0 1.53632 2.12112 0 1.40747 2.22011 0 - 1.27334 2.31065 0 1.13446 2.39241 0 0.99139 2.46507 0 0.844691 2.52839 0 - 0.694958 2.58211 0 0.542801 2.626 0 0.388844 2.6598 0 0.233706 2.68313 0 - 0.0779589 2.69534 0 -0.0779589 2.69534 0 -0.233706 2.68313 0 -0.388844 2.6598 0 - -0.542801 2.626 0 -0.694958 2.58211 0 -0.844691 2.52839 0 -0.99139 2.46507 0 - -1.13446 2.39241 0 -1.27334 2.31065 0 -1.40747 2.22011 0 -1.53632 2.12112 0 - -1.65937 2.01403 0 -1.77613 1.89923 0 -1.88613 1.77716 0 -1.98891 1.64825 0 - -2.08404 1.51298 0 -2.17109 1.37186 0 -2.24967 1.22545 0 -2.31939 1.07433 0 - -2.37986 0.919128 0 -2.43068 0.7605 0 -2.47149 0.599089 0 -2.5019 0.435403 0 - -2.52155 0.269593 0 -2.53754 0.101188 0 1.84122 0.102892 0 1.82964 0.281367 0 - 1.81609 0.456835 0 1.79434 0.629813 0 1.76477 0.800148 0 1.72775 0.96733 0 - 1.68362 1.13073 0 1.63271 1.28969 0 1.57533 1.44359 0 1.51177 1.59185 0 - 1.44236 1.73391 0 1.3674 1.86923 0 1.28723 1.99733 0 1.20219 2.11774 0 - 1.11262 2.23002 0 1.0189 2.33377 0 0.921402 2.42861 0 0.82053 2.51419 0 - 0.71669 2.5902 0 0.610308 2.65635 0 0.501827 2.71237 0 0.391709 2.75802 0 - 0.280426 2.79302 0 0.168445 2.81702 0 0.0561679 2.82947 0 -0.0561679 2.82947 0 - -0.168445 2.81702 0 -0.280426 2.79302 0 -0.391709 2.75802 0 -0.501827 2.71237 0 - -0.610308 2.65635 0 -0.71669 2.5902 0 -0.82053 2.51419 0 -0.921402 2.42861 0 - -1.0189 2.33377 0 -1.11262 2.23002 0 -1.20219 2.11774 0 -1.28723 1.99733 0 - -1.3674 1.86923 0 -1.44236 1.73391 0 -1.51177 1.59185 0 -1.57533 1.44359 0 - -1.63271 1.28969 0 -1.68362 1.13073 0 -1.72775 0.96733 0 -1.76477 0.800148 0 - -1.79434 0.629813 0 -1.81609 0.456835 0 -1.82964 0.281367 0 -1.84122 0.102892 0 - 1.11611 0.101954 0 1.1092 0.288401 0 1.10168 0.470871 0 1.08878 0.650424 0 - 1.0709 0.826983 0 1.04835 1.00007 0 1.02139 1.16908 0 0.990256 1.33338 0 - 0.955162 1.49238 0 0.91631 1.64547 0 0.873898 1.79211 0 0.828132 1.93175 0 - 0.77922 2.06389 0 0.727378 2.18806 0 0.67283 2.30381 0 0.615806 2.41073 0 - 0.556544 2.50841 0 0.49529 2.59652 0 0.432301 2.67471 0 0.367842 2.74268 0 - 0.302197 2.80016 0 0.235661 2.84688 0 0.168544 2.88256 0 0.101146 2.90687 0 - 0.0337062 2.91935 0 -0.0337062 2.91935 0 -0.101146 2.90687 0 -0.168544 2.88256 0 - -0.235661 2.84688 0 -0.302197 2.80016 0 -0.367842 2.74268 0 -0.432301 2.67471 0 - -0.49529 2.59652 0 -0.556544 2.50841 0 -0.615806 2.41073 0 -0.67283 2.30381 0 - -0.727378 2.18806 0 -0.77922 2.06389 0 -0.828132 1.93175 0 -0.873898 1.79211 0 - -0.91631 1.64547 0 -0.955162 1.49238 0 -0.990256 1.33338 0 -1.02139 1.16908 0 - -1.04835 1.00007 0 -1.0709 0.826983 0 -1.08878 0.650424 0 -1.10168 0.470871 0 - -1.1092 0.288401 0 -1.11611 0.101954 0 0.374399 0.0973588 0 0.37235 0.286087 0 - 0.369716 0.471912 0 0.365394 0.65524 0 0.35933 0.835701 0 0.351638 1.01271 0 - 0.342428 1.18561 0 0.331795 1.35377 0 0.319821 1.51654 0 0.306583 1.67331 0 - 0.292156 1.82349 0 0.276617 1.96649 0 0.260041 2.10179 0 0.242509 2.22888 0 - 0.2241 2.34728 0 0.204895 2.45653 0 0.184977 2.55624 0 0.164433 2.646 0 - 0.143349 2.72549 0 0.121818 2.79439 0 0.0999383 2.85242 0 0.0778155 2.89932 0 - 0.0555634 2.93487 0 0.0332935 2.95883 0 0.0110837 2.97095 0 -0.0110837 2.97095 0 - -0.0332935 2.95883 0 -0.0555634 2.93487 0 -0.0778155 2.89932 0 -0.0999383 2.85242 0 - -0.121818 2.79439 0 -0.143349 2.72549 0 -0.164433 2.646 0 -0.184977 2.55624 0 - -0.204895 2.45653 0 -0.2241 2.34728 0 -0.242509 2.22888 0 -0.260041 2.10179 0 - -0.276617 1.96649 0 -0.292156 1.82349 0 -0.306583 1.67331 0 -0.319821 1.51654 0 - -0.331795 1.35377 0 -0.342428 1.18561 0 -0.351638 1.01271 0 -0.35933 0.835701 0 - -0.365394 0.65524 0 -0.369716 0.471912 0 -0.37235 0.286087 0 -0.374399 0.0973588 0 + -0.377844 0.094245 0 -0.381717 0.281191 0 -0.383961 0.466527 0 -0.38441 0.649769 0 + -0.382989 0.830337 0 -0.379668 1.00759 0 -0.374435 1.18087 0 -0.367291 1.34952 0 + -0.358248 1.51289 0 -0.347331 1.67034 0 -0.33458 1.82126 0 -0.320044 1.96507 0 + -0.30379 2.1012 0 -0.285895 2.22912 0 -0.266447 2.34833 0 -0.245549 2.45834 0 + -0.223311 2.55874 0 -0.199858 2.64911 0 -0.175321 2.7291 0 -0.149842 2.79838 0 + -0.123575 2.85667 0 -0.0966791 2.9037 0 -0.0693241 2.93927 0 -0.0416809 2.96317 0 + -0.0139043 2.97523 0 0.0139043 2.97523 0 0.0416809 2.96317 0 0.0693241 2.93927 0 + 0.0966791 2.9037 0 0.123575 2.85667 0 0.149842 2.79838 0 0.175321 2.7291 0 + 0.199858 2.64911 0 0.223311 2.55874 0 0.245549 2.45834 0 0.266447 2.34833 0 + 0.285895 2.22912 0 0.30379 2.1012 0 0.320044 1.96507 0 0.33458 1.82126 0 + 0.347331 1.67034 0 0.358248 1.51289 0 0.367291 1.34952 0 0.374435 1.18087 0 + 0.379668 1.00759 0 0.382989 0.830337 0 0.38441 0.649769 0 0.383961 0.466527 0 + 0.381717 0.281191 0 0.377844 0.094245 0 -1.12067 0.0939817 0 -1.11866 0.27895 0 + -1.11254 0.461171 0 -1.10213 0.640895 0 -1.08723 0.817825 0 -1.06785 0.991438 0 + -1.04403 1.16113 0 -1.01585 1.32629 0 -0.983392 1.48629 0 -0.946778 1.64053 0 + -0.906135 1.78842 0 -0.861617 1.9294 0 -0.813397 2.06291 0 -0.761667 2.18845 0 + -0.706644 2.30552 0 -0.648562 2.41367 0 -0.587672 2.51247 0 -0.52425 2.60152 0 + -0.458585 2.68047 0 -0.390988 2.74899 0 -0.32179 2.80679 0 -0.25134 2.8536 0 + -0.18 2.88918 0 -0.108132 2.91326 0 -0.0360555 2.92555 0 0.0360555 2.92555 0 + 0.108132 2.91326 0 0.18 2.88918 0 0.25134 2.8536 0 0.32179 2.80679 0 + 0.390988 2.74899 0 0.458585 2.68047 0 0.52425 2.60152 0 0.587672 2.51247 0 + 0.648562 2.41367 0 0.706644 2.30552 0 0.761667 2.18845 0 0.813397 2.06291 0 + 0.861617 1.9294 0 0.906135 1.78842 0 0.946778 1.64053 0 0.983392 1.48629 0 + 1.01585 1.32629 0 1.04403 1.16113 0 1.06785 0.991438 0 1.08723 0.817825 0 + 1.10213 0.640895 0 1.11254 0.461171 0 1.11866 0.27895 0 1.12067 0.0939817 0 + -1.84515 0.0917879 0 -1.83712 0.271878 0 -1.82346 0.448469 0 -1.80266 0.622384 0 + -1.77473 0.79351 0 -1.73975 0.961388 0 -1.69783 1.12545 0 -1.64914 1.2851 0 + -1.59384 1.43973 0 -1.53215 1.58878 0 -1.46428 1.73167 0 -1.3905 1.86786 0 + -1.3111 1.99683 0 -1.22638 2.11809 0 -1.13668 2.23117 0 -1.04236 2.33563 0 + -0.943817 2.43108 0 -0.841459 2.51713 0 -0.735727 2.59346 0 -0.627084 2.65976 0 + -0.516019 2.71575 0 -0.403044 2.76121 0 -0.288686 2.79587 0 -0.173468 2.81948 0 + -0.0578537 2.83164 0 0.0578537 2.83164 0 0.173468 2.81948 0 0.288686 2.79587 0 + 0.403044 2.76121 0 0.516019 2.71575 0 0.627084 2.65976 0 0.735727 2.59346 0 + 0.841459 2.51713 0 0.943817 2.43108 0 1.04236 2.33563 0 1.13668 2.23117 0 + 1.22638 2.11809 0 1.3111 1.99683 0 1.3905 1.86786 0 1.46428 1.73167 0 + 1.53215 1.58878 0 1.59384 1.43973 0 1.64914 1.2851 0 1.69783 1.12545 0 + 1.73975 0.961388 0 1.77473 0.79351 0 1.80266 0.622384 0 1.82346 0.448469 0 + 1.83712 0.271878 0 1.84515 0.0917879 0 -2.54033 0.0876145 0 -2.52653 0.259136 0 + -2.50615 0.427168 0 -2.47585 0.592587 0 -2.43579 0.755324 0 -2.38616 0.914958 0 + -2.32714 1.07095 0 -2.25898 1.22274 0 -2.18193 1.36975 0 -2.09629 1.51143 0 + -2.00239 1.64725 0 -1.90058 1.77669 0 -1.79128 1.89928 0 -1.67489 2.01453 0 + -1.55188 2.12201 0 -1.42274 2.22132 0 -1.28798 2.31208 0 -1.14816 2.39394 0 + -1.00384 2.4666 0 -0.855641 2.52977 0 -0.704184 2.58322 0 -0.55013 2.62671 0 + -0.394152 2.66003 0 -0.236915 2.68287 0 -0.0790321 2.69475 0 0.0790321 2.69475 0 + 0.236915 2.68287 0 0.394152 2.66003 0 0.55013 2.62671 0 0.704184 2.58322 0 + 0.855641 2.52977 0 1.00384 2.4666 0 1.14816 2.39394 0 1.28798 2.31208 0 + 1.42274 2.22132 0 1.55188 2.12201 0 1.67489 2.01453 0 1.79128 1.89928 0 + 1.90058 1.77669 0 2.00239 1.64725 0 2.09629 1.51143 0 2.18193 1.36975 0 + 2.25898 1.22274 0 2.32714 1.07095 0 2.38616 0.914958 0 2.43579 0.755324 0 + 2.47585 0.592587 0 2.50615 0.427168 0 2.52653 0.259136 0 2.54033 0.0876145 0 + -3.19543 0.0816691 0 -3.17629 0.24147 0 -3.15 0.398161 0 -3.11118 0.552475 0 + -3.06011 0.704313 0 -2.99705 0.853268 0 -2.92225 0.998831 0 -2.83603 1.14047 0 + -2.73872 1.27765 0 -2.63071 1.40987 0 -2.51243 1.53662 0 -2.38432 1.65742 0 + -2.2469 1.77182 0 -2.10069 1.87939 0 -1.94627 1.97972 0 -1.78425 2.07245 0 + -1.61526 2.15721 0 -1.43998 2.23371 0 -1.25911 2.30165 0 -1.07339 2.3608 0 + -0.883572 2.41092 0 -0.690453 2.45184 0 -0.494836 2.48331 0 -0.297521 2.50504 0 + -0.099269 2.51645 0 0.099269 2.51645 0 0.297521 2.50504 0 0.494836 2.48331 0 + 0.690453 2.45184 0 0.883572 2.41092 0 1.07339 2.3608 0 1.25911 2.30165 0 + 1.43998 2.23371 0 1.61526 2.15721 0 1.78425 2.07245 0 1.94627 1.97972 0 + 2.10069 1.87939 0 2.2469 1.77182 0 2.38432 1.65742 0 2.51243 1.53662 0 + 2.63071 1.40987 0 2.73872 1.27765 0 2.83603 1.14047 0 2.92225 0.998831 0 + 2.99705 0.853268 0 3.06011 0.704313 0 3.11118 0.552475 0 3.15 0.398161 0 + 3.17629 0.24147 0 3.19543 0.0816691 0 -3.80023 0.0741908 0 -3.77631 0.219548 0 + -3.74488 0.362362 0 -3.69856 0.503137 0 -3.63769 0.64171 0 -3.56256 0.77768 0 + -3.47351 0.910572 0 -3.37091 1.0399 0 -3.25515 1.16517 0 -3.12671 1.28591 0 + -2.98608 1.40167 0 -2.83382 1.51201 0 -2.67053 1.61651 0 -2.49683 1.71479 0 + -2.31341 1.80648 0 -2.12098 1.89124 0 -1.92029 1.96875 0 -1.71213 2.03873 0 + -1.49732 2.10094 0 -1.27671 2.15517 0 -1.05119 2.20121 0 -0.82165 2.23889 0 + -0.589027 2.26801 0 -0.354246 2.28824 0 -0.118216 2.29897 0 0.118216 2.29897 0 + 0.354246 2.28824 0 0.589027 2.26801 0 0.82165 2.23889 0 1.05119 2.20121 0 + 1.27671 2.15517 0 1.49732 2.10094 0 1.71213 2.03873 0 1.92029 1.96875 0 + 2.12098 1.89124 0 2.31341 1.80648 0 2.49683 1.71479 0 2.67053 1.61651 0 + 2.83382 1.51201 0 2.98608 1.40167 0 3.12671 1.28591 0 3.25515 1.16517 0 + 3.37091 1.0399 0 3.47351 0.910572 0 3.56256 0.77768 0 3.63769 0.64171 0 + 3.69856 0.503137 0 3.74488 0.362362 0 3.77631 0.219548 0 3.80023 0.0741908 0 + -4.34527 0.0654223 0 -4.31725 0.194007 0 -4.28146 0.320691 0 -4.22869 0.445717 0 + -4.15929 0.568855 0 -4.07359 0.689718 0 -3.97198 0.807871 0 -3.85486 0.922871 0 + -3.72271 1.03428 0 -3.57605 1.14169 0 -3.41545 1.24467 0 -3.24155 1.34285 0 + -3.05503 1.43585 0 -2.8566 1.52333 0 -2.64704 1.60496 0 -2.42716 1.68044 0 + -2.19782 1.7495 0 -1.95989 1.81189 0 -1.71432 1.8674 0 -1.46204 1.91583 0 + -1.20406 1.95704 0 -0.941382 1.99085 0 -0.675035 2.01708 0 -0.406066 2.03542 0 + -0.135529 2.04522 0 0.135529 2.04522 0 0.406066 2.03542 0 0.675035 2.01708 0 + 0.941382 1.99085 0 1.20406 1.95704 0 1.46204 1.91583 0 1.71432 1.8674 0 + 1.95989 1.81189 0 2.19782 1.7495 0 2.42716 1.68044 0 2.64704 1.60496 0 + 2.8566 1.52333 0 3.05503 1.43585 0 3.24155 1.34285 0 3.41545 1.24467 0 + 3.57605 1.14169 0 3.72271 1.03428 0 3.85486 0.922871 0 3.97198 0.807871 0 + 4.07359 0.689718 0 4.15929 0.568855 0 4.22869 0.445717 0 4.28146 0.320691 0 + 4.31725 0.194007 0 4.34527 0.0654223 0 -4.82204 0.0556159 0 -4.7907 0.165479 0 + -4.75135 0.274081 0 -4.6932 0.381406 0 -4.61662 0.487178 0 -4.52195 0.591035 0 + -4.4096 0.692589 0 -4.28002 0.791455 0 -4.13373 0.887256 0 -3.9713 0.979626 0 + -3.79338 1.06821 0 -3.60066 1.15268 0 -3.39388 1.23272 0 -3.17386 1.30801 0 + -2.94143 1.37829 0 -2.6975 1.4433 0 -2.443 1.5028 0 -2.17892 1.55658 0 + -1.90626 1.60447 0 -1.62608 1.64631 0 -1.33945 1.68195 0 -1.04747 1.71128 0 + -0.751282 1.73412 0 -0.452026 1.75016 0 -0.150888 1.7588 0 0.150888 1.7588 0 + 0.452026 1.75016 0 0.751282 1.73412 0 1.04747 1.71128 0 1.33945 1.68195 0 + 1.62608 1.64631 0 1.90626 1.60447 0 2.17892 1.55658 0 2.443 1.5028 0 + 2.6975 1.4433 0 2.94143 1.37829 0 3.17386 1.30801 0 3.39388 1.23272 0 + 3.60066 1.15268 0 3.79338 1.06821 0 3.9713 0.979626 0 4.13373 0.887256 0 + 4.28002 0.791455 0 4.4096 0.692589 0 4.52195 0.591035 0 4.61662 0.487178 0 + 4.6932 0.381406 0 4.75135 0.274081 0 4.7907 0.165479 0 4.82204 0.0556159 0 + -5.22306 0.0450379 0 -5.18929 0.134614 0 -5.14719 0.223489 0 -5.08478 0.311446 0 + -5.00242 0.398187 0 -4.90045 0.48339 0 -4.7793 0.566729 0 -4.63945 0.647882 0 + -4.48145 0.726538 0 -4.30592 0.802393 0 -4.11355 0.875158 0 -3.90509 0.944556 0 + -3.68134 1.01032 0 -3.44317 1.07221 0 -3.19149 1.12999 0 -2.92727 1.18345 0 + -2.65152 1.2324 0 -2.3653 1.27667 0 -2.06969 1.31612 0 -1.76583 1.35061 0 + -1.45486 1.38005 0 -1.13796 1.40432 0 -0.816351 1.42328 0 -0.491263 1.43666 0 + -0.164004 1.44391 0 0.164004 1.44391 0 0.491263 1.43666 0 0.816351 1.42328 0 + 1.13796 1.40432 0 1.45486 1.38005 0 1.76583 1.35061 0 2.06969 1.31612 0 + 2.3653 1.27667 0 2.65152 1.2324 0 2.92727 1.18345 0 3.19149 1.12999 0 + 3.44317 1.07221 0 3.68134 1.01032 0 3.90509 0.944556 0 4.11355 0.875158 0 + 4.30592 0.802393 0 4.48145 0.726538 0 4.63945 0.647882 0 4.7793 0.566729 0 + 4.90045 0.48339 0 5.00242 0.398187 0 5.08478 0.311446 0 5.14719 0.223489 0 + 5.18929 0.134614 0 5.22306 0.0450379 0 -5.542 0.0339628 0 -5.50672 0.102063 0 + -5.46268 0.169892 0 -5.39715 0.237114 0 -5.31045 0.303447 0 -5.20291 0.36863 0 + -5.07499 0.432407 0 -4.92716 0.494528 0 -4.76002 0.554752 0 -4.57422 0.612847 0 + -4.37047 0.668587 0 -4.14956 0.721759 0 -3.91235 0.772161 0 -3.65975 0.819601 0 + -3.39273 0.863902 0 -3.11231 0.904903 0 -2.81957 0.942457 0 -2.5156 0.976435 0 + -2.20158 1.00673 0 -1.87867 1.03324 0 -1.5481 1.05589 0 -1.21111 1.0746 0 + -0.868976 1.08925 0 -0.523009 1.09963 0 -0.174619 1.10529 0 0.174619 1.10529 0 + 0.523009 1.09963 0 0.868976 1.08925 0 1.21111 1.0746 0 1.5481 1.05589 0 + 1.87867 1.03324 0 2.20158 1.00673 0 2.5156 0.976435 0 2.81957 0.942457 0 + 3.11231 0.904903 0 3.39273 0.863902 0 3.65975 0.819601 0 3.91235 0.772161 0 + 4.14956 0.721759 0 4.37047 0.668587 0 4.57422 0.612847 0 4.76002 0.554752 0 + 4.92716 0.494528 0 5.07499 0.432407 0 5.20291 0.36863 0 5.31045 0.303447 0 + 5.39715 0.237114 0 5.46268 0.169892 0 5.50672 0.102063 0 5.542 0.0339628 0 + -5.77377 0.022655 0 -5.7378 0.0684639 0 -5.69261 0.114254 0 -5.62507 0.159689 0 + -5.53545 0.204549 0 -5.42411 0.248649 0 -5.29146 0.291811 0 -5.13802 0.333866 0 + -4.9644 0.374648 0 -4.77125 0.413998 0 -4.55933 0.451763 0 -4.32945 0.487796 0 + -4.08249 0.521959 0 -3.81941 0.55412 0 -3.5412 0.58416 0 -3.24894 0.611966 0 + -2.94374 0.637441 0 -2.62675 0.660496 0 -2.29917 0.681057 0 -1.96223 0.699062 0 + -1.61719 0.714458 0 -1.26535 0.727191 0 -0.908015 0.737183 0 -0.546571 0.744284 0 + -0.182499 0.748172 0 0.182499 0.748172 0 0.546571 0.744284 0 0.908015 0.737183 0 + 1.26535 0.727191 0 1.61719 0.714458 0 1.96223 0.699062 0 2.29917 0.681057 0 + 2.62675 0.660496 0 2.94374 0.637441 0 3.24894 0.611966 0 3.5412 0.58416 0 + 3.81941 0.55412 0 4.08249 0.521959 0 4.32945 0.487796 0 4.55933 0.451763 0 + 4.77125 0.413998 0 4.9644 0.374648 0 5.13802 0.333866 0 5.29146 0.291811 0 + 5.42411 0.248649 0 5.53545 0.204549 0 5.62507 0.159689 0 5.69261 0.114254 0 + 5.7378 0.0684639 0 5.77377 0.022655 0 -5.91454 0.0113305 0 -5.87848 0.0343741 0 + -5.8328 0.0574637 0 -5.76425 0.0803944 0 -5.67307 0.103048 0 -5.5596 0.125327 0 + -5.42426 0.147144 0 -5.26757 0.16841 0 -5.09013 0.189041 0 -4.89263 0.208956 0 + -4.67582 0.228075 0 -4.44054 0.246322 0 -4.18769 0.263625 0 -3.91823 0.279917 0 + -3.63321 0.295134 0 -3.33369 0.309221 0 -3.02084 0.322125 0 -2.69582 0.333803 0 + -2.35987 0.344217 0 -2.01424 0.353337 0 -1.66024 0.361137 0 -1.29916 0.367591 0 + -0.93237 0.372661 0 -0.561279 0.376271 0 -0.18742 0.378253 0 0.18742 0.378253 0 + 0.561279 0.376271 0 0.93237 0.372661 0 1.29916 0.367591 0 1.66024 0.361137 0 + 2.01424 0.353337 0 2.35987 0.344217 0 2.69582 0.333803 0 3.02084 0.322125 0 + 3.33369 0.309221 0 3.63321 0.295134 0 3.91823 0.279917 0 4.18769 0.263625 0 + 4.44054 0.246322 0 4.67582 0.228075 0 4.89263 0.208956 0 5.09013 0.189041 0 + 5.26757 0.16841 0 5.42426 0.147144 0 5.5596 0.125327 0 5.67307 0.103048 0 + 5.76425 0.0803944 0 5.8328 0.0574637 0 5.87848 0.0343741 0 5.91454 0.0113305 0 + -5.96179 8.74032e-05 0 -5.92584 0.000174292 0 -5.8801 0.000234398 0 -5.81131 0.000293045 0 + -5.7197 0.000359302 0 -5.6056 0.000436447 0 -5.46943 0.000525208 0 -5.31172 0.00062479 0 + -5.13306 0.000733303 0 -4.93415 0.000848038 0 -4.71574 0.000965748 0 -4.47867 0.0010829 0 + -4.22386 0.00119595 0 -3.95227 0.00130157 0 -3.66494 0.00139688 0 -3.36297 0.00147964 0 + -3.04751 0.00154839 0 -2.71975 0.00160257 0 -2.38093 0.00164257 0 -2.03231 0.00166965 0 + -1.6752 0.0016859 0 -1.31093 0.00169391 0 -0.940858 0.00169655 0 -0.56641 0.00169653 0 + -0.189137 0.00169597 0 0.189137 0.00169597 0 0.56641 0.00169653 0 0.940858 0.00169655 0 + 1.31093 0.00169391 0 1.6752 0.0016859 0 2.03231 0.00166965 0 2.38093 0.00164257 0 + 2.71975 0.00160257 0 3.04751 0.00154839 0 3.36297 0.00147964 0 3.66494 0.00139688 0 + 3.95227 0.00130157 0 4.22386 0.00119595 0 4.47867 0.0010829 0 4.71574 0.000965748 0 + 4.93415 0.000848038 0 5.13306 0.000733303 0 5.31172 0.00062479 0 5.46943 0.000525208 0 + 5.6056 0.000436447 0 5.7197 0.000359302 0 5.81131 0.000293045 0 5.8801 0.000234398 0 + 5.92584 0.000174292 0 5.96179 8.74032e-05 0 -5.91451 -0.011158 0 -5.87842 -0.0340304 0 + -5.83272 -0.0570021 0 -5.76416 -0.0798173 0 -5.67296 -0.102339 0 -5.55946 -0.124464 0 + -5.4241 -0.146102 0 -5.2674 -0.167167 0 -5.08995 -0.187579 0 -4.89244 -0.207261 0 + -4.67563 -0.226142 0 -4.44036 -0.244151 0 -4.18752 -0.261226 0 -3.91808 -0.277304 0 + -3.63308 -0.292329 0 -3.33359 -0.306249 0 -3.02076 -0.319016 0 -2.69577 -0.330586 0 + -2.35984 -0.340921 0 -2.01423 -0.349989 0 -1.66024 -0.35776 0 -1.29917 -0.364201 0 + -0.932381 -0.369268 0 -0.561288 -0.37288 0 -0.187423 -0.374865 0 0.187423 -0.374865 0 + 0.561288 -0.37288 0 0.932381 -0.369268 0 1.29917 -0.364201 0 1.66024 -0.35776 0 + 2.01423 -0.349989 0 2.35984 -0.340921 0 2.69577 -0.330586 0 3.02076 -0.319016 0 + 3.33359 -0.306249 0 3.63308 -0.292329 0 3.91808 -0.277304 0 4.18752 -0.261226 0 + 4.44036 -0.244151 0 4.67563 -0.226142 0 4.89244 -0.207261 0 5.08995 -0.187579 0 + 5.2674 -0.167167 0 5.4241 -0.146102 0 5.55946 -0.124464 0 5.67296 -0.102339 0 + 5.76416 -0.0798173 0 5.83272 -0.0570021 0 5.87842 -0.0340304 0 5.91451 -0.011158 0 + -5.77371 -0.02249 0 -5.73766 -0.0681361 0 -5.69244 -0.113815 0 -5.62487 -0.15914 0 + -5.53521 -0.203873 0 -5.42382 -0.247818 0 -5.29113 -0.290798 0 -5.13766 -0.332646 0 + -4.96401 -0.373201 0 -4.77085 -0.412309 0 -4.55892 -0.449825 0 -4.32905 -0.485612 0 + -4.08212 -0.519536 0 -3.81908 -0.551477 0 -3.54092 -0.581318 0 -3.24871 -0.608955 0 + -2.94356 -0.634291 0 -2.62662 -0.657241 0 -2.29909 -0.677728 0 -1.96219 -0.695688 0 + -1.61718 -0.711062 0 -1.26536 -0.723791 0 -0.908032 -0.733789 0 -0.546586 -0.740899 0 + -0.182505 -0.744792 0 0.182505 -0.744792 0 0.546586 -0.740899 0 0.908032 -0.733789 0 + 1.26536 -0.723791 0 1.61718 -0.711062 0 1.96219 -0.695688 0 2.29909 -0.677728 0 + 2.62662 -0.657241 0 2.94356 -0.634291 0 3.24871 -0.608955 0 3.54092 -0.581318 0 + 3.81908 -0.551477 0 4.08212 -0.519536 0 4.32905 -0.485612 0 4.55892 -0.449825 0 + 4.77085 -0.412309 0 4.96401 -0.373201 0 5.13766 -0.332646 0 5.29113 -0.290798 0 + 5.42382 -0.247818 0 5.53521 -0.203873 0 5.62487 -0.15914 0 5.69244 -0.113815 0 + 5.73766 -0.0681361 0 5.77371 -0.02249 0 -5.5419 -0.0338114 0 -5.50651 -0.101765 0 + -5.46242 -0.169497 0 -5.39683 -0.236619 0 -5.31005 -0.30283 0 -5.20245 -0.367859 0 + -5.07444 -0.431447 0 -4.92656 -0.493351 0 -4.75937 -0.553333 0 -4.57354 -0.611169 0 + -4.36979 -0.666643 0 -4.1489 -0.719551 0 -3.91173 -0.769699 0 -3.65919 -0.816905 0 + -3.39224 -0.860998 0 -3.1119 -0.901823 0 -2.81924 -0.939237 0 -2.51536 -0.973112 0 + -2.20141 -1.00334 0 -1.87858 -1.02981 0 -1.54806 -1.05246 0 -1.21111 -1.07118 0 + -0.868991 -1.08585 0 -0.523026 -1.09625 0 -0.174626 -1.10192 0 0.174626 -1.10192 0 + 0.523026 -1.09625 0 0.868991 -1.08585 0 1.21111 -1.07118 0 1.54806 -1.05246 0 + 1.87858 -1.02981 0 2.20141 -1.00334 0 2.51536 -0.973112 0 2.81924 -0.939237 0 + 3.1119 -0.901823 0 3.39224 -0.860998 0 3.65919 -0.816905 0 3.91173 -0.769699 0 + 4.1489 -0.719551 0 4.36979 -0.666643 0 4.57354 -0.611169 0 4.75937 -0.553333 0 + 4.92656 -0.493351 0 5.07444 -0.431447 0 5.20245 -0.367859 0 5.31005 -0.30283 0 + 5.39683 -0.236619 0 5.46242 -0.169497 0 5.50651 -0.101765 0 5.5419 -0.0338114 0 + -5.22292 -0.0449074 0 -5.189 -0.134363 0 -5.14682 -0.223166 0 -5.08432 -0.311042 0 + -5.00183 -0.39767 0 -4.89974 -0.482717 0 -4.77847 -0.565859 0 -4.63852 -0.646777 0 + -4.48045 -0.725168 0 -4.30487 -0.800739 0 -4.11249 -0.873211 0 -3.90405 -0.942317 0 + -3.68035 -1.0078 0 -3.44225 -1.06944 0 -3.19067 -1.12699 0 -2.92657 -1.18027 0 + -2.65095 -1.22907 0 -2.36486 -1.27324 0 -2.06938 -1.31263 0 -1.76563 -1.34711 0 + -1.45475 -1.37656 0 -1.13792 -1.40086 0 -0.816343 -1.41986 0 -0.49127 -1.43328 0 + -0.164008 -1.44056 0 0.164008 -1.44056 0 0.49127 -1.43328 0 0.816343 -1.41986 0 + 1.13792 -1.40086 0 1.45475 -1.37656 0 1.76563 -1.34711 0 2.06938 -1.31263 0 + 2.36486 -1.27324 0 2.65095 -1.22907 0 2.92657 -1.18027 0 3.19067 -1.12699 0 + 3.44225 -1.06944 0 3.68035 -1.0078 0 3.90405 -0.942317 0 4.11249 -0.873211 0 + 4.30487 -0.800739 0 4.48045 -0.725168 0 4.63852 -0.646777 0 4.77847 -0.565859 0 + 4.89974 -0.482717 0 5.00183 -0.39767 0 5.08432 -0.311042 0 5.14682 -0.223166 0 + 5.189 -0.134363 0 5.22292 -0.0449074 0 -4.82187 -0.0555172 0 -4.79032 -0.165307 0 + -4.75084 -0.273877 0 -4.69253 -0.38115 0 -4.61575 -0.486823 0 -4.52088 -0.590522 0 + -4.40834 -0.691863 0 -4.2786 -0.790468 0 -4.13218 -0.88597 0 -3.96968 -0.978018 0 + -3.79172 -1.06627 0 -3.59901 -1.15041 0 -3.3923 -1.23013 0 -3.17237 -1.30513 0 + -2.94008 -1.37516 0 -2.69632 -1.43996 0 -2.442 -1.49931 0 -2.17811 -1.55299 0 + -1.90565 -1.60083 0 -1.62564 -1.64267 0 -1.33916 -1.67835 0 -1.04731 -1.70775 0 + -0.7512 -1.73065 0 -0.451992 -1.74676 0 -0.15088 -1.75545 0 0.15088 -1.75545 0 + 0.451992 -1.74676 0 0.7512 -1.73065 0 1.04731 -1.70775 0 1.33916 -1.67835 0 + 1.62564 -1.64267 0 1.90565 -1.60083 0 2.17811 -1.55299 0 2.442 -1.49931 0 + 2.69632 -1.43996 0 2.94008 -1.37516 0 3.17237 -1.30513 0 3.3923 -1.23013 0 + 3.59901 -1.15041 0 3.79172 -1.06627 0 3.96968 -0.978018 0 4.13218 -0.88597 0 + 4.2786 -0.790468 0 4.40834 -0.691863 0 4.52088 -0.590522 0 4.61575 -0.486823 0 + 4.69253 -0.38115 0 4.75084 -0.273877 0 4.79032 -0.165307 0 4.82187 -0.0555172 0 + -4.34506 -0.0653745 0 -4.31673 -0.193966 0 -4.28073 -0.320688 0 -4.22768 -0.445707 0 + -4.15796 -0.568764 0 -4.07194 -0.689464 0 -3.97002 -0.807379 0 -3.85264 -0.922077 0 + -3.72027 -1.03314 0 -3.57346 -1.14016 0 -3.41279 -1.24275 0 -3.23888 -1.34054 0 + -3.05242 -1.43317 0 -2.85412 -1.52031 0 -2.64475 -1.60165 0 -2.4251 -1.67689 0 + -2.19602 -1.74577 0 -1.95839 -1.80805 0 -1.71311 -1.86352 0 -1.46112 -1.91197 0 + -1.2034 -1.95325 0 -0.940939 -1.98717 0 -0.674765 -2.01352 0 -0.405927 -2.03195 0 + -0.135487 -2.04181 0 0.135487 -2.04181 0 0.405927 -2.03195 0 0.674765 -2.01352 0 + 0.940939 -1.98717 0 1.2034 -1.95325 0 1.46112 -1.91197 0 1.71311 -1.86352 0 + 1.95839 -1.80805 0 2.19602 -1.74577 0 2.4251 -1.67689 0 2.64475 -1.60165 0 + 2.85412 -1.52031 0 3.05242 -1.43317 0 3.23888 -1.34054 0 3.41279 -1.24275 0 + 3.57346 -1.14016 0 3.72027 -1.03314 0 3.85264 -0.922077 0 3.97002 -0.807379 0 + 4.07194 -0.689464 0 4.15796 -0.568764 0 4.22768 -0.445707 0 4.28073 -0.320688 0 + 4.31673 -0.193966 0 4.34506 -0.0653745 0 -3.79994 -0.0742321 0 -3.77557 -0.219745 0 + -3.74376 -0.362711 0 -3.69695 -0.503547 0 -3.63554 -0.64206 0 -3.55987 -0.777851 0 + -3.47032 -0.910462 0 -3.36728 -1.03942 0 -3.25117 -1.16427 0 -3.12247 -1.28455 0 + -2.98169 -1.39982 0 -2.82938 -1.50969 0 -2.66614 -1.61373 0 -2.4926 -1.71159 0 + -2.30943 -1.80291 0 -2.11733 -1.88737 0 -1.91704 -1.96466 0 -1.70932 -2.03451 0 + -1.49497 -2.09668 0 -1.27483 -2.15094 0 -1.04976 -2.19709 0 -0.820629 -2.23492 0 + -0.588359 -2.26421 0 -0.353875 -2.28458 0 -0.118098 -2.2954 0 0.118098 -2.2954 0 + 0.353875 -2.28458 0 0.588359 -2.26421 0 0.820629 -2.23492 0 1.04976 -2.19709 0 + 1.27483 -2.15094 0 1.49497 -2.09668 0 1.70932 -2.03451 0 1.91704 -1.96466 0 + 2.11733 -1.88737 0 2.30943 -1.80291 0 2.4926 -1.71159 0 2.66614 -1.61373 0 + 2.82938 -1.50969 0 2.98169 -1.39982 0 3.12247 -1.28455 0 3.25117 -1.16427 0 + 3.36728 -1.03942 0 3.47032 -0.910462 0 3.55987 -0.777851 0 3.63554 -0.64206 0 + 3.69695 -0.503547 0 3.74376 -0.362711 0 3.77557 -0.219745 0 3.79994 -0.0742321 0 + -3.19502 -0.0818801 0 -3.17518 -0.242116 0 -3.14818 -0.399145 0 -3.10849 -0.553611 0 + -3.0565 -0.705403 0 -2.99253 -0.85414 0 -2.91691 -0.999346 0 -2.82997 -1.14052 0 + -2.73208 -1.27717 0 -2.62364 -1.40879 0 -2.50507 -1.53493 0 -2.37684 -1.65511 0 + -2.23946 -1.76892 0 -2.09345 -1.87595 0 -1.93938 -1.9758 0 -1.77784 -2.06813 0 + -1.60945 -2.15259 0 -1.43485 -2.2289 0 -1.25472 -2.29676 0 -1.06978 -2.35594 0 + -0.880732 -2.4062 0 -0.688349 -2.44731 0 -0.493409 -2.47902 0 -0.296703 -2.50096 0 + -0.0990036 -2.5125 0 0.0990036 -2.5125 0 0.296703 -2.50096 0 0.493409 -2.47902 0 + 0.688349 -2.44731 0 0.880732 -2.4062 0 1.06978 -2.35594 0 1.25472 -2.29676 0 + 1.43485 -2.2289 0 1.60945 -2.15259 0 1.77784 -2.06813 0 1.93938 -1.9758 0 + 2.09345 -1.87595 0 2.23946 -1.76892 0 2.37684 -1.65511 0 2.50507 -1.53493 0 + 2.62364 -1.40879 0 2.73208 -1.27717 0 2.82997 -1.14052 0 2.91691 -0.999346 0 + 2.99253 -0.85414 0 3.0565 -0.705403 0 3.10849 -0.553611 0 3.14818 -0.399145 0 + 3.17518 -0.242116 0 3.19502 -0.0818801 0 -2.53974 -0.0881642 0 -2.52478 -0.260648 0 + -2.50308 -0.429305 0 -2.47125 -0.594973 0 -2.42964 -0.757645 0 -2.37853 -0.916972 0 + -2.31819 -1.07248 0 -2.24888 -1.22364 0 -2.1709 -1.36993 0 -2.08456 -1.51082 0 + -1.99019 -1.64583 0 -1.88817 -1.77446 0 -1.77889 -1.89624 0 -1.66278 -2.01075 0 + -1.54027 -2.11757 0 -1.41185 -2.21632 0 -1.27799 -2.30664 0 -1.13923 -2.38821 0 + -0.996094 -2.46071 0 -0.849148 -2.52389 0 -0.698978 -2.57747 0 -0.546195 -2.62121 0 + -0.391431 -2.65483 0 -0.23533 -2.67796 0 -0.0785134 -2.69001 0 0.0785134 -2.69001 0 + 0.23533 -2.67796 0 0.391431 -2.65483 0 0.546195 -2.62121 0 0.698978 -2.57747 0 + 0.849148 -2.52389 0 0.996094 -2.46071 0 1.13923 -2.38821 0 1.27799 -2.30664 0 + 1.41185 -2.21632 0 1.54027 -2.11757 0 1.66278 -2.01075 0 1.77889 -1.89624 0 + 1.88817 -1.77446 0 1.99019 -1.64583 0 2.08456 -1.51082 0 2.1709 -1.36993 0 + 2.24888 -1.22364 0 2.31819 -1.07248 0 2.37853 -0.916972 0 2.42964 -0.757645 0 + 2.47125 -0.594973 0 2.50308 -0.429305 0 2.52478 -0.260648 0 2.53974 -0.0881642 0 + -1.84432 -0.0930144 0 -1.83438 -0.275043 0 -1.81834 -0.452644 0 -1.79494 -0.626864 0 + -1.76449 -0.797816 0 -1.7272 -0.965199 0 -1.68325 -1.12854 0 -1.63283 -1.2873 0 + -1.57613 -1.44094 0 -1.51339 -1.5889 0 -1.44484 -1.73067 0 -1.37074 -1.86573 0 + -1.29139 -1.9936 0 -1.20707 -2.11382 0 -1.11812 -2.22596 0 -1.02488 -2.32961 0 + -0.927687 -2.4244 0 -0.826932 -2.50997 0 -0.723001 -2.58601 0 -0.616304 -2.65223 0 + -0.507268 -2.70833 0 -0.396343 -2.75406 0 -0.283997 -2.78909 0 -0.170711 -2.81308 0 + -0.0569465 -2.82547 0 0.0569465 -2.82547 0 0.170711 -2.81308 0 0.283997 -2.78909 0 + 0.396343 -2.75406 0 0.507268 -2.70833 0 0.616304 -2.65223 0 0.723001 -2.58601 0 + 0.826932 -2.50997 0 0.927687 -2.4244 0 1.02488 -2.32961 0 1.11812 -2.22596 0 + 1.20707 -2.11382 0 1.29139 -1.9936 0 1.37074 -1.86573 0 1.44484 -1.73067 0 + 1.51339 -1.5889 0 1.57613 -1.44094 0 1.63283 -1.2873 0 1.68325 -1.12854 0 + 1.7272 -0.965199 0 1.76449 -0.797816 0 1.79494 -0.626864 0 1.81834 -0.452644 0 + 1.83438 -0.275043 0 1.84432 -0.0930144 0 -1.11963 -0.0965128 0 -1.11464 -0.285147 0 + -1.10446 -0.468758 0 -1.08993 -0.648676 0 -1.07124 -0.825146 0 -1.04849 -0.997911 0 + -1.02176 -1.1665 0 -0.991164 -1.33036 0 -0.956792 -1.48894 0 -0.918772 -1.64166 0 + -0.877241 -1.78799 0 -0.832351 -1.92739 0 -0.784266 -2.05938 0 -0.733166 -2.18346 0 + -0.67924 -2.2992 0 -0.62269 -2.40617 0 -0.563728 -2.50399 0 -0.50258 -2.59229 0 + -0.43948 -2.67073 0 -0.374675 -2.73901 0 -0.308426 -2.79683 0 -0.241003 -2.8439 0 + -0.172696 -2.8799 0 -0.103804 -2.90445 0 -0.0346255 -2.91705 0 0.0346255 -2.91705 0 + 0.103804 -2.90445 0 0.172696 -2.8799 0 0.241003 -2.8439 0 0.308426 -2.79683 0 + 0.374675 -2.73901 0 0.43948 -2.67073 0 0.50258 -2.59229 0 0.563728 -2.50399 0 + 0.62269 -2.40617 0 0.67924 -2.2992 0 0.733166 -2.18346 0 0.784266 -2.05938 0 + 0.832351 -1.92739 0 0.877241 -1.78799 0 0.918772 -1.64166 0 0.956792 -1.48894 0 + 0.991164 -1.33036 0 1.02176 -1.1665 0 1.04849 -0.997911 0 1.07124 -0.825146 0 + 1.08993 -0.648676 0 1.10446 -0.468758 0 1.11464 -0.285147 0 1.11963 -0.0965128 0 + -0.377042 -0.0990954 0 -0.376742 -0.290932 0 -0.372532 -0.477363 0 -0.367162 -0.659971 0 + -0.360621 -0.839084 0 -0.352883 -1.01446 0 -0.343925 -1.18563 0 -0.333744 -1.35202 0 + -0.322346 -1.51306 0 -0.309751 -1.66816 0 -0.295989 -1.81678 0 -0.281098 -1.95838 0 + -0.265121 -2.09245 0 -0.248107 -2.2185 0 -0.230112 -2.33608 0 -0.211196 -2.44476 0 + -0.191425 -2.54413 0 -0.170869 -2.63384 0 -0.149602 -2.71354 0 -0.127704 -2.78291 0 + -0.105257 -2.84164 0 -0.082351 -2.88943 0 -0.0590782 -2.92596 0 -0.0355429 -2.95082 0 + -0.0118617 -2.96353 0 0.0118617 -2.96353 0 0.0355429 -2.95082 0 0.0590782 -2.92596 0 + 0.082351 -2.88943 0 0.105257 -2.84164 0 0.127704 -2.78291 0 0.149602 -2.71354 0 + 0.170869 -2.63384 0 0.191425 -2.54413 0 0.211196 -2.44476 0 0.230112 -2.33608 0 + 0.248107 -2.2185 0 0.265121 -2.09245 0 0.281098 -1.95838 0 0.295989 -1.81678 0 + 0.309751 -1.66816 0 0.322346 -1.51306 0 0.333744 -1.35202 0 0.343925 -1.18563 0 + 0.352883 -1.01446 0 0.360621 -0.839084 0 0.367162 -0.659971 0 0.372532 -0.477363 0 + 0.376742 -0.290932 0 0.377042 -0.0990954 0 0.371747 -0.101326 0 0.367599 -0.29238 0 + 0.365755 -0.47828 0 0.36183 -0.660499 0 0.356065 -0.83933 0 0.34862 -1.01451 0 + 0.339624 -1.18554 0 0.329181 -1.35184 0 0.317384 -1.51283 0 0.304316 -1.66791 0 + 0.290056 -1.81653 0 0.274682 -1.95815 0 0.258274 -2.09225 0 0.240909 -2.21835 0 + 0.222669 -2.33598 0 0.203634 -2.44473 0 0.183888 -2.54419 0 0.163516 -2.63398 0 + 0.142604 -2.71376 0 0.121242 -2.78322 0 0.0995234 -2.84205 0 0.0775467 -2.88995 0 + 0.0554152 -2.92658 0 0.0332294 -2.95155 0 0.0110676 -2.96433 0 -0.0110676 -2.96433 0 + -0.0332294 -2.95155 0 -0.0554152 -2.92658 0 -0.0775467 -2.88995 0 -0.0995234 -2.84205 0 + -0.121242 -2.78322 0 -0.142604 -2.71376 0 -0.163516 -2.63398 0 -0.183888 -2.54419 0 + -0.203634 -2.44473 0 -0.222669 -2.33598 0 -0.240909 -2.21835 0 -0.258274 -2.09225 0 + -0.274682 -1.95815 0 -0.290056 -1.81653 0 -0.304316 -1.66791 0 -0.317384 -1.51283 0 + -0.329181 -1.35184 0 -0.339624 -1.18554 0 -0.34862 -1.01451 0 -0.356065 -0.83933 0 + -0.36183 -0.660499 0 -0.365755 -0.47828 0 -0.367599 -0.29238 0 -0.371747 -0.101326 0 + 1.11474 -0.102991 0 1.10621 -0.289397 0 1.09826 -0.471471 0 1.08512 -0.650245 0 + 1.06718 -0.825879 0 1.04472 -0.998054 0 1.01796 -1.16624 0 0.98711 -1.32985 0 + 0.952355 -1.48827 0 0.913883 -1.64093 0 0.871879 -1.78725 0 0.826533 -1.92671 0 + 0.778045 -2.05879 0 0.726619 -2.18302 0 0.672468 -2.29893 0 0.615814 -2.4061 0 + 0.556885 -2.50414 0 0.495918 -2.59268 0 0.433158 -2.67139 0 0.368858 -2.73994 0 + 0.303286 -2.79804 0 0.236719 -2.84541 0 0.169447 -2.88171 0 0.101763 -2.90654 0 + 0.0339271 -2.91933 0 -0.0339271 -2.91933 0 -0.101763 -2.90654 0 -0.169447 -2.88171 0 + -0.236719 -2.84541 0 -0.303286 -2.79804 0 -0.368858 -2.73994 0 -0.433158 -2.67139 0 + -0.495918 -2.59268 0 -0.556885 -2.50414 0 -0.615814 -2.4061 0 -0.672468 -2.29893 0 + -0.726619 -2.18302 0 -0.778045 -2.05879 0 -0.826533 -1.92671 0 -0.871879 -1.78725 0 + -0.913883 -1.64093 0 -0.952355 -1.48827 0 -0.98711 -1.32985 0 -1.01796 -1.16624 0 + -1.04472 -0.998054 0 -1.06718 -0.825879 0 -1.08512 -0.650245 0 -1.09826 -0.471471 0 + -1.10621 -0.289397 0 -1.11474 -0.102991 0 1.84015 -0.103171 0 1.82724 -0.281854 0 + 1.81323 -0.457049 0 1.79113 -0.629429 0 1.76139 -0.799018 0 1.72437 -0.965434 0 + 1.68039 -1.12812 0 1.62973 -1.28646 0 1.57268 -1.43986 0 1.50952 -1.58772 0 + 1.44054 -1.72948 0 1.36604 -1.86463 0 1.28632 -1.99267 0 1.20172 -2.11311 0 + 1.11257 -2.22553 0 1.01924 -2.32951 0 0.922088 -2.42465 0 0.821499 -2.51061 0 + 0.71787 -2.58706 0 0.611614 -2.6537 0 0.503157 -2.71025 0 0.392948 -2.75643 0 + 0.281447 -2.79192 0 0.169123 -2.81632 0 0.0564066 -2.829 0 -0.0564066 -2.829 0 + -0.169123 -2.81632 0 -0.281447 -2.79192 0 -0.392948 -2.75643 0 -0.503157 -2.71025 0 + -0.611614 -2.6537 0 -0.71787 -2.58706 0 -0.821499 -2.51061 0 -0.922088 -2.42465 0 + -1.01924 -2.32951 0 -1.11257 -2.22553 0 -1.20172 -2.11311 0 -1.28632 -1.99267 0 + -1.36604 -1.86463 0 -1.44054 -1.72948 0 -1.50952 -1.58772 0 -1.57268 -1.43986 0 + -1.62973 -1.28646 0 -1.68039 -1.12812 0 -1.72437 -0.965434 0 -1.76139 -0.799018 0 + -1.79113 -0.629429 0 -1.81323 -0.457049 0 -1.82724 -0.281854 0 -1.84015 -0.103171 0 + 2.53658 -0.101222 0 2.51946 -0.269664 0 2.49947 -0.435232 0 2.46878 -0.598455 0 + 2.42781 -0.759282 0 2.37695 -0.917293 0 2.31658 -1.07191 0 2.24706 -1.2225 0 + 2.16876 -1.36847 0 2.08205 -1.50923 0 1.98731 -1.64424 0 1.88493 -1.77299 0 + 1.77534 -1.895 0 1.65898 -2.00982 0 1.53631 -2.11701 0 1.40782 -2.21619 0 + 1.27399 -2.30699 0 1.13536 -2.38906 0 0.992462 -2.46209 0 0.845859 -2.52581 0 + 0.69613 -2.57995 0 0.543875 -2.62426 0 0.389716 -2.65843 0 0.234277 -2.68205 0 + 0.0781582 -2.69443 0 -0.0781582 -2.69443 0 -0.234277 -2.68205 0 -0.389716 -2.65843 0 + -0.543875 -2.62426 0 -0.69613 -2.57995 0 -0.845859 -2.52581 0 -0.992462 -2.46209 0 + -1.13536 -2.38906 0 -1.27399 -2.30699 0 -1.40782 -2.21619 0 -1.53631 -2.11701 0 + -1.65898 -2.00982 0 -1.77534 -1.895 0 -1.88493 -1.77299 0 -1.98731 -1.64424 0 + -2.08205 -1.50923 0 -2.16876 -1.36847 0 -2.24706 -1.2225 0 -2.31658 -1.07191 0 + -2.37695 -0.917293 0 -2.42781 -0.759282 0 -2.46878 -0.598455 0 -2.49947 -0.435232 0 + -2.51946 -0.269664 0 -2.53658 -0.101222 0 3.1931 -0.0969602 0 3.17207 -0.252856 0 + 3.14634 -0.406332 0 3.10755 -0.557873 0 3.05608 -0.707415 0 2.99231 -0.854535 0 + 2.91666 -0.998647 0 2.82955 -1.13913 0 2.73139 -1.27539 0 2.62264 -1.40685 0 + 2.50376 -1.533 0 2.37525 -1.65334 0 2.23761 -1.76743 0 2.0914 -1.87482 0 + 1.93719 -1.97513 0 1.77558 -2.06797 0 1.60719 -2.153 0 1.43267 -2.2299 0 + 1.2527 -2.29839 0 1.06798 -2.35819 0 0.879207 -2.40908 0 0.687142 -2.45081 0 + 0.492544 -2.48312 0 0.296187 -2.50557 0 0.0988329 -2.51744 0 -0.0988329 -2.51744 0 + -0.296187 -2.50557 0 -0.492544 -2.48312 0 -0.687142 -2.45081 0 -0.879207 -2.40908 0 + -1.06798 -2.35819 0 -1.2527 -2.29839 0 -1.43267 -2.2299 0 -1.60719 -2.153 0 + -1.77558 -2.06797 0 -1.93719 -1.97513 0 -2.0914 -1.87482 0 -2.23761 -1.76743 0 + -2.37525 -1.65334 0 -2.50376 -1.533 0 -2.62264 -1.40685 0 -2.73139 -1.27539 0 + -2.82955 -1.13913 0 -2.91666 -0.998647 0 -2.99231 -0.854535 0 -3.05608 -0.707415 0 + -3.10755 -0.557873 0 -3.14634 -0.406332 0 -3.17207 -0.252856 0 -3.1931 -0.0969602 0 + 3.79938 -0.0904147 0 3.77486 -0.231615 0 3.7438 -0.370785 0 3.69755 -0.50838 0 + 3.63647 -0.644349 0 3.56093 -0.778294 0 3.47134 -0.909654 0 3.36816 -1.03783 0 + 3.25185 -1.16223 0 3.12293 -1.28233 0 2.98192 -1.39763 0 2.8294 -1.50768 0 + 2.66598 -1.61204 0 2.49229 -1.71031 0 2.309 -1.80214 0 2.11683 -1.88717 0 + 1.91651 -1.96509 0 1.70881 -2.0356 0 1.49453 -2.09843 0 1.27447 -2.15336 0 + 1.04949 -2.20017 0 0.820467 -2.23863 0 0.588281 -2.26851 0 0.35385 -2.28939 0 + 0.118094 -2.30052 0 -0.118094 -2.30052 0 -0.35385 -2.28939 0 -0.588281 -2.26851 0 + -0.820467 -2.23863 0 -1.04949 -2.20017 0 -1.27447 -2.15336 0 -1.49453 -2.09843 0 + -1.70881 -2.0356 0 -1.91651 -1.96509 0 -2.11683 -1.88717 0 -2.309 -1.80214 0 + -2.49229 -1.71031 0 -2.66598 -1.61204 0 -2.8294 -1.50768 0 -2.98192 -1.39763 0 + -3.12293 -1.28233 0 -3.25185 -1.16223 0 -3.36816 -1.03783 0 -3.47134 -0.909654 0 + -3.56093 -0.778294 0 -3.63647 -0.644349 0 -3.69755 -0.50838 0 -3.7438 -0.370785 0 + -3.77486 -0.231615 0 -3.79938 -0.0904147 0 4.34586 -0.0817263 0 4.31838 -0.20628 0 + 4.2825 -0.329178 0 4.22959 -0.450825 0 4.15996 -0.57119 0 4.07396 -0.689916 0 + 3.972 -0.806487 0 3.85453 -0.920341 0 3.72205 -1.03094 0 3.57512 -1.13777 0 + 3.41433 -1.24039 0 3.24031 -1.33838 0 3.05375 -1.43134 0 2.85536 -1.51893 0 + 2.64591 -1.6008 0 2.42621 -1.67664 0 2.19708 -1.74617 0 1.95941 -1.80913 0 + 1.71408 -1.86528 0 1.46205 -1.91442 0 1.20425 -1.95634 0 0.94169 -1.99087 0 + 0.675366 -2.01777 0 0.406322 -2.03666 0 0.135625 -2.0468 0 -0.135625 -2.0468 0 + -0.406322 -2.03666 0 -0.675366 -2.01777 0 -0.94169 -1.99087 0 -1.20425 -1.95634 0 + -1.46205 -1.91442 0 -1.71408 -1.86528 0 -1.95941 -1.80913 0 -2.19708 -1.74617 0 + -2.42621 -1.67664 0 -2.64591 -1.6008 0 -2.85536 -1.51893 0 -3.05375 -1.43134 0 + -3.24031 -1.33838 0 -3.41433 -1.24039 0 -3.57512 -1.13777 0 -3.72205 -1.03094 0 + -3.85453 -0.920341 0 -3.972 -0.806487 0 -4.07396 -0.689916 0 -4.15996 -0.57119 0 + -4.22959 -0.450825 0 -4.2825 -0.329178 0 -4.31838 -0.20628 0 -4.34586 -0.0817263 0 + 4.8239 -0.0711125 0 4.79403 -0.177314 0 4.754 -0.282236 0 4.69535 -0.386207 0 + 4.61839 -0.489207 0 4.52341 -0.59093 0 4.41082 -0.690919 0 4.28106 -0.788673 0 + 4.13463 -0.883706 0 3.97213 -0.97557 0 3.79419 -1.06386 0 3.60149 -1.1482 0 + 3.39479 -1.22825 0 3.17486 -1.30371 0 2.94256 -1.37427 0 2.69876 -1.43967 0 + 2.44439 -1.49965 0 2.18041 -1.554 0 1.90782 -1.6025 0 1.62765 -1.64498 0 + 1.34095 -1.68128 0 1.04881 -1.71123 0 0.752353 -1.73463 0 0.452724 -1.75113 0 + 0.151132 -1.76004 0 -0.151132 -1.76004 0 -0.452724 -1.75113 0 -0.752353 -1.73463 0 + -1.04881 -1.71123 0 -1.34095 -1.68128 0 -1.62765 -1.64498 0 -1.90782 -1.6025 0 + -2.18041 -1.554 0 -2.44439 -1.49965 0 -2.69876 -1.43967 0 -2.94256 -1.37427 0 + -3.17486 -1.30371 0 -3.39479 -1.22825 0 -3.60149 -1.1482 0 -3.79419 -1.06386 0 + -3.97213 -0.97557 0 -4.13463 -0.883706 0 -4.28106 -0.788673 0 -4.41082 -0.690919 0 + -4.52341 -0.59093 0 -4.61839 -0.489207 0 -4.69535 -0.386207 0 -4.754 -0.282236 0 + -4.79403 -0.177314 0 -4.8239 -0.0711125 0 5.22593 -0.0588464 0 5.19427 -0.145283 0 + 5.15084 -0.230807 0 5.08751 -0.31566 0 5.00454 -0.399817 0 4.90222 -0.483027 0 + 4.78089 -0.564904 0 4.641 -0.645027 0 4.48305 -0.72298 0 4.30763 -0.798383 0 + 4.11542 -0.870892 0 3.90715 -0.940193 0 3.6836 -1.006 0 3.44562 -1.06806 0 + 3.19411 -1.12611 0 2.93003 -1.17994 0 2.65436 -1.22934 0 2.36816 -1.27413 0 + 2.0725 -1.31412 0 1.76848 -1.34918 0 1.45726 -1.37917 0 1.14 -1.40395 0 + 0.817918 -1.42336 0 0.492256 -1.4371 0 0.164345 -1.44456 0 -0.164345 -1.44456 0 + -0.492256 -1.4371 0 -0.817918 -1.42336 0 -1.14 -1.40395 0 -1.45726 -1.37917 0 + -1.76848 -1.34918 0 -2.0725 -1.31412 0 -2.36816 -1.27413 0 -2.65436 -1.22934 0 + -2.93003 -1.17994 0 -3.19411 -1.12611 0 -3.44562 -1.06806 0 -3.6836 -1.006 0 + -3.90715 -0.940193 0 -4.11542 -0.870892 0 -4.30763 -0.798383 0 -4.48305 -0.72298 0 + -4.641 -0.645027 0 -4.78089 -0.564904 0 -4.90222 -0.483027 0 -5.00454 -0.399817 0 + -5.08751 -0.31566 0 -5.15084 -0.230807 0 -5.19427 -0.145283 0 -5.22593 -0.0588464 0 + 5.54556 -0.0452437 0 5.51269 -0.110825 0 5.46669 -0.175836 0 5.39981 -0.240421 0 + 5.31227 -0.304549 0 5.20432 -0.36802 0 5.07627 -0.430535 0 4.92853 -0.491763 0 + 4.76162 -0.551376 0 4.57612 -0.609076 0 4.37272 -0.66459 0 4.15217 -0.717674 0 + 3.91531 -0.768106 0 3.66302 -0.815681 0 3.39625 -0.86021 0 3.11601 -0.901518 0 + 2.82335 -0.939444 0 2.51936 -0.973842 0 2.2052 -1.00458 0 1.88204 -1.03155 0 + 1.5511 -1.05463 0 1.21361 -1.07374 0 0.870867 -1.08874 0 0.524192 -1.09939 0 + 0.175022 -1.10519 0 -0.175022 -1.10519 0 -0.524192 -1.09939 0 -0.870867 -1.08874 0 + -1.21361 -1.07374 0 -1.5511 -1.05463 0 -1.88204 -1.03155 0 -2.2052 -1.00458 0 + -2.51936 -0.973842 0 -2.82335 -0.939444 0 -3.11601 -0.901518 0 -3.39625 -0.86021 0 + -3.66302 -0.815681 0 -3.91531 -0.768106 0 -4.15217 -0.717674 0 -4.37272 -0.66459 0 + -4.57612 -0.609076 0 -4.76162 -0.551376 0 -4.92853 -0.491763 0 -5.07627 -0.430535 0 + -5.20432 -0.36802 0 -5.31227 -0.304549 0 -5.39981 -0.240421 0 -5.46669 -0.175836 0 + -5.51269 -0.110825 0 -5.54556 -0.0452437 0 5.77768 -0.0306501 0 5.74417 -0.0746278 0 + 5.69645 -0.118321 0 5.62719 -0.161788 0 5.53654 -0.204994 0 5.42472 -0.247798 0 + 5.292 -0.289991 0 5.13878 -0.331346 0 4.96554 -0.371637 0 4.77288 -0.410657 0 + 4.56149 -0.448218 0 4.33214 -0.484152 0 4.08568 -0.518306 0 3.82303 -0.55054 0 + 3.54517 -0.580723 0 3.25315 -0.608736 0 2.94806 -0.634468 0 2.63104 -0.657818 0 + 2.30329 -0.678695 0 1.96604 -0.697022 0 1.62055 -0.712726 0 1.26813 -0.725738 0 + 0.910102 -0.735968 0 0.547867 -0.743248 0 0.182939 -0.747234 0 -0.182939 -0.747234 0 + -0.547867 -0.743248 0 -0.910102 -0.735968 0 -1.26813 -0.725738 0 -1.62055 -0.712726 0 + -1.96604 -0.697022 0 -2.30329 -0.678695 0 -2.63104 -0.657818 0 -2.94806 -0.634468 0 + -3.25315 -0.608736 0 -3.54517 -0.580723 0 -3.82303 -0.55054 0 -4.08568 -0.518306 0 + -4.33214 -0.484152 0 -4.56149 -0.448218 0 -4.77288 -0.410657 0 -4.96554 -0.371637 0 + -5.13878 -0.331346 0 -5.292 -0.289991 0 -5.42472 -0.247798 0 -5.53654 -0.204994 0 + -5.62719 -0.161788 0 -5.69645 -0.118321 0 -5.74417 -0.0746278 0 -5.77768 -0.0306501 0 + 5.91857 -0.0154261 0 5.88484 -0.0373829 0 5.83625 -0.0592575 0 5.76571 -0.0810535 0 + 5.67337 -0.102742 0 5.55939 -0.124247 0 5.42403 -0.145462 0 5.26764 -0.166269 0 + 5.09072 -0.186553 0 4.89385 -0.206209 0 4.67771 -0.225142 0 4.4431 -0.243265 0 + 4.19087 -0.2605 0 3.92195 -0.276776 0 3.63734 -0.292027 0 3.33813 -0.30619 0 + 3.02541 -0.319208 0 2.70038 -0.33103 0 2.36425 -0.341606 0 2.01829 -0.350897 0 + 1.66379 -0.358865 0 1.30209 -0.365473 0 0.934558 -0.370674 0 0.562633 -0.374382 0 + 0.187878 -0.376417 0 -0.187878 -0.376417 0 -0.562633 -0.374382 0 -0.934558 -0.370674 0 + -1.30209 -0.365473 0 -1.66379 -0.358865 0 -2.01829 -0.350897 0 -2.36425 -0.341606 0 + -2.70038 -0.33103 0 -3.02541 -0.319208 0 -3.33813 -0.30619 0 -3.63734 -0.292027 0 + -3.92195 -0.276776 0 -4.19087 -0.2605 0 -4.4431 -0.243265 0 -4.67771 -0.225142 0 + -4.89385 -0.206209 0 -5.09072 -0.186553 0 -5.26764 -0.166269 0 -5.42403 -0.145462 0 + -5.55939 -0.124247 0 -5.67337 -0.102742 0 -5.76571 -0.0810535 0 -5.83625 -0.0592575 0 + -5.88484 -0.0373829 0 -5.91857 -0.0154261 0 5.96586 8.40713e-05 0 5.93219 0.000293111 0 + 5.88339 0.000466201 0 5.81253 0.000613707 0 5.71972 0.000742981 0 5.60511 0.000858495 0 + 5.46895 0.00096239 0 5.31158 0.00105516 0 5.13349 0.0011363 0 4.93526 0.00120488 0 + 4.71758 0.00125995 0 4.48123 0.00130081 0 4.22707 0.0013272 0 3.95605 0.0013394 0 + 3.66917 0.00133821 0 3.3675 0.00132501 0 3.05219 0.00130165 0 2.72441 0.00127041 0 + 2.3854 0.0012339 0 2.03643 0.00119499 0 1.67882 0.00115659 0 1.3139 0.00112159 0 + 0.943073 0.00109261 0 0.567778 0.00107187 0 0.1896 0.00106104 0 -0.1896 0.00106104 0 + -0.567778 0.00107187 0 -0.943073 0.00109261 0 -1.3139 0.00112159 0 -1.67882 0.00115659 0 + -2.03643 0.00119499 0 -2.3854 0.0012339 0 -2.72441 0.00127041 0 -3.05219 0.00130165 0 + -3.3675 0.00132501 0 -3.66917 0.00133821 0 -3.95605 0.0013394 0 -4.22707 0.0013272 0 + -4.48123 0.00130081 0 -4.71758 0.00125995 0 -4.93526 0.00120488 0 -5.13349 0.0011363 0 + -5.31158 0.00105516 0 -5.46895 0.00096239 0 -5.60511 0.000858495 0 -5.71972 0.000742981 0 + -5.81253 0.000613707 0 -5.88339 0.000466201 0 -5.93219 0.000293111 0 -5.96586 8.40713e-05 0 + 5.91867 0.0155944 0 5.88506 0.0379681 0 5.83646 0.0601883 0 5.76593 0.0822797 0 + 5.67359 0.104228 0 5.55961 0.125966 0 5.42424 0.147391 0 5.26784 0.168386 0 + 5.0909 0.188836 0 4.89401 0.208631 0 4.67785 0.227675 0 4.44321 0.245881 0 + 4.19094 0.263169 0 3.92199 0.279469 0 3.63737 0.294717 0 3.33812 0.308852 0 + 3.02539 0.321821 0 2.70034 0.333577 0 2.3642 0.344078 0 2.01823 0.353288 0 + 1.66373 0.361176 0 1.30204 0.367712 0 0.934517 0.372853 0 0.562607 0.376518 0 + 0.187869 0.37853 0 -0.187869 0.37853 0 -0.562607 0.376518 0 -0.934517 0.372853 0 + -1.30204 0.367712 0 -1.66373 0.361176 0 -2.01823 0.353288 0 -2.3642 0.344078 0 + -2.70034 0.333577 0 -3.02539 0.321821 0 -3.33812 0.308852 0 -3.63737 0.294717 0 + -3.92199 0.279469 0 -4.19094 0.263169 0 -4.44321 0.245881 0 -4.67785 0.227675 0 + -4.89401 0.208631 0 -5.0909 0.188836 0 -5.26784 0.168386 0 -5.42424 0.147391 0 + -5.55961 0.125966 0 -5.67359 0.104228 0 -5.76593 0.0822797 0 -5.83646 0.0601883 0 + -5.88506 0.0379681 0 -5.91867 0.0155944 0 5.7779 0.0308187 0 5.7446 0.0752088 0 + 5.69689 0.119246 0 5.62764 0.16301 0 5.53699 0.20648 0 5.42517 0.249523 0 + 5.29244 0.291935 0 5.13919 0.333486 0 4.96591 0.37395 0 4.77321 0.413115 0 + 4.56177 0.450792 0 4.33236 0.486812 0 4.08584 0.52102 0 3.82314 0.553276 0 + 3.54522 0.583453 0 3.25315 0.611433 0 2.94801 0.63711 0 2.63096 0.660387 0 + 2.30319 0.681181 0 1.96592 0.699417 0 1.62044 0.715033 0 1.26802 0.727965 0 + 0.910018 0.738127 0 0.547814 0.745359 0 0.18292 0.74932 0 -0.18292 0.74932 0 + -0.547814 0.745359 0 -0.910018 0.738127 0 -1.26802 0.727965 0 -1.62044 0.715033 0 + -1.96592 0.699417 0 -2.30319 0.681181 0 -2.63096 0.660387 0 -2.94801 0.63711 0 + -3.25315 0.611433 0 -3.54522 0.583453 0 -3.82314 0.553276 0 -4.08584 0.52102 0 + -4.33236 0.486812 0 -4.56177 0.450792 0 -4.77321 0.413115 0 -4.96591 0.37395 0 + -5.13919 0.333486 0 -5.29244 0.291935 0 -5.42517 0.249523 0 -5.53699 0.20648 0 + -5.62764 0.16301 0 -5.69689 0.119246 0 -5.7446 0.0752088 0 -5.7779 0.0308187 0 + 5.54588 0.0454118 0 5.51335 0.111396 0 5.46736 0.176747 0 5.4005 0.241632 0 + 5.31297 0.306032 0 5.20501 0.369755 0 5.07694 0.432503 0 4.92917 0.493941 0 + 4.7622 0.55374 0 4.57663 0.611596 0 4.37315 0.667234 0 4.15252 0.720409 0 + 3.91556 0.770896 0 3.66318 0.818492 0 3.39632 0.863009 0 3.116 0.904276 0 + 2.82327 0.942137 0 2.51923 0.976449 0 2.20503 1.00709 0 1.88185 1.03395 0 + 1.55091 1.05693 0 1.21344 1.07595 0 0.870733 1.09086 0 0.524107 1.10145 0 + 0.174992 1.10723 0 -0.174992 1.10723 0 -0.524107 1.10145 0 -0.870733 1.09086 0 + -1.21344 1.07595 0 -1.55091 1.05693 0 -1.88185 1.03395 0 -2.20503 1.00709 0 + -2.51923 0.976449 0 -2.82327 0.942137 0 -3.116 0.904276 0 -3.39632 0.863009 0 + -3.66318 0.818492 0 -3.91556 0.770896 0 -4.15252 0.720409 0 -4.37315 0.667234 0 + -4.57663 0.611596 0 -4.7622 0.55374 0 -4.92917 0.493941 0 -5.07694 0.432503 0 + -5.20501 0.369755 0 -5.31297 0.306032 0 -5.4005 0.241632 0 -5.46736 0.176747 0 + -5.51335 0.111396 0 -5.54588 0.0454118 0 5.22636 0.0590124 0 5.19515 0.145835 0 + 5.15175 0.231694 0 5.08845 0.31685 0 5.0055 0.401293 0 4.90317 0.484773 0 + 4.78182 0.566904 0 4.64188 0.647259 0 4.48385 0.725418 0 4.30834 0.800994 0 + 4.11602 0.873639 0 3.90762 0.943038 0 3.68393 1.0089 0 3.44582 1.07098 0 + 3.19419 1.12901 0 2.93 1.18279 0 2.65424 1.23211 0 2.36796 1.27679 0 + 2.07225 1.31666 0 1.76821 1.35159 0 1.45698 1.38145 0 1.13976 1.40612 0 + 0.817722 1.42543 0 0.49213 1.4391 0 0.164302 1.44653 0 -0.164302 1.44653 0 + -0.49213 1.4391 0 -0.817722 1.42543 0 -1.13976 1.40612 0 -1.45698 1.38145 0 + -1.76821 1.35159 0 -2.07225 1.31666 0 -2.36796 1.27679 0 -2.65424 1.23211 0 + -2.93 1.18279 0 -3.19419 1.12901 0 -3.44582 1.07098 0 -3.68393 1.0089 0 + -3.90762 0.943038 0 -4.11602 0.873639 0 -4.30834 0.800994 0 -4.48385 0.725418 0 + -4.64188 0.647259 0 -4.78182 0.566904 0 -4.90317 0.484773 0 -5.0055 0.401293 0 + -5.08845 0.31685 0 -5.15175 0.231694 0 -5.19515 0.145835 0 -5.22636 0.0590124 0 + 4.82445 0.0712729 0 4.79514 0.177834 0 4.75516 0.283079 0 4.69656 0.387361 0 + 4.61963 0.490667 0 4.52466 0.592689 0 4.41204 0.692963 0 4.2822 0.790981 0 + 4.13568 0.886247 0 3.97305 0.978306 0 3.79495 1.06675 0 3.60209 1.15119 0 + 3.39521 1.23131 0 3.17511 1.30678 0 2.94265 1.37731 0 2.6987 1.44264 0 + 2.4442 1.50252 0 2.18012 1.55674 0 1.90746 1.60509 0 1.62725 1.64741 0 + 1.34056 1.68355 0 1.04846 1.71335 0 0.752075 1.73662 0 0.452545 1.75303 0 + 0.15107 1.7619 0 -0.15107 1.7619 0 -0.452545 1.75303 0 -0.752075 1.73662 0 + -1.04846 1.71335 0 -1.34056 1.68355 0 -1.62725 1.64741 0 -1.90746 1.60509 0 + -2.18012 1.55674 0 -2.4442 1.50252 0 -2.6987 1.44264 0 -2.94265 1.37731 0 + -3.17511 1.30678 0 -3.39521 1.23131 0 -3.60209 1.15119 0 -3.79495 1.06675 0 + -3.97305 0.978306 0 -4.13568 0.886247 0 -4.2822 0.790981 0 -4.41204 0.692963 0 + -4.52466 0.592689 0 -4.61963 0.490667 0 -4.69656 0.387361 0 -4.75516 0.283079 0 + -4.79514 0.177834 0 -4.82445 0.0712729 0 4.34652 0.0818748 0 4.31972 0.206744 0 + 4.28393 0.329951 0 4.23109 0.451919 0 4.16152 0.57262 0 4.07553 0.691687 0 + 3.97353 0.808588 0 3.85598 0.922748 0 3.72337 1.03361 0 3.57626 1.14067 0 + 3.41527 1.24347 0 3.24104 1.34157 0 3.05425 1.4346 0 2.85564 1.52219 0 + 2.64598 1.60402 0 2.42609 1.67977 0 2.1968 1.74917 0 1.959 1.81197 0 + 1.71359 1.86793 0 1.46151 1.91686 0 1.20372 1.95858 0 0.941207 1.99292 0 + 0.674982 2.01966 0 0.406074 2.03843 0 0.13554 2.04851 0 -0.13554 2.04851 0 + -0.406074 2.03843 0 -0.674982 2.01966 0 -0.941207 1.99292 0 -1.20372 1.95858 0 + -1.46151 1.91686 0 -1.71359 1.86793 0 -1.959 1.81197 0 -2.1968 1.74917 0 + -2.42609 1.67977 0 -2.64598 1.60402 0 -2.85564 1.52219 0 -3.05425 1.4346 0 + -3.24104 1.34157 0 -3.41527 1.24347 0 -3.57626 1.14067 0 -3.72337 1.03361 0 + -3.85598 0.922748 0 -3.97353 0.808588 0 -4.07553 0.691687 0 -4.16152 0.57262 0 + -4.23109 0.451919 0 -4.28393 0.329951 0 -4.31972 0.206744 0 -4.34652 0.0818748 0 + 3.80014 0.0905388 0 3.77644 0.231985 0 3.74551 0.371443 0 3.69939 0.509379 0 + 3.63839 0.645732 0 3.56287 0.780078 0 3.47324 0.91183 0 3.36994 1.04036 0 + 3.25346 1.16509 0 3.12431 1.28545 0 2.98305 1.40095 0 2.83026 1.51112 0 + 2.66656 1.61554 0 2.49259 1.71382 0 2.30904 1.80559 0 2.11663 1.8905 0 + 1.91611 1.96825 0 1.70825 2.03856 0 1.49385 2.10116 0 1.27374 2.15583 0 + 1.04877 2.20237 0 0.819813 2.2406 0 0.58776 2.27027 0 0.353514 2.29099 0 + 0.117978 2.30203 0 -0.117978 2.30203 0 -0.353514 2.29099 0 -0.58776 2.27027 0 + -0.819813 2.2406 0 -1.04877 2.20237 0 -1.27374 2.15583 0 -1.49385 2.10116 0 + -1.70825 2.03856 0 -1.91611 1.96825 0 -2.11663 1.8905 0 -2.30904 1.80559 0 + -2.49259 1.71382 0 -2.66656 1.61554 0 -2.83026 1.51112 0 -2.98305 1.40095 0 + -3.12431 1.28545 0 -3.25346 1.16509 0 -3.36994 1.04036 0 -3.47324 0.91183 0 + -3.56287 0.780078 0 -3.63839 0.645732 0 -3.69939 0.509379 0 -3.74551 0.371443 0 + -3.77644 0.231985 0 -3.80014 0.0905388 0 3.19396 0.0970359 0 3.17388 0.253069 0 + 3.14837 0.406806 0 3.10978 0.558727 0 3.05843 0.708728 0 2.99469 0.856335 0 + 2.91898 1.00092 0 2.83171 1.14184 0 2.73333 1.27847 0 2.6243 1.41024 0 + 2.5051 1.53661 0 2.37625 1.6571 0 2.23827 1.77125 0 2.09172 1.87863 0 + 1.93719 1.97886 0 1.77528 2.07155 0 1.60664 2.15637 0 1.43193 2.23302 0 + 1.25181 2.3012 0 1.06702 2.36069 0 0.878255 2.41125 0 0.686279 2.45266 0 + 0.491851 2.48468 0 0.295737 2.50693 0 0.0986769 2.51868 0 -0.0986769 2.51868 0 + -0.295737 2.50693 0 -0.491851 2.48468 0 -0.686279 2.45266 0 -0.878255 2.41125 0 + -1.06702 2.36069 0 -1.25181 2.3012 0 -1.43193 2.23302 0 -1.60664 2.15637 0 + -1.77528 2.07155 0 -1.93719 1.97886 0 -2.09172 1.87863 0 -2.23827 1.77125 0 + -2.37625 1.6571 0 -2.5051 1.53661 0 -2.6243 1.41024 0 -2.73333 1.27847 0 + -2.83171 1.14184 0 -2.91898 1.00092 0 -2.99469 0.856335 0 -3.05843 0.708728 0 + -3.10978 0.558727 0 -3.14837 0.406806 0 -3.17388 0.253069 0 -3.19396 0.0970359 0 + 2.53753 0.101196 0 2.52152 0.269615 0 2.50186 0.435426 0 2.47146 0.599104 0 + 2.43065 0.760505 0 2.37982 0.919124 0 2.31935 1.07432 0 2.24963 1.22544 0 + 2.17105 1.37184 0 2.08399 1.51295 0 1.98887 1.64822 0 1.88608 1.77713 0 + 1.77609 1.8992 0 1.65932 2.01399 0 1.53627 2.12108 0 1.40743 2.22007 0 + 1.2733 2.31061 0 1.13443 2.39237 0 0.991358 2.46504 0 0.844663 2.52835 0 + 0.694934 2.58207 0 0.542782 2.62596 0 0.38883 2.65976 0 0.233697 2.68309 0 + 0.077956 2.69531 0 -0.077956 2.69531 0 -0.233697 2.68309 0 -0.38883 2.65976 0 + -0.542782 2.62596 0 -0.694934 2.58207 0 -0.844663 2.52835 0 -0.991358 2.46504 0 + -1.13443 2.39237 0 -1.2733 2.31061 0 -1.40743 2.22007 0 -1.53627 2.12108 0 + -1.65932 2.01399 0 -1.77609 1.8992 0 -1.88608 1.77713 0 -1.98887 1.64822 0 + -2.08399 1.51295 0 -2.17105 1.37184 0 -2.24963 1.22544 0 -2.31935 1.07432 0 + -2.37982 0.919124 0 -2.43065 0.760505 0 -2.47146 0.599104 0 -2.50186 0.435426 0 + -2.52152 0.269615 0 -2.53753 0.101196 0 1.8412 0.1029 0 1.82961 0.281387 0 + 1.81607 0.456856 0 1.79432 0.629828 0 1.76475 0.800155 0 1.72773 0.967328 0 + 1.6836 1.13072 0 1.63268 1.28967 0 1.57529 1.44358 0 1.51174 1.59183 0 + 1.44232 1.73388 0 1.36737 1.8692 0 1.2872 1.9973 0 1.20215 2.1177 0 + 1.11258 2.22999 0 1.01886 2.33373 0 0.921369 2.42857 0 0.8205 2.51415 0 + 0.716663 2.59016 0 0.610284 2.6563 0 0.501806 2.71233 0 0.391692 2.75798 0 + 0.280414 2.79298 0 0.168437 2.81699 0 0.0561652 2.82943 0 -0.0561652 2.82943 0 + -0.168437 2.81699 0 -0.280414 2.79298 0 -0.391692 2.75798 0 -0.501806 2.71233 0 + -0.610284 2.6563 0 -0.716663 2.59016 0 -0.8205 2.51415 0 -0.921369 2.42857 0 + -1.01886 2.33373 0 -1.11258 2.22999 0 -1.20215 2.1177 0 -1.2872 1.9973 0 + -1.36737 1.8692 0 -1.44232 1.73388 0 -1.51174 1.59183 0 -1.57529 1.44358 0 + -1.63268 1.28967 0 -1.6836 1.13072 0 -1.72773 0.967328 0 -1.76475 0.800155 0 + -1.79432 0.629828 0 -1.81607 0.456856 0 -1.82961 0.281387 0 -1.8412 0.1029 0 + 1.1161 0.10196 0 1.10918 0.288419 0 1.10167 0.47089 0 1.08877 0.650439 0 + 1.07089 0.826991 0 1.04834 1.00007 0 1.02137 1.16907 0 0.990237 1.33337 0 + 0.955141 1.49236 0 0.916286 1.64545 0 0.873873 1.79208 0 0.828106 1.93172 0 + 0.779194 2.06386 0 0.727352 2.18803 0 0.672804 2.30378 0 0.615781 2.41069 0 + 0.55652 2.50837 0 0.495268 2.59647 0 0.432281 2.67466 0 0.367824 2.74263 0 + 0.302181 2.80011 0 0.235648 2.84683 0 0.168534 2.88251 0 0.101139 2.90682 0 + 0.0337041 2.9193 0 -0.0337041 2.9193 0 -0.101139 2.90682 0 -0.168534 2.88251 0 + -0.235648 2.84683 0 -0.302181 2.80011 0 -0.367824 2.74263 0 -0.432281 2.67466 0 + -0.495268 2.59647 0 -0.55652 2.50837 0 -0.615781 2.41069 0 -0.672804 2.30378 0 + -0.727352 2.18803 0 -0.779194 2.06386 0 -0.828106 1.93172 0 -0.873873 1.79208 0 + -0.916286 1.64545 0 -0.955141 1.49236 0 -0.990237 1.33337 0 -1.02137 1.16907 0 + -1.04834 1.00007 0 -1.07089 0.826991 0 -1.08877 0.650439 0 -1.10167 0.47089 0 + -1.10918 0.288419 0 -1.1161 0.10196 0 0.374397 0.0973617 0 0.372345 0.286095 0 + 0.369713 0.471921 0 0.365391 0.655246 0 0.359328 0.835705 0 0.351634 1.01271 0 + 0.342423 1.18561 0 0.331788 1.35377 0 0.319812 1.51654 0 0.306573 1.6733 0 + 0.292146 1.82347 0 0.276606 1.96648 0 0.26003 2.10178 0 0.242498 2.22887 0 + 0.224088 2.34726 0 0.204883 2.45651 0 0.184967 2.55621 0 0.164423 2.64598 0 + 0.14334 2.72547 0 0.12181 2.79437 0 0.0999307 2.85239 0 0.0778091 2.8993 0 + 0.0555585 2.93484 0 0.0332903 2.9588 0 0.0110826 2.97093 0 -0.0110826 2.97093 0 + -0.0332903 2.9588 0 -0.0555585 2.93484 0 -0.0778091 2.8993 0 -0.0999307 2.85239 0 + -0.12181 2.79437 0 -0.14334 2.72547 0 -0.164423 2.64598 0 -0.184967 2.55621 0 + -0.204883 2.45651 0 -0.224088 2.34726 0 -0.242498 2.22887 0 -0.26003 2.10178 0 + -0.276606 1.96648 0 -0.292146 1.82347 0 -0.306573 1.6733 0 -0.319812 1.51654 0 + -0.331788 1.35377 0 -0.342423 1.18561 0 -0.351634 1.01271 0 -0.359328 0.835705 0 + -0.365391 0.655246 0 -0.369713 0.471921 0 -0.372345 0.286095 0 -0.374397 0.0973617 0 </DataArray> <DataArray type="Float32" Name="process rank" NumberOfComponents="1" format="ascii"> 0 0 0 0 0 0 0 0 0 0 0 0 diff --git a/test/references/test_ff_navierstokes_kovasznay_higherorder-reference.vtu b/test/references/test_ff_navierstokes_kovasznay_higherorder-reference.vtu new file mode 100644 index 0000000000000000000000000000000000000000..2c535c6561fa828f87cfb6be1d238c3b5272bc51 --- /dev/null +++ b/test/references/test_ff_navierstokes_kovasznay_higherorder-reference.vtu @@ -0,0 +1,4022 @@ +<?xml version="1.0"?> +<VTKFile type="UnstructuredGrid" version="0.1" byte_order="LittleEndian"> + <UnstructuredGrid> + <Piece NumberOfCells="2500" NumberOfPoints="2601"> + <CellData Scalars="p" Vectors="velocity_liq (m/s)"> + <DataArray type="Float32" Name="p" NumberOfComponents="1" format="ascii"> + -0.749079 -0.620556 -0.510736 -0.41808 -0.332957 -0.255012 -0.183798 -0.118829 -0.0596193 -0.00569639 0.0433858 0.0880435 + 0.128662 0.165598 0.199176 0.229696 0.257432 0.282635 0.305533 0.326335 0.345232 0.362397 0.377988 0.392148 + 0.405009 0.41669 0.427298 0.436931 0.44568 0.453624 0.460838 0.467388 0.473334 0.478733 0.483632 0.488079 + 0.492113 0.495774 0.499094 0.502105 0.504838 0.507319 0.509577 0.51164 0.513536 0.515302 0.516983 0.51865 + 0.520446 0.524228 -0.749079 -0.623404 -0.512567 -0.419217 -0.333714 -0.255553 -0.18421 -0.11916 -0.0598953 -0.00593221 + 0.0431808 0.0878631 0.128502 0.165454 0.199046 0.229579 0.257326 0.282538 0.305445 0.326254 0.345158 0.362329 + 0.377926 0.392092 0.404958 0.416643 0.427255 0.436893 0.445645 0.453592 0.460809 0.467362 0.473311 0.478711 + 0.483612 0.488061 0.492096 0.495758 0.499079 0.502091 0.504824 0.507307 0.509565 0.511629 0.513527 0.515294 + 0.516974 0.518627 0.520332 0.523461 -0.749079 -0.624401 -0.514331 -0.420223 -0.334273 -0.255851 -0.184354 -0.119212 + -0.0598894 -0.00589064 0.0432444 0.0879398 0.128586 0.16554 0.199132 0.229662 0.257405 0.282613 0.305515 0.32632 + 0.345218 0.362385 0.377977 0.392138 0.405 0.416682 0.427291 0.436925 0.445675 0.45362 0.460834 0.467385 + 0.473332 0.478731 0.483631 0.488077 0.492111 0.495771 0.49909 0.5021 0.50483 0.507308 0.509562 0.511618 + 0.513504 0.515254 0.516903 0.518496 0.520077 0.522749 -0.749079 -0.624686 -0.516181 -0.421398 -0.335026 -0.256338 + -0.184669 -0.11941 -0.0600067 -0.0059501 0.0432266 0.0879518 0.128619 0.165587 0.199188 0.229724 0.257469 0.282677 + 0.305577 0.326379 0.345275 0.362438 0.378027 0.392185 0.405044 0.416722 0.427328 0.43696 0.445707 0.45365 + 0.460862 0.467411 0.473357 0.478754 0.483652 0.488097 0.49213 0.495788 0.499104 0.502111 0.504837 0.507309 + 0.509553 0.511596 0.513462 0.51518 0.516782 0.518298 0.519759 0.522012 -0.749079 -0.624583 -0.517751 -0.422438 + -0.335741 -0.256845 -0.185032 -0.119668 -0.0601845 -0.00606599 0.0431588 0.087921 0.128616 0.165605 0.199221 0.229767 + 0.257518 0.28273 0.305632 0.326434 0.345329 0.36249 0.378076 0.392232 0.405088 0.416763 0.427367 0.436996 + 0.445741 0.453682 0.460893 0.46744 0.473384 0.47878 0.483677 0.488121 0.492152 0.495808 0.499122 0.502125 + 0.504846 0.507311 0.509544 0.511568 0.513409 0.515088 0.516632 0.518065 0.51941 0.52122 -0.749079 -0.624222 + -0.518751 -0.423109 -0.336227 -0.257211 -0.185308 -0.119873 -0.0603302 -0.00616242 0.0431027 0.0878975 0.128618 0.165627 + 0.199258 0.229813 0.257572 0.282788 0.305691 0.326494 0.345388 0.362547 0.378131 0.392284 0.405138 0.416811 + 0.427411 0.437038 0.44578 0.453719 0.460928 0.467473 0.473416 0.47881 0.483706 0.488149 0.492179 0.495833 + 0.499145 0.502145 0.504861 0.507317 0.509538 0.511544 0.513356 0.514993 0.516476 0.517823 0.519051 0.520389 + -0.749079 -0.623766 -0.519322 -0.42356 -0.336626 -0.257559 -0.185602 -0.120112 -0.0605185 -0.00630454 0.043001 0.0878303 + 0.128579 0.165612 0.19926 0.22983 0.257599 0.282822 0.305731 0.326536 0.345432 0.362591 0.378175 0.392327 + 0.405179 0.41685 0.427449 0.437074 0.445815 0.453752 0.46096 0.467504 0.473445 0.478839 0.483734 0.488176 + 0.492205 0.495858 0.499169 0.502166 0.504877 0.507326 0.509535 0.511523 0.513308 0.514904 0.516327 0.517589 + 0.5187 0.519562 -0.749079 -0.624733 -0.52008 -0.424401 -0.337459 -0.258346 -0.18633 -0.120778 -0.0611224 -0.00684931 + 0.0425119 0.0873928 0.128189 0.165265 0.198953 0.229557 0.257358 0.282609 0.305542 0.32637 0.345284 0.362461 + 0.378059 0.392225 0.405088 0.41677 0.427379 0.437012 0.445761 0.453705 0.460919 0.467469 0.473416 0.478815 + 0.483715 0.488161 0.492195 0.495851 0.499164 0.502163 0.504874 0.50732 0.509522 0.511497 0.51326 0.514822 + 0.516192 0.517376 0.518375 0.518788 -0.749079 -0.624039 -0.519443 -0.424066 -0.33726 -0.25821 -0.186224 -0.120686 + -0.0610377 -0.00676771 0.0425924 0.0874732 0.12827 0.165346 0.199033 0.229637 0.257436 0.282685 0.305617 0.326442 + 0.345353 0.362527 0.378122 0.392284 0.405145 0.416824 0.427429 0.43706 0.445806 0.453748 0.46096 0.467508 + 0.473454 0.478852 0.483751 0.488197 0.49223 0.495887 0.499199 0.502197 0.504906 0.507349 0.509544 0.511508 + 0.513252 0.514785 0.51611 0.517226 0.518123 0.518141 -0.749079 -0.623525 -0.518995 -0.423829 -0.337123 -0.258125 + -0.186167 -0.120645 -0.0610061 -0.00674152 0.0426156 0.087495 0.128292 0.165368 0.199056 0.229661 0.257461 0.282711 + 0.305643 0.326469 0.345381 0.362554 0.378149 0.392311 0.405171 0.416849 0.427454 0.437085 0.44583 0.453772 + 0.460983 0.467532 0.473478 0.478876 0.483776 0.488223 0.492258 0.495915 0.499229 0.502229 0.504938 0.50738 + 0.509573 0.511531 0.513264 0.514778 0.51607 0.517135 0.517953 0.517651 -0.749079 -0.623153 -0.518726 -0.423639 + -0.336987 -0.258023 -0.186089 -0.120584 -0.060957 -0.0067017 0.0426485 0.0875227 0.128316 0.165389 0.199076 0.22968 + 0.25748 0.28273 0.305662 0.326487 0.345399 0.362573 0.378168 0.39233 0.40519 0.416868 0.427473 0.437103 + 0.445849 0.45379 0.461002 0.467551 0.473498 0.478897 0.483799 0.488247 0.492283 0.495944 0.49926 0.502262 + 0.504975 0.507419 0.509614 0.511572 0.513302 0.514807 0.516082 0.517115 0.517882 0.517346 -0.749079 -0.622867 + -0.518549 -0.423499 -0.336869 -0.257924 -0.186005 -0.120513 -0.0608979 -0.00665232 0.0426898 0.0875575 0.128345 0.165415 + 0.199099 0.229701 0.257499 0.282748 0.305679 0.326504 0.345415 0.362589 0.378184 0.392346 0.405205 0.416883 + 0.427488 0.437119 0.445864 0.453806 0.461019 0.467569 0.473516 0.478917 0.48382 0.48827 0.492309 0.495972 + 0.499293 0.502299 0.505016 0.507466 0.509667 0.511631 0.513367 0.514875 0.51615 0.517174 0.517903 0.517302 + -0.749079 -0.622733 -0.518454 -0.423413 -0.336789 -0.25785 -0.185938 -0.120454 -0.0608453 -0.00660653 0.0427293 0.0875914 + 0.128374 0.16544 0.19912 0.22972 0.257516 0.282763 0.305694 0.326518 0.345429 0.362602 0.378197 0.392358 + 0.405218 0.416896 0.427501 0.437132 0.445878 0.45382 0.461033 0.467584 0.473533 0.478935 0.48384 0.488293 + 0.492335 0.496002 0.499327 0.502339 0.505063 0.507522 0.509732 0.511709 0.51346 0.514983 0.516278 0.517324 + 0.518067 0.517483 -0.749079 -0.622842 -0.518511 -0.423451 -0.336814 -0.257866 -0.185949 -0.12046 -0.0608504 -0.0066111 + 0.0427246 0.0875862 0.128368 0.165434 0.199114 0.229713 0.25751 0.282758 0.305688 0.326513 0.345425 0.3626 + 0.378195 0.392358 0.405219 0.416898 0.427504 0.437135 0.445882 0.453826 0.461041 0.467593 0.473543 0.478948 + 0.483855 0.488312 0.492358 0.49603 0.499361 0.502381 0.505115 0.507585 0.509811 0.511804 0.513575 0.515133 + 0.516466 0.517558 0.518406 0.517861 -0.749079 -0.623095 -0.518646 -0.423541 -0.336877 -0.25791 -0.185979 -0.120482 + -0.0608669 -0.00662442 0.0427129 0.0875753 0.128358 0.165423 0.199104 0.229703 0.2575 0.282749 0.30568 0.326506 + 0.345419 0.362594 0.378191 0.392354 0.405216 0.416897 0.427504 0.437137 0.445885 0.45383 0.461047 0.467601 + 0.473553 0.47896 0.483871 0.488332 0.492382 0.49606 0.499399 0.502428 0.505174 0.507659 0.509903 0.511922 + 0.513726 0.515324 0.516715 0.517889 0.518824 0.518487 -0.749079 -0.623426 -0.518869 -0.423681 -0.336964 -0.257964 + -0.186014 -0.120506 -0.060884 -0.0066383 0.0427004 0.0875632 0.128346 0.165411 0.199091 0.229691 0.257488 0.282737 + 0.305669 0.326495 0.345409 0.362586 0.378184 0.392348 0.405212 0.416893 0.427502 0.437136 0.445886 0.453833 + 0.461051 0.467608 0.473563 0.478973 0.483887 0.488352 0.492409 0.496094 0.499441 0.502481 0.505241 0.507744 + 0.510011 0.51206 0.513905 0.515556 0.517018 0.518291 0.519356 0.519329 -0.749079 -0.623894 -0.519275 -0.423878 + -0.337063 -0.258016 -0.186043 -0.120524 -0.0608988 -0.00665252 0.0426853 0.0875467 0.128328 0.165392 0.199071 0.22967 + 0.257467 0.282717 0.305649 0.326477 0.345392 0.36257 0.37817 0.392336 0.405201 0.416884 0.427495 0.437131 + 0.445883 0.453833 0.461053 0.467612 0.473571 0.478984 0.483903 0.488373 0.492436 0.496129 0.499487 0.50254 + 0.505316 0.50784 0.510134 0.512219 0.51411 0.515824 0.517371 0.518758 0.519978 0.520352 -0.749079 -0.624561 + -0.519901 -0.424205 -0.337256 -0.258148 -0.186148 -0.120617 -0.060986 -0.00673742 0.0426016 0.087464 0.128246 0.165312 + 0.198994 0.229596 0.257397 0.28265 0.305587 0.326419 0.345338 0.362521 0.378125 0.392295 0.405165 0.416852 + 0.427467 0.437107 0.445863 0.453816 0.461041 0.467604 0.473567 0.478986 0.483911 0.488388 0.492459 0.496161 + 0.499531 0.502598 0.505393 0.507941 0.510267 0.512392 0.514336 0.516119 0.517759 0.519271 0.520661 0.521514 + -0.749079 -0.623607 -0.519161 -0.423375 -0.336431 -0.257369 -0.18543 -0.119964 -0.060398 -0.00621037 0.0430725 0.0878838 + 0.12862 0.165645 0.19929 0.22986 0.257633 0.282861 0.305776 0.326589 0.345491 0.362659 0.37825 0.392409 + 0.405268 0.416947 0.427554 0.437188 0.445938 0.453887 0.461108 0.467669 0.473631 0.479049 0.483975 0.488454 + 0.492529 0.496238 0.499617 0.502698 0.50551 0.508081 0.510438 0.512604 0.514603 0.516459 0.518195 0.519836 + 0.521398 0.522779 -0.749079 -0.62423 -0.518729 -0.423049 -0.336139 -0.25711 -0.185207 -0.11978 -0.0602498 -0.00609461 + 0.04316 0.0879475 0.128664 0.165673 0.199306 0.229867 0.257632 0.282855 0.305766 0.326577 0.345479 0.362646 + 0.378237 0.392397 0.405258 0.416938 0.427547 0.437183 0.445936 0.453887 0.461111 0.467675 0.473641 0.479063 + 0.483994 0.48848 0.492563 0.496283 0.499674 0.50277 0.505603 0.5082 0.51059 0.5128 0.514856 0.516785 + 0.518616 0.520383 0.522112 0.524047 -0.749079 -0.624927 -0.517972 -0.422568 -0.335796 -0.256848 -0.185004 -0.119624 + -0.0601331 -0.00601136 0.0432153 0.08798 0.128678 0.165673 0.199295 0.229848 0.257608 0.282827 0.305737 0.326547 + 0.345449 0.362618 0.378211 0.392373 0.405236 0.416919 0.427531 0.437169 0.445925 0.45388 0.461107 0.467675 + 0.473645 0.479073 0.48401 0.488503 0.492594 0.496323 0.499727 0.50284 0.505693 0.508316 0.510739 0.512991 + 0.515101 0.5171 0.519022 0.520904 0.522784 0.525262 -0.749079 -0.625622 -0.516796 -0.421811 -0.335272 -0.256463 + -0.184711 -0.119399 -0.0599611 -0.00588195 0.0433102 0.0880468 0.128723 0.1657 0.199308 0.229851 0.257603 0.282817 + 0.305724 0.326532 0.345433 0.362601 0.378195 0.392358 0.405223 0.416907 0.427521 0.437162 0.44592 0.453878 + 0.461108 0.467679 0.473653 0.479085 0.484027 0.488526 0.492625 0.496363 0.499779 0.502906 0.505777 0.508423 + 0.510876 0.513166 0.515324 0.517385 0.519386 0.521368 0.523377 0.526347 -0.749079 -0.626263 -0.51549 -0.420974 + -0.33471 -0.256067 -0.184422 -0.119184 -0.0598002 -0.00576292 0.0433962 0.0881067 0.128762 0.165723 0.199319 0.229852 + 0.257598 0.282808 0.305711 0.326518 0.345418 0.362586 0.378181 0.392345 0.405211 0.416897 0.427512 0.437155 + 0.445916 0.453875 0.461108 0.467682 0.473659 0.479095 0.484041 0.488545 0.49265 0.496396 0.499822 0.502961 + 0.505847 0.508512 0.51099 0.513311 0.515509 0.517621 0.519684 0.521745 0.523853 0.52723 -0.749079 -0.626637 + -0.514353 -0.420265 -0.334253 -0.255761 -0.18421 -0.119033 -0.059693 -0.00568787 0.0434468 0.0881385 0.12878 0.165729 + 0.199318 0.229845 0.257586 0.282793 0.305695 0.326501 0.345401 0.36257 0.378165 0.392331 0.405198 0.416886 + 0.427503 0.437148 0.44591 0.453871 0.461106 0.467682 0.473662 0.4791 0.48405 0.488558 0.492667 0.496419 + 0.499852 0.502999 0.505897 0.508576 0.511071 0.513415 0.515641 0.517788 0.519896 0.52201 0.524184 0.527846 + -0.749079 -0.626534 -0.513725 -0.419909 -0.334047 -0.255641 -0.18414 -0.118995 -0.0596762 -0.00568534 0.0434393 0.0881239 + 0.12876 0.165707 0.199293 0.229819 0.25756 0.282768 0.30567 0.326477 0.345379 0.36255 0.378146 0.392314 + 0.405182 0.416872 0.42749 0.437137 0.4459 0.453864 0.4611 0.467678 0.473659 0.479099 0.484051 0.488561 + 0.492674 0.496429 0.499865 0.503018 0.505921 0.508608 0.511112 0.513467 0.515709 0.517874 0.520004 0.522146 + 0.524351 0.52815 -0.749079 -0.626534 -0.513725 -0.419909 -0.334047 -0.255641 -0.18414 -0.118995 -0.0596762 -0.00568534 + 0.0434393 0.0881239 0.12876 0.165707 0.199293 0.229819 0.25756 0.282768 0.30567 0.326477 0.345379 0.36255 + 0.378146 0.392314 0.405182 0.416872 0.42749 0.437137 0.4459 0.453864 0.4611 0.467678 0.473659 0.479099 + 0.484051 0.488561 0.492674 0.496429 0.499865 0.503018 0.505921 0.508608 0.511112 0.513467 0.515709 0.517874 + 0.520004 0.522146 0.524351 0.52815 -0.749079 -0.626637 -0.514353 -0.420265 -0.334253 -0.255761 -0.18421 -0.119033 + -0.059693 -0.00568787 0.0434468 0.0881385 0.12878 0.165729 0.199318 0.229845 0.257586 0.282793 0.305695 0.326501 + 0.345401 0.36257 0.378165 0.392331 0.405198 0.416886 0.427503 0.437148 0.44591 0.453871 0.461106 0.467682 + 0.473662 0.4791 0.48405 0.488558 0.492667 0.496419 0.499852 0.502999 0.505897 0.508576 0.511071 0.513415 + 0.515641 0.517788 0.519896 0.52201 0.524184 0.527846 -0.749079 -0.626263 -0.51549 -0.420974 -0.33471 -0.256067 + -0.184422 -0.119184 -0.0598002 -0.00576292 0.0433962 0.0881067 0.128762 0.165723 0.199319 0.229852 0.257598 0.282808 + 0.305711 0.326518 0.345418 0.362586 0.378181 0.392345 0.405211 0.416897 0.427512 0.437155 0.445916 0.453875 + 0.461108 0.467682 0.473659 0.479095 0.484041 0.488545 0.49265 0.496396 0.499822 0.502961 0.505847 0.508512 + 0.51099 0.513311 0.515509 0.517621 0.519684 0.521745 0.523853 0.52723 -0.749079 -0.625622 -0.516796 -0.421811 + -0.335272 -0.256463 -0.184711 -0.119399 -0.0599611 -0.00588195 0.0433102 0.0880468 0.128723 0.1657 0.199308 0.229851 + 0.257603 0.282817 0.305724 0.326532 0.345433 0.362601 0.378195 0.392358 0.405223 0.416907 0.427521 0.437162 + 0.44592 0.453878 0.461108 0.467679 0.473653 0.479085 0.484027 0.488526 0.492625 0.496363 0.499779 0.502906 + 0.505777 0.508423 0.510876 0.513166 0.515324 0.517385 0.519386 0.521368 0.523377 0.526347 -0.749079 -0.624927 + -0.517972 -0.422568 -0.335796 -0.256848 -0.185004 -0.119624 -0.0601331 -0.00601136 0.0432153 0.08798 0.128678 0.165673 + 0.199295 0.229848 0.257608 0.282827 0.305737 0.326547 0.345449 0.362618 0.378211 0.392373 0.405236 0.416919 + 0.427531 0.437169 0.445925 0.45388 0.461107 0.467675 0.473645 0.479073 0.48401 0.488503 0.492594 0.496323 + 0.499727 0.50284 0.505693 0.508316 0.510739 0.512991 0.515101 0.5171 0.519022 0.520904 0.522784 0.525262 + -0.749079 -0.62423 -0.518729 -0.423049 -0.336139 -0.25711 -0.185207 -0.11978 -0.0602498 -0.00609461 0.04316 0.0879475 + 0.128664 0.165673 0.199306 0.229867 0.257632 0.282855 0.305766 0.326577 0.345479 0.362646 0.378237 0.392397 + 0.405258 0.416938 0.427547 0.437183 0.445936 0.453887 0.461111 0.467675 0.473641 0.479063 0.483994 0.48848 + 0.492563 0.496283 0.499674 0.50277 0.505603 0.5082 0.51059 0.5128 0.514856 0.516785 0.518616 0.520383 + 0.522112 0.524047 -0.749079 -0.623607 -0.519161 -0.423375 -0.336431 -0.257369 -0.18543 -0.119964 -0.060398 -0.00621037 + 0.0430725 0.0878838 0.12862 0.165645 0.19929 0.22986 0.257633 0.282861 0.305776 0.326589 0.345491 0.362659 + 0.37825 0.392409 0.405268 0.416947 0.427554 0.437188 0.445938 0.453887 0.461108 0.467669 0.473631 0.479049 + 0.483975 0.488454 0.492529 0.496238 0.499617 0.502698 0.50551 0.508081 0.510438 0.512604 0.514603 0.516459 + 0.518195 0.519836 0.521398 0.522779 -0.749079 -0.624561 -0.519901 -0.424205 -0.337256 -0.258148 -0.186148 -0.120617 + -0.060986 -0.00673742 0.0426016 0.087464 0.128246 0.165312 0.198994 0.229596 0.257397 0.28265 0.305587 0.326419 + 0.345338 0.362521 0.378125 0.392295 0.405165 0.416852 0.427467 0.437107 0.445863 0.453816 0.461041 0.467604 + 0.473567 0.478986 0.483911 0.488388 0.492459 0.496161 0.499531 0.502598 0.505393 0.507941 0.510267 0.512392 + 0.514336 0.516119 0.517759 0.519271 0.520661 0.521514 -0.749079 -0.623894 -0.519275 -0.423878 -0.337063 -0.258016 + -0.186043 -0.120524 -0.0608988 -0.00665252 0.0426853 0.0875467 0.128328 0.165392 0.199071 0.22967 0.257467 0.282717 + 0.305649 0.326477 0.345392 0.36257 0.37817 0.392336 0.405201 0.416884 0.427495 0.437131 0.445883 0.453833 + 0.461053 0.467612 0.473571 0.478984 0.483903 0.488373 0.492436 0.496129 0.499487 0.50254 0.505316 0.50784 + 0.510134 0.512219 0.51411 0.515824 0.517371 0.518758 0.519978 0.520352 -0.749079 -0.623426 -0.518869 -0.423681 + -0.336964 -0.257964 -0.186014 -0.120506 -0.060884 -0.0066383 0.0427004 0.0875632 0.128346 0.165411 0.199091 0.229691 + 0.257488 0.282737 0.305669 0.326495 0.345409 0.362586 0.378184 0.392348 0.405212 0.416893 0.427502 0.437136 + 0.445886 0.453833 0.461051 0.467608 0.473563 0.478973 0.483887 0.488352 0.492409 0.496094 0.499441 0.502481 + 0.505241 0.507744 0.510011 0.51206 0.513905 0.515556 0.517018 0.518291 0.519356 0.519329 -0.749079 -0.623095 + -0.518646 -0.423541 -0.336877 -0.25791 -0.185979 -0.120482 -0.0608669 -0.00662442 0.0427129 0.0875753 0.128358 0.165423 + 0.199104 0.229703 0.2575 0.282749 0.30568 0.326506 0.345419 0.362594 0.378191 0.392354 0.405216 0.416897 + 0.427504 0.437137 0.445885 0.45383 0.461047 0.467601 0.473553 0.47896 0.483871 0.488332 0.492382 0.49606 + 0.499399 0.502428 0.505174 0.507659 0.509903 0.511922 0.513726 0.515324 0.516715 0.517889 0.518824 0.518487 + -0.749079 -0.622842 -0.518511 -0.423451 -0.336814 -0.257866 -0.185949 -0.12046 -0.0608504 -0.0066111 0.0427246 0.0875862 + 0.128368 0.165434 0.199114 0.229713 0.25751 0.282758 0.305688 0.326513 0.345425 0.3626 0.378195 0.392358 + 0.405219 0.416898 0.427504 0.437135 0.445882 0.453826 0.461041 0.467593 0.473543 0.478948 0.483855 0.488312 + 0.492358 0.49603 0.499361 0.502381 0.505115 0.507585 0.509811 0.511804 0.513575 0.515133 0.516466 0.517558 + 0.518406 0.517861 -0.749079 -0.622733 -0.518454 -0.423413 -0.336789 -0.25785 -0.185938 -0.120454 -0.0608453 -0.00660653 + 0.0427293 0.0875914 0.128374 0.16544 0.19912 0.22972 0.257516 0.282763 0.305694 0.326518 0.345429 0.362602 + 0.378197 0.392358 0.405218 0.416896 0.427501 0.437132 0.445878 0.45382 0.461033 0.467584 0.473533 0.478935 + 0.48384 0.488293 0.492335 0.496002 0.499327 0.502339 0.505063 0.507522 0.509732 0.511709 0.51346 0.514983 + 0.516278 0.517324 0.518067 0.517483 -0.749079 -0.622867 -0.518549 -0.423499 -0.336869 -0.257924 -0.186005 -0.120513 + -0.0608979 -0.00665232 0.0426898 0.0875575 0.128345 0.165415 0.199099 0.229701 0.257499 0.282748 0.305679 0.326504 + 0.345415 0.362589 0.378184 0.392346 0.405205 0.416883 0.427488 0.437119 0.445864 0.453806 0.461019 0.467569 + 0.473516 0.478917 0.48382 0.48827 0.492309 0.495972 0.499293 0.502299 0.505016 0.507466 0.509667 0.511631 + 0.513367 0.514875 0.51615 0.517174 0.517903 0.517302 -0.749079 -0.623153 -0.518726 -0.423639 -0.336987 -0.258023 + -0.186089 -0.120584 -0.060957 -0.0067017 0.0426485 0.0875227 0.128316 0.165389 0.199076 0.22968 0.25748 0.28273 + 0.305662 0.326487 0.345399 0.362573 0.378168 0.39233 0.40519 0.416868 0.427473 0.437103 0.445849 0.45379 + 0.461002 0.467551 0.473498 0.478897 0.483799 0.488247 0.492283 0.495944 0.49926 0.502262 0.504975 0.507419 + 0.509614 0.511572 0.513302 0.514807 0.516082 0.517115 0.517882 0.517346 -0.749079 -0.623525 -0.518995 -0.423829 + -0.337123 -0.258125 -0.186167 -0.120645 -0.0610061 -0.00674152 0.0426156 0.087495 0.128292 0.165368 0.199056 0.229661 + 0.257461 0.282711 0.305643 0.326469 0.345381 0.362554 0.378149 0.392311 0.405171 0.416849 0.427454 0.437085 + 0.44583 0.453772 0.460983 0.467532 0.473478 0.478876 0.483776 0.488223 0.492258 0.495915 0.499229 0.502229 + 0.504938 0.50738 0.509573 0.511531 0.513264 0.514778 0.51607 0.517135 0.517953 0.517651 -0.749079 -0.624039 + -0.519443 -0.424066 -0.33726 -0.25821 -0.186224 -0.120686 -0.0610377 -0.00676771 0.0425924 0.0874732 0.12827 0.165346 + 0.199033 0.229637 0.257436 0.282685 0.305617 0.326442 0.345353 0.362527 0.378122 0.392284 0.405145 0.416824 + 0.427429 0.43706 0.445806 0.453748 0.46096 0.467508 0.473454 0.478852 0.483751 0.488197 0.49223 0.495887 + 0.499199 0.502197 0.504906 0.507349 0.509544 0.511508 0.513252 0.514785 0.51611 0.517226 0.518123 0.518141 + -0.749079 -0.624733 -0.52008 -0.424401 -0.337459 -0.258346 -0.18633 -0.120778 -0.0611224 -0.00684931 0.0425119 0.0873928 + 0.128189 0.165265 0.198953 0.229557 0.257358 0.282609 0.305542 0.32637 0.345284 0.362461 0.378059 0.392225 + 0.405088 0.41677 0.427379 0.437012 0.445761 0.453705 0.460919 0.467469 0.473416 0.478815 0.483715 0.488161 + 0.492195 0.495851 0.499164 0.502163 0.504874 0.50732 0.509522 0.511497 0.51326 0.514822 0.516192 0.517376 + 0.518375 0.518788 -0.749079 -0.623766 -0.519322 -0.42356 -0.336626 -0.257559 -0.185602 -0.120112 -0.0605185 -0.00630454 + 0.043001 0.0878303 0.128579 0.165612 0.19926 0.22983 0.257599 0.282822 0.305731 0.326536 0.345432 0.362591 + 0.378175 0.392327 0.405179 0.41685 0.427449 0.437074 0.445815 0.453752 0.46096 0.467504 0.473445 0.478839 + 0.483734 0.488176 0.492205 0.495858 0.499169 0.502166 0.504877 0.507326 0.509535 0.511523 0.513308 0.514904 + 0.516327 0.517589 0.5187 0.519562 -0.749079 -0.624222 -0.518751 -0.423109 -0.336227 -0.257211 -0.185308 -0.119873 + -0.0603302 -0.00616242 0.0431027 0.0878975 0.128618 0.165627 0.199258 0.229813 0.257572 0.282788 0.305691 0.326494 + 0.345388 0.362547 0.378131 0.392284 0.405138 0.416811 0.427411 0.437038 0.44578 0.453719 0.460928 0.467473 + 0.473416 0.47881 0.483706 0.488149 0.492179 0.495833 0.499145 0.502145 0.504861 0.507317 0.509538 0.511544 + 0.513356 0.514993 0.516476 0.517823 0.519051 0.520389 -0.749079 -0.624583 -0.517751 -0.422438 -0.335741 -0.256845 + -0.185032 -0.119668 -0.0601845 -0.00606599 0.0431588 0.087921 0.128616 0.165605 0.199221 0.229767 0.257518 0.28273 + 0.305632 0.326434 0.345329 0.36249 0.378076 0.392232 0.405088 0.416763 0.427367 0.436996 0.445741 0.453682 + 0.460893 0.46744 0.473384 0.47878 0.483677 0.488121 0.492152 0.495808 0.499122 0.502125 0.504846 0.507311 + 0.509544 0.511568 0.513409 0.515088 0.516632 0.518065 0.51941 0.52122 -0.749079 -0.624686 -0.516181 -0.421398 + -0.335026 -0.256338 -0.184669 -0.11941 -0.0600067 -0.0059501 0.0432266 0.0879518 0.128619 0.165587 0.199188 0.229724 + 0.257469 0.282677 0.305577 0.326379 0.345275 0.362438 0.378027 0.392185 0.405044 0.416722 0.427328 0.43696 + 0.445707 0.45365 0.460862 0.467411 0.473357 0.478754 0.483652 0.488097 0.49213 0.495788 0.499104 0.502111 + 0.504837 0.507309 0.509553 0.511596 0.513462 0.51518 0.516782 0.518298 0.519759 0.522012 -0.749079 -0.624401 + -0.514331 -0.420223 -0.334273 -0.255851 -0.184354 -0.119212 -0.0598894 -0.00589064 0.0432444 0.0879398 0.128586 0.16554 + 0.199132 0.229662 0.257405 0.282613 0.305515 0.32632 0.345218 0.362385 0.377977 0.392138 0.405 0.416682 + 0.427291 0.436925 0.445675 0.45362 0.460834 0.467385 0.473332 0.478731 0.483631 0.488077 0.492111 0.495771 + 0.49909 0.5021 0.50483 0.507308 0.509562 0.511618 0.513504 0.515254 0.516903 0.518496 0.520077 0.522749 + -0.749079 -0.623404 -0.512567 -0.419217 -0.333714 -0.255553 -0.18421 -0.11916 -0.0598953 -0.00593221 0.0431808 0.0878631 + 0.128502 0.165454 0.199046 0.229579 0.257326 0.282538 0.305445 0.326254 0.345158 0.362329 0.377926 0.392092 + 0.404958 0.416643 0.427255 0.436893 0.445645 0.453592 0.460809 0.467362 0.473311 0.478711 0.483612 0.488061 + 0.492096 0.495758 0.499079 0.502091 0.504824 0.507307 0.509565 0.511629 0.513527 0.515294 0.516974 0.518627 + 0.520332 0.523461 -0.749079 -0.620556 -0.510736 -0.41808 -0.332957 -0.255012 -0.183798 -0.118829 -0.0596193 -0.00569639 + 0.0433858 0.0880435 0.128662 0.165598 0.199176 0.229696 0.257432 0.282635 0.305533 0.326335 0.345232 0.362397 + 0.377988 0.392148 0.405009 0.41669 0.427298 0.436931 0.44568 0.453624 0.460838 0.467388 0.473334 0.478733 + 0.483632 0.488079 0.492113 0.495774 0.499094 0.502105 0.504838 0.507319 0.509577 0.51164 0.513536 0.515302 + 0.516983 0.51865 0.520446 0.524228 + </DataArray> + <DataArray type="Float32" Name="rho" NumberOfComponents="1" format="ascii"> + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 1 1 1 1 1 1 1 1 + 1 1 1 1 + </DataArray> + <DataArray type="Float32" Name="velocity_liq (m/s)" NumberOfComponents="3" format="ascii"> + 2.57602 0.0299003 0 2.50966 0.0288379 0 2.43899 0.0277012 0 2.37125 0.0264925 0 + 2.30654 0.0252746 0 2.24484 0.0240858 0 2.18605 0.0229433 0 2.13006 0.0218524 0 + 2.07673 0.0208135 0 2.02593 0.0198248 0 1.97754 0.0188841 0 1.93145 0.0179888 0 + 1.88754 0.0171367 0 1.84572 0.0163255 0 1.80587 0.0155533 0 1.7679 0.014818 0 + 1.73173 0.0141178 0 1.69727 0.0134511 0 1.66444 0.0128162 0 1.63315 0.0122115 0 + 1.60335 0.0116356 0 1.57494 0.011087 0 1.54788 0.0105645 0 1.52209 0.0100667 0 + 1.49751 0.00959245 0 1.4741 0.00914065 0 1.45178 0.0087102 0 1.43052 0.00830005 0 + 1.41026 0.00790925 0 1.39095 0.00753685 0 1.37255 0.00718199 0 1.35502 0.00684383 0 + 1.33832 0.00652157 0 1.3224 0.00621446 0 1.30722 0.00592179 0 1.29277 0.00564288 0 + 1.27899 0.00537711 0 1.26587 0.0051239 0 1.25336 0.00488269 0 1.24144 0.00465301 0 + 1.23008 0.00443444 0 1.21925 0.00422667 0 1.20893 0.00402949 0 1.19909 0.00384289 0 + 1.18971 0.00366716 0 1.18074 0.00350328 0 1.17217 0.00335373 0 1.16395 0.00322528 0 + 1.156 0.00313604 0 1.14822 0.00308372 0 2.47746 0.0878818 0 2.41618 0.0843527 0 + 2.35078 0.0810423 0 2.28794 0.0776148 0 2.22766 0.0741495 0 2.16995 0.070737 0 + 2.11481 0.0674305 0 2.0622 0.0642545 0 2.01202 0.0612173 0 1.9642 0.0583191 0 + 1.91862 0.0555564 0 1.87521 0.0529241 0 1.83384 0.0504166 0 1.79444 0.0480285 0 + 1.75691 0.0457543 0 1.72116 0.0435886 0 1.68711 0.0415262 0 1.65467 0.0395624 0 + 1.62377 0.0376923 0 1.59433 0.0359114 0 1.56629 0.0342155 0 1.53958 0.0326003 0 + 1.51413 0.0310619 0 1.48988 0.0295966 0 1.46679 0.0282009 0 1.44478 0.0268713 0 + 1.42381 0.0256047 0 1.40383 0.024398 0 1.3848 0.0232483 0 1.36666 0.0221528 0 + 1.34938 0.0211089 0 1.33292 0.0201142 0 1.31723 0.0191663 0 1.30228 0.018263 0 + 1.28804 0.0174021 0 1.27447 0.0165818 0 1.26155 0.0158001 0 1.24923 0.0150553 0 + 1.23749 0.014346 0 1.22631 0.0136707 0 1.21566 0.0130283 0 1.2055 0.012418 0 + 1.19582 0.0118396 0 1.18659 0.0112934 0 1.17777 0.0107808 0 1.16934 0.0103053 0 + 1.16125 0.00987476 0 1.15348 0.00950592 0 1.14596 0.00922838 0 1.13878 0.00895564 0 + 2.2854 0.140392 0 2.23194 0.134212 0 2.17523 0.128863 0 2.12093 0.123504 0 + 2.06889 0.118123 0 2.01904 0.112808 0 1.97134 0.107632 0 1.92573 0.102633 0 + 1.88216 0.0978314 0 1.84058 0.0932335 0 1.8009 0.0888387 0 1.76307 0.0846431 0 + 1.727 0.0806408 0 1.69263 0.0768248 0 1.65987 0.0731878 0 1.62867 0.0697225 0 + 1.59893 0.0664215 0 1.57061 0.0632773 0 1.54363 0.0602828 0 1.51792 0.057431 0 + 1.49344 0.0547152 0 1.47012 0.0521289 0 1.4479 0.0496657 0 1.42674 0.0473199 0 + 1.40658 0.0450856 0 1.38737 0.0429574 0 1.36908 0.0409302 0 1.35165 0.0389991 0 + 1.33504 0.0371593 0 1.31922 0.0354064 0 1.30415 0.0337363 0 1.28979 0.0321449 0 + 1.27611 0.0306284 0 1.26308 0.0291832 0 1.25067 0.0278059 0 1.23884 0.0264935 0 + 1.22757 0.0252428 0 1.21684 0.0240513 0 1.20662 0.0229165 0 1.19688 0.0218363 0 + 1.1876 0.0208093 0 1.17876 0.0198342 0 1.17033 0.0189112 0 1.16229 0.0180414 0 + 1.15462 0.0172278 0 1.14728 0.0164771 0 1.14024 0.015801 0 1.13346 0.0152197 0 + 1.12694 0.0147432 0 1.12073 0.0141526 0 2.01234 0.184102 0 1.96972 0.175714 0 + 1.92501 0.168494 0 1.88238 0.161419 0 1.84165 0.154417 0 1.80271 0.147548 0 + 1.76544 0.140868 0 1.72978 0.134411 0 1.69567 0.128194 0 1.66306 0.122227 0 + 1.63191 0.11651 0 1.60215 0.111041 0 1.57376 0.105814 0 1.54667 0.100824 0 + 1.52083 0.0960626 0 1.49619 0.0915217 0 1.47271 0.0871928 0 1.45034 0.0830674 0 + 1.42901 0.0791367 0 1.4087 0.0753922 0 1.38934 0.0718255 0 1.3709 0.0684283 0 + 1.35333 0.0651927 0 1.3366 0.0621109 0 1.32066 0.0591757 0 1.30547 0.0563799 0 + 1.29101 0.0537169 0 1.27723 0.05118 0 1.26411 0.0487633 0 1.2516 0.0464608 0 + 1.23969 0.0442671 0 1.22835 0.0421767 0 1.21754 0.0401847 0 1.20725 0.0382864 0 + 1.19744 0.0364773 0 1.18811 0.0347532 0 1.17921 0.0331102 0 1.17074 0.0315448 0 + 1.16268 0.0300539 0 1.155 0.0286348 0 1.14768 0.0272856 0 1.14071 0.0260053 0 + 1.13407 0.0247939 0 1.12774 0.0236536 0 1.1217 0.022589 0 1.11593 0.0216086 0 + 1.1104 0.0207266 0 1.10508 0.0199617 0 1.09998 0.0193018 0 1.09512 0.0184516 0 + 1.67554 0.216324 0 1.64633 0.206331 0 1.61642 0.197578 0 1.58808 0.189111 0 + 1.56115 0.180851 0 1.53545 0.172826 0 1.51088 0.165061 0 1.48735 0.157568 0 + 1.46482 0.150355 0 1.44323 0.143422 0 1.42257 0.136771 0 1.4028 0.130398 0 + 1.38389 0.124298 0 1.36583 0.118465 0 1.34858 0.112893 0 1.33211 0.107573 0 + 1.3164 0.102497 0 1.30141 0.097656 0 1.28712 0.0930407 0 1.27349 0.0886418 0 + 1.2605 0.08445 0 1.24813 0.0804563 0 1.23634 0.0766516 0 1.2251 0.0730272 0 + 1.2144 0.0695746 0 1.2042 0.0662858 0 1.19449 0.0631528 0 1.18524 0.0601683 0 + 1.17643 0.0573249 0 1.16803 0.0546159 0 1.16004 0.0520347 0 1.15243 0.049575 0 + 1.14518 0.0472311 0 1.13828 0.0449973 0 1.1317 0.0428682 0 1.12544 0.0408391 0 + 1.11949 0.0389052 0 1.11382 0.0370624 0 1.10842 0.035307 0 1.10328 0.033636 0 + 1.09839 0.0320471 0 1.09374 0.0305393 0 1.08932 0.0291129 0 1.0851 0.0277705 0 + 1.08108 0.0265177 0 1.07725 0.0253644 0 1.07359 0.0243258 0 1.07008 0.0234187 0 + 1.06672 0.0226174 0 1.06352 0.0215899 0 1.29626 0.235039 0 1.28232 0.224084 0 + 1.26919 0.214261 0 1.25698 0.204861 0 1.24552 0.195823 0 1.23462 0.187127 0 + 1.2242 0.178758 0 1.21418 0.170703 0 1.20455 0.162954 0 1.19529 0.155505 0 + 1.18637 0.148352 0 1.1778 0.141491 0 1.16956 0.134916 0 1.16166 0.128621 0 + 1.15408 0.1226 0 1.14682 0.116847 0 1.13988 0.111351 0 1.13323 0.106106 0 + 1.12689 0.101102 0 1.12083 0.0963293 0 1.11504 0.0917792 0 1.10952 0.0874422 0 + 1.10426 0.0833091 0 1.09925 0.0793707 0 1.09446 0.0756181 0 1.08991 0.0720429 0 + 1.08557 0.0686366 0 1.08144 0.0653913 0 1.0775 0.0622992 0 1.07376 0.0593529 0 + 1.07019 0.0565454 0 1.0668 0.0538699 0 1.06357 0.0513201 0 1.06049 0.0488897 0 + 1.05757 0.0465731 0 1.05479 0.0443649 0 1.05215 0.0422599 0 1.04963 0.0402537 0 + 1.04725 0.0383421 0 1.04498 0.0365219 0 1.04284 0.0347906 0 1.0408 0.033147 0 + 1.03887 0.0315915 0 1.03704 0.030127 0 1.03531 0.0287596 0 1.03367 0.0274998 0 + 1.03211 0.0263631 0 1.03064 0.0253653 0 1.02925 0.0244764 0 1.02792 0.0233574 0 + 0.898544 0.238997 0 0.90091 0.227813 0 0.905442 0.217412 0 0.910206 0.207663 0 + 0.914911 0.198432 0 0.919425 0.189622 0 0.923706 0.181177 0 0.927741 0.173064 0 + 0.931529 0.165265 0 0.935078 0.157768 0 0.9384 0.150565 0 0.941507 0.143651 0 + 0.944413 0.137019 0 0.947134 0.130664 0 0.949685 0.124579 0 0.95208 0.118759 0 + 0.954331 0.113195 0 0.956451 0.10788 0 0.95845 0.102805 0 0.960339 0.0979628 0 + 0.962127 0.0933432 0 0.963821 0.0889377 0 0.965428 0.0847376 0 0.966954 0.0807339 0 + 0.968406 0.0769181 0 0.969787 0.0732816 0 0.971103 0.0698162 0 0.972357 0.0665139 0 + 0.973554 0.063367 0 0.974697 0.0603682 0 0.975788 0.0575102 0 0.976831 0.0547862 0 + 0.977829 0.0521898 0 0.978784 0.0497146 0 0.979699 0.0473548 0 0.980578 0.0451049 0 + 0.981421 0.0429596 0 0.982232 0.0409142 0 0.983014 0.0389646 0 0.983769 0.0371071 0 + 0.9845 0.0353393 0 0.98521 0.0336598 0 0.985903 0.032069 0 0.986582 0.0305696 0 + 0.98725 0.0291676 0 0.987913 0.0278735 0 0.988575 0.0267028 0 0.989241 0.0256712 0 + 0.98991 0.024752 0 0.990554 0.02363 0 0.507497 0.228179 0 0.526471 0.217168 0 + 0.548497 0.206811 0 0.569827 0.197388 0 0.590272 0.188588 0 0.609794 0.180236 0 + 0.628407 0.172247 0 0.64614 0.16458 0 0.663024 0.157212 0 0.679091 0.150129 0 + 0.694374 0.143321 0 0.708907 0.136783 0 0.722725 0.130507 0 0.735861 0.124489 0 + 0.748349 0.118723 0 0.760221 0.113202 0 0.77151 0.10792 0 0.782246 0.10287 0 + 0.792458 0.0980458 0 0.802174 0.0934386 0 0.81142 0.089041 0 0.820219 0.0848451 0 + 0.828597 0.0808428 0 0.836573 0.0770262 0 0.84417 0.0733874 0 0.851405 0.0699185 0 + 0.858298 0.066612 0 0.864866 0.0634603 0 0.871125 0.0604563 0 0.87709 0.057593 0 + 0.882776 0.0548637 0 0.888196 0.0522618 0 0.893365 0.0497811 0 0.898294 0.0474158 0 + 0.902995 0.0451601 0 0.907481 0.0430086 0 0.911762 0.0409563 0 0.91585 0.0389986 0 + 0.919754 0.0371313 0 0.923486 0.0353509 0 0.927056 0.0336547 0 0.930475 0.0320413 0 + 0.933753 0.0305106 0 0.936903 0.0290651 0 0.939936 0.0277102 0 0.942868 0.0264556 0 + 0.945711 0.025316 0 0.948483 0.0243081 0 0.95119 0.0234145 0 0.95378 0.02238 0 + 0.147899 0.203163 0 0.182796 0.192696 0 0.220842 0.183225 0 0.257221 0.174806 0 + 0.291974 0.167012 0 0.325166 0.159641 0 0.356857 0.1526 0 0.387102 0.145846 0 + 0.415956 0.139356 0 0.443473 0.133117 0 0.469705 0.12712 0 0.494705 0.121358 0 + 0.518523 0.115824 0 0.541212 0.110513 0 0.562821 0.105421 0 0.5834 0.100542 0 + 0.602996 0.0958711 0 0.621657 0.091402 0 0.639426 0.0871289 0 0.656348 0.0830456 0 + 0.672462 0.0791457 0 0.68781 0.0754225 0 0.702428 0.0718694 0 0.716351 0.0684795 0 + 0.729615 0.0652462 0 0.74225 0.0621628 0 0.754288 0.0592227 0 0.765759 0.0564194 0 + 0.776688 0.0537467 0 0.787103 0.0511985 0 0.797029 0.0487689 0 0.806489 0.046452 0 + 0.815506 0.0442423 0 0.824102 0.0421346 0 0.832298 0.0401236 0 0.840113 0.0382045 0 + 0.847566 0.0363727 0 0.854677 0.0346239 0 0.861462 0.0329541 0 0.86794 0.03136 0 + 0.874129 0.0298389 0 0.880045 0.0283891 0 0.885708 0.0270102 0 0.891135 0.0257037 0 + 0.896349 0.024474 0 0.90137 0.0233294 0 0.906225 0.0222833 0 0.910938 0.0213525 0 + 0.915524 0.0205363 0 0.919907 0.0196793 0 -0.157763 0.165107 0 -0.108869 0.156035 0 + -0.0573911 0.148266 0 -0.00834992 0.141428 0 0.0384768 0.135127 0 0.0832157 0.129182 0 + 0.125959 0.123512 0 0.166785 0.118077 0 0.205767 0.112856 0 0.242977 0.107837 0 + 0.278482 0.103011 0 0.31235 0.0983727 0 0.344647 0.093916 0 0.375439 0.0896365 0 + 0.40479 0.0855301 0 0.432763 0.0815925 0 0.459418 0.0778195 0 0.484816 0.0742069 0 + 0.509014 0.07075 0 0.532068 0.0674442 0 0.554031 0.0642846 0 0.574956 0.0612662 0 + 0.59489 0.0583839 0 0.613882 0.0556326 0 0.631977 0.053007 0 0.649216 0.0505019 0 + 0.665642 0.0481123 0 0.681293 0.0458329 0 0.696207 0.0436589 0 0.710418 0.0415852 0 + 0.723961 0.0396072 0 0.736868 0.0377201 0 0.749169 0.0359195 0 0.760893 0.0342008 0 + 0.77207 0.0325597 0 0.782725 0.0309923 0 0.792885 0.0294944 0 0.802574 0.0280625 0 + 0.811817 0.0266928 0 0.820637 0.0253825 0 0.829058 0.0241287 0 0.837104 0.0229295 0 + 0.844798 0.0217841 0 0.852167 0.0206928 0 0.859237 0.0196582 0 0.866039 0.0186867 0 + 0.872605 0.0177891 0 0.878972 0.0169829 0 0.885157 0.0162889 0 0.891065 0.0156939 0 + -0.390654 0.116393 0 -0.330872 0.109641 0 -0.269235 0.104168 0 -0.210567 0.0993591 0 + -0.154573 0.0949393 0 -0.101075 0.09078 0 -0.0499512 0.0868197 0 -0.00110124 0.0830276 0 + 0.0455635 0.0793869 0 0.0901268 0.0758874 0 0.13267 0.0725221 0 0.173272 0.0692857 0 + 0.212011 0.0661742 0 0.248962 0.0631838 0 0.2842 0.0603116 0 0.317798 0.0575545 0 + 0.349828 0.0549098 0 0.380358 0.0523746 0 0.409455 0.0499461 0 0.437184 0.0476212 0 + 0.463609 0.045397 0 0.488789 0.0432702 0 0.512783 0.0412375 0 0.535645 0.0392956 0 + 0.557429 0.0374411 0 0.578186 0.0356704 0 0.597965 0.0339801 0 0.616812 0.0323668 0 + 0.634771 0.030827 0 0.651884 0.0293572 0 0.668193 0.0279542 0 0.683735 0.0266145 0 + 0.698546 0.0253349 0 0.712663 0.024112 0 0.726119 0.0229427 0 0.738946 0.0218239 0 + 0.751174 0.0207523 0 0.762835 0.0197251 0 0.773956 0.0187392 0 0.784566 0.0177918 0 + 0.794693 0.0168806 0 0.804365 0.0160032 0 0.813611 0.0151581 0 0.82246 0.0143442 0 + 0.830946 0.013562 0 0.839105 0.0128151 0 0.846975 0.012111 0 0.8546 0.011468 0 + 0.862002 0.0109335 0 0.869066 0.0106715 0 -0.53629 0.0601363 0 -0.469519 0.0564936 0 + -0.401601 0.0536713 0 -0.336952 0.0512027 0 -0.275253 0.0489415 0 -0.216306 0.0468215 0 + -0.159969 0.0448091 0 -0.106129 0.0428863 0 -0.0546862 0.0410424 0 -0.00554768 0.0392704 0 + 0.0413761 0.0375655 0 0.0861717 0.035924 0 0.128924 0.0343431 0 0.169716 0.0328206 0 + 0.208628 0.0313546 0 0.245739 0.0299437 0 0.281127 0.0285867 0 0.314867 0.0272824 0 + 0.34703 0.0260297 0 0.377688 0.0248275 0 0.406909 0.0236745 0 0.434757 0.0225697 0 + 0.461297 0.0215115 0 0.486589 0.0204986 0 0.51069 0.0195295 0 0.533657 0.0186026 0 + 0.555543 0.0177163 0 0.576398 0.016869 0 0.596272 0.0160588 0 0.61521 0.015284 0 + 0.633257 0.0145429 0 0.650456 0.0138335 0 0.666847 0.013154 0 0.682468 0.0125024 0 + 0.697357 0.0118767 0 0.711549 0.011275 0 0.725078 0.0106951 0 0.737977 0.0101348 0 + 0.750278 0.00959182 0 0.762012 0.00906391 0 0.773209 0.00854866 0 0.783902 0.00804368 0 + 0.79412 0.00754658 0 0.803896 0.00705479 0 0.813267 0.00656583 0 0.822272 0.00608097 0 + 0.830954 0.00560283 0 0.839362 0.00514985 0 0.847507 0.00481375 0 0.855284 0.00491827 0 + -0.585739 -6.04353e-05 0 -0.51647 -9.39844e-05 0 -0.44645 -9.23559e-05 0 -0.379805 -6.8784e-05 0 + -0.3162 -2.95756e-05 0 -0.255433 2.09306e-05 0 -0.197357 7.89559e-05 0 -0.141853 0.000140979 0 + -0.0888153 0.00020376 0 -0.0381481 0.000264459 0 0.0102415 0.000320745 0 0.0564433 0.000370839 0 + 0.100545 0.000413556 0 0.14263 0.000448241 0 0.182783 0.000474693 0 0.221085 0.000493081 0 + 0.257614 0.000503845 0 0.292446 0.000507614 0 0.325657 0.000505124 0 0.357318 0.000497154 0 + 0.387497 0.00048448 0 0.416264 0.000467834 0 0.44368 0.000447878 0 0.46981 0.00042519 0 + 0.494712 0.000400253 0 0.518443 0.000373445 0 0.541058 0.000345043 0 0.562609 0.000315217 0 + 0.583146 0.00028403 0 0.602717 0.000251438 0 0.621367 0.000217284 0 0.639141 0.000181296 0 + 0.656079 0.000143077 0 0.672222 0.000102093 0 0.687607 5.76622e-05 0 0.702272 8.93246e-06 0 + 0.71625 -4.51398e-05 0 0.729577 -0.00010582 0 0.742285 -0.000174629 0 0.754406 -0.00025339 0 + 0.765971 -0.000344277 0 0.777012 -0.000449866 0 0.787561 -0.000573202 0 0.79765 -0.000718515 0 + 0.807318 -0.000891875 0 0.816604 -0.00109335 0 0.825551 -0.001327 0 0.834211 -0.00157458 0 + 0.842591 -0.00168197 0 0.850596 -0.00121171 0 -0.536321 -0.0602471 0 -0.469597 -0.0566689 0 + -0.401714 -0.0538401 0 -0.337109 -0.0513215 0 -0.27546 -0.0489797 0 -0.216566 -0.0467575 0 + -0.160284 -0.0446291 0 -0.106499 -0.0425832 0 -0.0551064 -0.0406156 0 -0.00601266 -0.0387249 0 + 0.0408736 -0.0369106 0 0.0856403 -0.0351725 0 0.128373 -0.0335099 0 0.169154 -0.0319217 0 + 0.208064 -0.0304063 0 0.245183 -0.028962 0 0.280585 -0.0275864 0 0.314346 -0.0262771 0 + 0.346537 -0.0250315 0 0.377228 -0.023847 0 0.406485 -0.0227208 0 0.434373 -0.0216502 0 + 0.460954 -0.0206326 0 0.486288 -0.0196654 0 0.510433 -0.0187463 0 0.533443 -0.0178729 0 + 0.555371 -0.0170431 0 0.576268 -0.016255 0 0.596182 -0.0155066 0 0.615159 -0.0147963 0 + 0.633243 -0.0141227 0 0.650477 -0.0134845 0 0.666901 -0.0128805 0 0.682552 -0.0123099 0 + 0.697469 -0.0117721 0 0.711687 -0.0112668 0 0.725238 -0.0107939 0 0.738157 -0.0103537 0 + 0.750475 -0.00994702 0 0.762222 -0.00957518 0 0.773429 -0.00924008 0 0.784126 -0.00894445 0 + 0.794344 -0.00869202 0 0.804115 -0.00848841 0 0.813472 -0.00834213 0 0.822454 -0.0082569 0 + 0.831104 -0.00824172 0 0.839463 -0.00827493 0 0.84756 -0.00816267 0 0.855301 -0.00732832 0 + -0.390709 -0.116477 0 -0.331012 -0.109781 0 -0.269443 -0.10429 0 -0.21086 -0.0994221 0 + -0.154963 -0.0949154 0 -0.101571 -0.0906509 0 -0.0505541 -0.0865747 0 -0.00180854 -0.0826627 0 + 0.0447595 -0.0789043 0 0.0892381 -0.0752941 0 0.131711 -0.071829 0 0.17226 -0.0685067 0 + 0.210964 -0.0653244 0 0.247898 -0.0622794 0 0.283137 -0.0593682 0 0.316753 -0.0565872 0 + 0.348814 -0.0539325 0 0.379389 -0.0513997 0 0.408543 -0.0489845 0 0.436337 -0.0466823 0 + 0.462834 -0.0444886 0 0.488092 -0.0423988 0 0.512166 -0.0404084 0 0.535112 -0.0385132 0 + 0.55698 -0.0367088 0 0.577821 -0.0349912 0 0.597682 -0.0333564 0 0.616609 -0.0318009 0 + 0.634646 -0.0303211 0 0.651834 -0.0289139 0 0.668213 -0.0275761 0 0.683822 -0.026305 0 + 0.698696 -0.0250982 0 0.712871 -0.0239535 0 0.726379 -0.022869 0 0.739254 -0.0218434 0 + 0.751525 -0.0208754 0 0.763222 -0.0199646 0 0.774373 -0.0191111 0 0.785006 -0.0183155 0 + 0.795149 -0.0175796 0 0.804828 -0.0169061 0 0.814072 -0.0162995 0 0.822908 -0.0157663 0 + 0.831365 -0.0153161 0 0.839477 -0.0149582 0 0.847282 -0.0147039 0 0.854817 -0.0145283 0 + 0.862113 -0.0142231 0 0.869094 -0.0130461 0 -0.157832 -0.165157 0 -0.109046 -0.156119 0 + -0.0576631 -0.148314 0 -0.00874361 -0.141401 0 0.0379427 -0.135003 0 0.082531 -0.128948 0 + 0.125122 -0.123163 0 0.165802 -0.117615 0 0.204651 -0.112286 0 0.241746 -0.107171 0 + 0.27716 -0.102262 0 0.310961 -0.0975546 0 0.343219 -0.0930452 0 0.373997 -0.0887286 0 + 0.403359 -0.0845998 0 0.431365 -0.0806533 0 0.458075 -0.0768835 0 0.483545 -0.0732845 0 + 0.507829 -0.0698501 0 0.530981 -0.0665742 0 0.553052 -0.0634506 0 0.574089 -0.060473 0 + 0.594141 -0.0576353 0 0.613253 -0.0549316 0 0.631466 -0.0523561 0 0.648824 -0.049903 0 + 0.665366 -0.047567 0 0.68113 -0.045343 0 0.696152 -0.0432259 0 0.710467 -0.0412112 0 + 0.724107 -0.0392946 0 0.737106 -0.037472 0 0.749492 -0.0357398 0 0.761296 -0.0340945 0 + 0.772544 -0.0325334 0 0.783263 -0.0310539 0 0.793478 -0.0296541 0 0.803215 -0.0283326 0 + 0.812496 -0.0270889 0 0.821345 -0.0259232 0 0.829783 -0.0248368 0 0.837833 -0.0238327 0 + 0.845518 -0.0229155 0 0.85286 -0.0220925 0 0.859883 -0.0213741 0 0.866612 -0.0207734 0 + 0.873076 -0.0203036 0 0.879308 -0.0199424 0 0.885336 -0.0194679 0 0.891113 -0.0180079 0 + 0.14783 -0.20318 0 0.182611 -0.19271 0 0.220541 -0.183173 0 0.256768 -0.174658 0 + 0.291345 -0.166756 0 0.32435 -0.15927 0 0.355854 -0.152118 0 0.385925 -0.145261 0 + 0.414625 -0.13868 0 0.442013 -0.132364 0 0.468149 -0.126307 0 0.493084 -0.1205 0 + 0.516873 -0.114937 0 0.539564 -0.109612 0 0.561206 -0.104519 0 0.581844 -0.09965 0 + 0.601523 -0.0949981 0 0.620287 -0.0905561 0 0.638174 -0.0863163 0 0.655226 -0.0822712 0 + 0.671481 -0.0784131 0 0.686973 -0.0747345 0 0.701739 -0.0712279 0 0.715811 -0.067886 0 + 0.729222 -0.0647017 0 0.742003 -0.0616681 0 0.754182 -0.0587786 0 0.765787 -0.0560268 0 + 0.776846 -0.0534067 0 0.787384 -0.0509125 0 0.797425 -0.0485389 0 0.806993 -0.0462807 0 + 0.81611 -0.0441335 0 0.824796 -0.0420929 0 0.833073 -0.0401551 0 0.84096 -0.0383169 0 + 0.848475 -0.0365756 0 0.855636 -0.0349292 0 0.86246 -0.0333765 0 0.868964 -0.0319174 0 + 0.875163 -0.030553 0 0.881075 -0.029286 0 0.886714 -0.0281212 0 0.892096 -0.0270662 0 + 0.897238 -0.0261321 0 0.902156 -0.0253336 0 0.90687 -0.0246859 0 0.911401 -0.0241706 0 + 0.915775 -0.0235607 0 0.919977 -0.0218988 0 0.507439 -0.228173 0 0.526304 -0.217103 0 + 0.548199 -0.20664 0 0.569354 -0.197096 0 0.589596 -0.188173 0 0.608907 -0.179705 0 + 0.627317 -0.171614 0 0.644865 -0.16386 0 0.661593 -0.156423 0 0.67754 -0.14929 0 + 0.692743 -0.142451 0 0.707236 -0.135898 0 0.721053 -0.129622 0 0.734224 -0.123616 0 + 0.746779 -0.117872 0 0.758747 -0.112382 0 0.770154 -0.107136 0 0.781027 -0.102127 0 + 0.79139 -0.097346 0 0.801266 -0.0927843 0 0.810679 -0.0884333 0 0.819648 -0.0842844 0 + 0.828196 -0.0803291 0 0.836342 -0.0765593 0 0.844104 -0.0729669 0 0.8515 -0.0695442 0 + 0.858548 -0.0662837 0 0.865263 -0.0631781 0 0.87166 -0.0602208 0 0.877756 -0.0574052 0 + 0.883563 -0.0547251 0 0.889096 -0.0521749 0 0.894367 -0.0497492 0 0.899387 -0.0474431 0 + 0.90417 -0.0452524 0 0.908725 -0.0431731 0 0.913064 -0.0412021 0 0.917196 -0.0393368 0 + 0.92113 -0.0375758 0 0.924877 -0.0359184 0 0.928444 -0.0343656 0 0.931841 -0.0329198 0 + 0.935075 -0.0315857 0 0.938154 -0.030371 0 0.941087 -0.0292867 0 0.94388 -0.0283481 0 + 0.94654 -0.0275711 0 0.94908 -0.0269417 0 0.951518 -0.0262385 0 0.953874 -0.0244683 0 + 0.898506 -0.238977 0 0.90078 -0.227663 0 0.905172 -0.217109 0 0.909746 -0.20721 0 + 0.914235 -0.197844 0 0.918532 -0.188921 0 0.922612 -0.180389 0 0.926477 -0.172215 0 + 0.930136 -0.164378 0 0.933602 -0.156865 0 0.936887 -0.149666 0 0.940001 -0.14277 0 + 0.942957 -0.136168 0 0.945763 -0.129852 0 0.948428 -0.123813 0 0.950962 -0.118042 0 + 0.95337 -0.112529 0 0.955661 -0.107265 0 0.957841 -0.102242 0 0.959915 -0.097449 0 + 0.961889 -0.0928779 0 0.963769 -0.0885193 0 0.965558 -0.0843641 0 0.967262 -0.0804038 0 + 0.968884 -0.0766298 0 0.970428 -0.0730339 0 0.971899 -0.0696082 0 0.973298 -0.0663453 0 + 0.974631 -0.0632378 0 0.975899 -0.060279 0 0.977105 -0.0574624 0 0.978253 -0.0547818 0 + 0.979344 -0.0522317 0 0.980381 -0.0498069 0 0.981366 -0.0475027 0 0.982301 -0.045315 0 + 0.983188 -0.0432404 0 0.984028 -0.041276 0 0.984823 -0.0394201 0 0.985573 -0.0376718 0 + 0.98628 -0.0360317 0 0.986944 -0.0345021 0 0.987565 -0.0330875 0 0.988143 -0.0317949 0 + 0.988676 -0.030635 0 0.989161 -0.0296225 0 0.989596 -0.0287731 0 0.989978 -0.0280769 0 + 0.990321 -0.0273277 0 0.990674 -0.0255472 0 1.29626 -0.235011 0 1.28225 -0.223847 0 + 1.26897 -0.213817 0 1.25657 -0.204239 0 1.24488 -0.195059 0 1.23379 -0.186264 0 + 1.22319 -0.177835 0 1.21306 -0.169755 0 1.20336 -0.162008 0 1.19408 -0.154584 0 + 1.18521 -0.147472 0 1.17671 -0.140662 0 1.1686 -0.134146 0 1.16084 -0.127914 0 + 1.15343 -0.121957 0 1.14636 -0.116266 0 1.13961 -0.11083 0 1.13317 -0.105642 0 + 1.12702 -0.100692 0 1.12116 -0.0959689 0 1.11557 -0.0914651 0 1.11024 -0.087171 0 + 1.10515 -0.0830777 0 1.10031 -0.0791765 0 1.09569 -0.0754589 0 1.09128 -0.0719169 0 + 1.08708 -0.0685426 0 1.08308 -0.0653284 0 1.07927 -0.0622674 0 1.07563 -0.0593526 0 + 1.07216 -0.0565777 0 1.06885 -0.0539367 0 1.06569 -0.051424 0 1.06268 -0.0490344 0 + 1.0598 -0.0467633 0 1.05706 -0.0446066 0 1.05444 -0.0425607 0 1.05193 -0.0406228 0 + 1.04953 -0.0387911 0 1.04724 -0.0370646 0 1.04503 -0.0354436 0 1.04292 -0.0339301 0 + 1.04089 -0.0325281 0 1.03892 -0.0312439 0 1.03701 -0.0300874 0 1.03516 -0.0290717 0 + 1.03333 -0.0282114 0 1.03152 -0.0275 0 1.02974 -0.0267543 0 1.02806 -0.0250599 0 + 1.67558 -0.216293 0 1.64635 -0.206003 0 1.61628 -0.196985 0 1.58775 -0.188319 0 + 1.56062 -0.17993 0 1.53478 -0.171838 0 1.51011 -0.164057 0 1.48656 -0.156586 0 + 1.46407 -0.149422 0 1.44258 -0.142555 0 1.42205 -0.135979 0 1.40246 -0.129685 0 + 1.38375 -0.123665 0 1.3659 -0.117909 0 1.34887 -0.112409 0 1.33262 -0.107157 0 + 1.31712 -0.102142 0 1.30235 -0.0973559 0 1.28826 -0.09279 0 1.27483 -0.0884352 0 + 1.26202 -0.0842828 0 1.24982 -0.0803242 0 1.23818 -0.076551 0 1.22709 -0.0729552 0 + 1.21652 -0.0695288 0 1.20645 -0.0662644 0 1.19685 -0.0631545 0 1.1877 -0.0601924 0 + 1.17897 -0.0573713 0 1.17066 -0.054685 0 1.16273 -0.0521275 0 1.15517 -0.0496933 0 + 1.14797 -0.0473771 0 1.14109 -0.0451743 0 1.13454 -0.0430804 0 1.12829 -0.0410917 0 + 1.12232 -0.0392049 0 1.11663 -0.0374172 0 1.11119 -0.0357269 0 1.10599 -0.0341331 0 + 1.10101 -0.0326358 0 1.09625 -0.0312367 0 1.09168 -0.0299391 0 1.0873 -0.0287487 0 + 1.08306 -0.0276736 0 1.07897 -0.0267252 0 1.075 -0.0259161 0 1.07111 -0.0252421 0 + 1.06731 -0.0245489 0 1.0637 -0.0230298 0 2.01244 -0.184071 0 1.96985 -0.175284 0 + 1.92498 -0.167754 0 1.88219 -0.160486 0 1.84136 -0.153396 0 1.80238 -0.146518 0 + 1.76517 -0.139881 0 1.72965 -0.133499 0 1.69573 -0.127375 0 1.66334 -0.121505 0 + 1.63244 -0.115886 0 1.60295 -0.110509 0 1.57481 -0.105368 0 1.54798 -0.100455 0 + 1.52238 -0.0957627 0 1.49798 -0.0912821 0 1.47471 -0.0870056 0 1.45253 -0.0829253 0 + 1.43138 -0.0790334 0 1.41123 -0.0753221 0 1.39202 -0.0717838 0 1.37371 -0.068411 0 + 1.35626 -0.0651965 0 1.33963 -0.0621334 0 1.32378 -0.0592147 0 1.30867 -0.0564341 0 + 1.29427 -0.0537853 0 1.28055 -0.0512623 0 1.26747 -0.0488595 0 1.25501 -0.0465714 0 + 1.24312 -0.0443931 0 1.23179 -0.0423196 0 1.221 -0.0403467 0 1.2107 -0.0384701 0 + 1.20088 -0.0366862 0 1.19151 -0.0349918 0 1.18258 -0.0333839 0 1.17405 -0.0318603 0 + 1.16591 -0.0304193 0 1.15814 -0.0290602 0 1.1507 -0.0277829 0 1.14359 -0.0265887 0 + 1.13677 -0.0254804 0 1.13023 -0.0244622 0 1.12394 -0.0235409 0 1.11786 -0.0227254 0 + 1.11198 -0.0220258 0 1.10625 -0.0214395 0 1.10066 -0.0208444 0 1.09533 -0.0195776 0 + 2.28559 -0.140368 0 2.23226 -0.133676 0 2.17544 -0.128012 0 2.1211 -0.12252 0 + 2.06914 -0.117132 0 2.01949 -0.111883 0 1.97207 -0.106808 0 1.92679 -0.101924 0 + 1.88356 -0.0972357 0 1.84232 -0.0927438 0 1.80297 -0.0884445 0 1.76544 -0.0843327 0 + 1.72965 -0.0804028 0 1.69552 -0.0766485 0 1.66298 -0.0730635 0 1.63196 -0.0696415 0 + 1.60239 -0.0663762 0 1.57421 -0.0632614 0 1.54734 -0.0602909 0 1.52174 -0.0574586 0 + 1.49734 -0.0547587 0 1.47409 -0.0521853 0 1.45193 -0.0497329 0 1.43081 -0.0473961 0 + 1.41068 -0.0451696 0 1.3915 -0.0430485 0 1.37321 -0.041028 0 1.35579 -0.0391035 0 + 1.33919 -0.0372706 0 1.32336 -0.0355253 0 1.30827 -0.0338636 0 1.29389 -0.0322819 0 + 1.28018 -0.0307768 0 1.26711 -0.0293452 0 1.25464 -0.0279842 0 1.24276 -0.0266913 0 + 1.23142 -0.0254644 0 1.22059 -0.0243016 0 1.21026 -0.0232018 0 1.2004 -0.0221642 0 + 1.19097 -0.0211888 0 1.18195 -0.0202765 0 1.17331 -0.0194293 0 1.16503 -0.0186504 0 + 1.15706 -0.0179446 0 1.14938 -0.0173183 0 1.14195 -0.0167789 0 1.13473 -0.0163245 0 + 1.1277 -0.0158671 0 1.12098 -0.0149144 0 2.47783 -0.0879117 0 2.41693 -0.0837755 0 + 2.35166 -0.0802406 0 2.28913 -0.0767965 0 2.22928 -0.0734112 0 2.17207 -0.0701126 0 + 2.11743 -0.0669233 0 2.06527 -0.0638547 0 2.01549 -0.0609108 0 1.96802 -0.0580913 0 + 1.92274 -0.0553939 0 1.87956 -0.0528151 0 1.83839 -0.0503512 0 1.79914 -0.047998 0 + 1.76173 -0.0457515 0 1.72606 -0.0436076 0 1.69207 -0.0415622 0 1.65968 -0.0396113 0 + 1.6288 -0.037751 0 1.59938 -0.0359774 0 1.57134 -0.0342868 0 1.54461 -0.0326756 0 + 1.51915 -0.0311402 0 1.49488 -0.0296771 0 1.47175 -0.0282832 0 1.44971 -0.0269553 0 + 1.4287 -0.0256903 0 1.40868 -0.0244854 0 1.3896 -0.0233379 0 1.37141 -0.0222452 0 + 1.35407 -0.0212048 0 1.33754 -0.0202145 0 1.32179 -0.0192721 0 1.30677 -0.0183757 0 + 1.29245 -0.0175235 0 1.27879 -0.0167139 0 1.26576 -0.0159455 0 1.25332 -0.0152173 0 + 1.24146 -0.0145284 0 1.23012 -0.0138783 0 1.21929 -0.0132672 0 1.20893 -0.0126955 0 + 1.19901 -0.0121643 0 1.1895 -0.0116758 0 1.18036 -0.0112326 0 1.17155 -0.0108388 0 + 1.16303 -0.0104986 0 1.15476 -0.010211 0 1.14672 -0.00992224 0 1.13902 -0.00932933 0 + 2.57687 -0.0299384 0 2.51172 -0.028555 0 2.44184 -0.0273445 0 2.37496 -0.0261621 0 + 2.311 -0.0250023 0 2.24991 -0.0238746 0 2.19158 -0.0227857 0 2.13593 -0.0217389 0 + 2.08283 -0.0207353 0 2.0322 -0.0197745 0 1.98391 -0.0188556 0 1.93787 -0.0179773 0 + 1.89397 -0.0171382 0 1.85213 -0.016337 0 1.81224 -0.0155723 0 1.77422 -0.0148425 0 + 1.73799 -0.0141463 0 1.70345 -0.0134823 0 1.67054 -0.0128491 0 1.63917 -0.0122455 0 + 1.60927 -0.0116702 0 1.58078 -0.0111219 0 1.55363 -0.0105993 0 1.52776 -0.0101014 0 + 1.5031 -0.00962708 0 1.47959 -0.00917517 0 1.45719 -0.00874468 0 1.43584 -0.00833463 0 + 1.4155 -0.00794411 0 1.3961 -0.00757222 0 1.37761 -0.00721814 0 1.35999 -0.00688109 0 + 1.34319 -0.00656035 0 1.32717 -0.00625524 0 1.31189 -0.00596516 0 1.29732 -0.00568958 0 + 1.28343 -0.00542802 0 1.27017 -0.00518012 0 1.25751 -0.0049456 0 1.24542 -0.0047243 0 + 1.23387 -0.00451622 0 1.22282 -0.00432153 0 1.21225 -0.00414063 0 1.2021 -0.00397418 0 + 1.19236 -0.00382315 0 1.18297 -0.00368881 0 1.17389 -0.0035726 0 1.16508 -0.00347413 0 + 1.15652 -0.00337526 0 1.14833 -0.00317338 0 2.57687 0.0299384 0 2.51172 0.028555 0 + 2.44184 0.0273445 0 2.37496 0.0261621 0 2.311 0.0250023 0 2.24991 0.0238746 0 + 2.19158 0.0227857 0 2.13593 0.0217389 0 2.08283 0.0207353 0 2.0322 0.0197745 0 + 1.98391 0.0188556 0 1.93787 0.0179773 0 1.89397 0.0171382 0 1.85213 0.016337 0 + 1.81224 0.0155723 0 1.77422 0.0148425 0 1.73799 0.0141463 0 1.70345 0.0134823 0 + 1.67054 0.0128491 0 1.63917 0.0122455 0 1.60927 0.0116702 0 1.58078 0.0111219 0 + 1.55363 0.0105993 0 1.52776 0.0101014 0 1.5031 0.00962708 0 1.47959 0.00917517 0 + 1.45719 0.00874468 0 1.43584 0.00833463 0 1.4155 0.00794411 0 1.3961 0.00757222 0 + 1.37761 0.00721814 0 1.35999 0.00688109 0 1.34319 0.00656035 0 1.32717 0.00625524 0 + 1.31189 0.00596516 0 1.29732 0.00568958 0 1.28343 0.00542802 0 1.27017 0.00518012 0 + 1.25751 0.0049456 0 1.24542 0.0047243 0 1.23387 0.00451622 0 1.22282 0.00432153 0 + 1.21225 0.00414063 0 1.2021 0.00397418 0 1.19236 0.00382315 0 1.18297 0.00368881 0 + 1.17389 0.0035726 0 1.16508 0.00347413 0 1.15652 0.00337526 0 1.14833 0.00317338 0 + 2.47783 0.0879117 0 2.41693 0.0837755 0 2.35166 0.0802406 0 2.28913 0.0767965 0 + 2.22928 0.0734112 0 2.17207 0.0701126 0 2.11743 0.0669233 0 2.06527 0.0638547 0 + 2.01549 0.0609108 0 1.96802 0.0580913 0 1.92274 0.0553939 0 1.87956 0.0528151 0 + 1.83839 0.0503512 0 1.79914 0.047998 0 1.76173 0.0457515 0 1.72606 0.0436076 0 + 1.69207 0.0415622 0 1.65968 0.0396113 0 1.6288 0.037751 0 1.59938 0.0359774 0 + 1.57134 0.0342868 0 1.54461 0.0326756 0 1.51915 0.0311402 0 1.49488 0.0296771 0 + 1.47175 0.0282832 0 1.44971 0.0269553 0 1.4287 0.0256903 0 1.40868 0.0244854 0 + 1.3896 0.0233379 0 1.37141 0.0222452 0 1.35407 0.0212048 0 1.33754 0.0202145 0 + 1.32179 0.0192721 0 1.30677 0.0183757 0 1.29245 0.0175235 0 1.27879 0.0167139 0 + 1.26576 0.0159455 0 1.25332 0.0152173 0 1.24146 0.0145284 0 1.23012 0.0138783 0 + 1.21929 0.0132672 0 1.20893 0.0126955 0 1.19901 0.0121643 0 1.1895 0.0116758 0 + 1.18036 0.0112326 0 1.17155 0.0108388 0 1.16303 0.0104986 0 1.15476 0.010211 0 + 1.14672 0.00992224 0 1.13902 0.00932933 0 2.28559 0.140368 0 2.23226 0.133676 0 + 2.17544 0.128012 0 2.1211 0.12252 0 2.06914 0.117132 0 2.01949 0.111883 0 + 1.97207 0.106808 0 1.92679 0.101924 0 1.88356 0.0972357 0 1.84232 0.0927438 0 + 1.80297 0.0884445 0 1.76544 0.0843327 0 1.72965 0.0804028 0 1.69552 0.0766485 0 + 1.66298 0.0730635 0 1.63196 0.0696415 0 1.60239 0.0663762 0 1.57421 0.0632614 0 + 1.54734 0.0602909 0 1.52174 0.0574586 0 1.49734 0.0547587 0 1.47409 0.0521853 0 + 1.45193 0.0497329 0 1.43081 0.0473961 0 1.41068 0.0451696 0 1.3915 0.0430485 0 + 1.37321 0.041028 0 1.35579 0.0391035 0 1.33919 0.0372706 0 1.32336 0.0355253 0 + 1.30827 0.0338636 0 1.29389 0.0322819 0 1.28018 0.0307768 0 1.26711 0.0293452 0 + 1.25464 0.0279842 0 1.24276 0.0266913 0 1.23142 0.0254644 0 1.22059 0.0243016 0 + 1.21026 0.0232018 0 1.2004 0.0221642 0 1.19097 0.0211888 0 1.18195 0.0202765 0 + 1.17331 0.0194293 0 1.16503 0.0186504 0 1.15706 0.0179446 0 1.14938 0.0173183 0 + 1.14195 0.0167789 0 1.13473 0.0163245 0 1.1277 0.0158671 0 1.12098 0.0149144 0 + 2.01244 0.184071 0 1.96985 0.175284 0 1.92498 0.167754 0 1.88219 0.160486 0 + 1.84136 0.153396 0 1.80238 0.146518 0 1.76517 0.139881 0 1.72965 0.133499 0 + 1.69573 0.127375 0 1.66334 0.121505 0 1.63244 0.115886 0 1.60295 0.110509 0 + 1.57481 0.105368 0 1.54798 0.100455 0 1.52238 0.0957627 0 1.49798 0.0912821 0 + 1.47471 0.0870056 0 1.45253 0.0829253 0 1.43138 0.0790334 0 1.41123 0.0753221 0 + 1.39202 0.0717838 0 1.37371 0.068411 0 1.35626 0.0651965 0 1.33963 0.0621334 0 + 1.32378 0.0592147 0 1.30867 0.0564341 0 1.29427 0.0537853 0 1.28055 0.0512623 0 + 1.26747 0.0488595 0 1.25501 0.0465714 0 1.24312 0.0443931 0 1.23179 0.0423196 0 + 1.221 0.0403467 0 1.2107 0.0384701 0 1.20088 0.0366862 0 1.19151 0.0349918 0 + 1.18258 0.0333839 0 1.17405 0.0318603 0 1.16591 0.0304193 0 1.15814 0.0290602 0 + 1.1507 0.0277829 0 1.14359 0.0265887 0 1.13677 0.0254804 0 1.13023 0.0244622 0 + 1.12394 0.0235409 0 1.11786 0.0227254 0 1.11198 0.0220258 0 1.10625 0.0214395 0 + 1.10066 0.0208444 0 1.09533 0.0195776 0 1.67558 0.216293 0 1.64635 0.206003 0 + 1.61628 0.196985 0 1.58775 0.188319 0 1.56062 0.17993 0 1.53478 0.171838 0 + 1.51011 0.164057 0 1.48656 0.156586 0 1.46407 0.149422 0 1.44258 0.142555 0 + 1.42205 0.135979 0 1.40246 0.129685 0 1.38375 0.123665 0 1.3659 0.117909 0 + 1.34887 0.112409 0 1.33262 0.107157 0 1.31712 0.102142 0 1.30235 0.0973559 0 + 1.28826 0.09279 0 1.27483 0.0884352 0 1.26202 0.0842828 0 1.24982 0.0803242 0 + 1.23818 0.076551 0 1.22709 0.0729552 0 1.21652 0.0695288 0 1.20645 0.0662644 0 + 1.19685 0.0631545 0 1.1877 0.0601924 0 1.17897 0.0573713 0 1.17066 0.054685 0 + 1.16273 0.0521275 0 1.15517 0.0496933 0 1.14797 0.0473771 0 1.14109 0.0451743 0 + 1.13454 0.0430804 0 1.12829 0.0410917 0 1.12232 0.0392049 0 1.11663 0.0374172 0 + 1.11119 0.0357269 0 1.10599 0.0341331 0 1.10101 0.0326358 0 1.09625 0.0312367 0 + 1.09168 0.0299391 0 1.0873 0.0287487 0 1.08306 0.0276736 0 1.07897 0.0267252 0 + 1.075 0.0259161 0 1.07111 0.0252421 0 1.06731 0.0245489 0 1.0637 0.0230298 0 + 1.29626 0.235011 0 1.28225 0.223847 0 1.26897 0.213817 0 1.25657 0.204239 0 + 1.24488 0.195059 0 1.23379 0.186264 0 1.22319 0.177835 0 1.21306 0.169755 0 + 1.20336 0.162008 0 1.19408 0.154584 0 1.18521 0.147472 0 1.17671 0.140662 0 + 1.1686 0.134146 0 1.16084 0.127914 0 1.15343 0.121957 0 1.14636 0.116266 0 + 1.13961 0.11083 0 1.13317 0.105642 0 1.12702 0.100692 0 1.12116 0.0959689 0 + 1.11557 0.0914651 0 1.11024 0.087171 0 1.10515 0.0830777 0 1.10031 0.0791765 0 + 1.09569 0.0754589 0 1.09128 0.0719169 0 1.08708 0.0685426 0 1.08308 0.0653284 0 + 1.07927 0.0622674 0 1.07563 0.0593526 0 1.07216 0.0565777 0 1.06885 0.0539367 0 + 1.06569 0.051424 0 1.06268 0.0490344 0 1.0598 0.0467633 0 1.05706 0.0446066 0 + 1.05444 0.0425607 0 1.05193 0.0406228 0 1.04953 0.0387911 0 1.04724 0.0370646 0 + 1.04503 0.0354436 0 1.04292 0.0339301 0 1.04089 0.0325281 0 1.03892 0.0312439 0 + 1.03701 0.0300874 0 1.03516 0.0290717 0 1.03333 0.0282114 0 1.03152 0.0275 0 + 1.02974 0.0267543 0 1.02806 0.0250599 0 0.898506 0.238977 0 0.90078 0.227663 0 + 0.905172 0.217109 0 0.909746 0.20721 0 0.914235 0.197844 0 0.918532 0.188921 0 + 0.922612 0.180389 0 0.926477 0.172215 0 0.930136 0.164378 0 0.933602 0.156865 0 + 0.936887 0.149666 0 0.940001 0.14277 0 0.942957 0.136168 0 0.945763 0.129852 0 + 0.948428 0.123813 0 0.950962 0.118042 0 0.95337 0.112529 0 0.955661 0.107265 0 + 0.957841 0.102242 0 0.959915 0.097449 0 0.961889 0.0928779 0 0.963769 0.0885193 0 + 0.965558 0.0843641 0 0.967262 0.0804038 0 0.968884 0.0766298 0 0.970428 0.0730339 0 + 0.971899 0.0696082 0 0.973298 0.0663453 0 0.974631 0.0632378 0 0.975899 0.060279 0 + 0.977105 0.0574624 0 0.978253 0.0547818 0 0.979344 0.0522317 0 0.980381 0.0498069 0 + 0.981366 0.0475027 0 0.982301 0.045315 0 0.983188 0.0432404 0 0.984028 0.041276 0 + 0.984823 0.0394201 0 0.985573 0.0376718 0 0.98628 0.0360317 0 0.986944 0.0345021 0 + 0.987565 0.0330875 0 0.988143 0.0317949 0 0.988676 0.030635 0 0.989161 0.0296225 0 + 0.989596 0.0287731 0 0.989978 0.0280769 0 0.990321 0.0273277 0 0.990674 0.0255472 0 + 0.507439 0.228173 0 0.526304 0.217103 0 0.548199 0.20664 0 0.569354 0.197096 0 + 0.589596 0.188173 0 0.608907 0.179705 0 0.627317 0.171614 0 0.644865 0.16386 0 + 0.661593 0.156423 0 0.67754 0.14929 0 0.692743 0.142451 0 0.707236 0.135898 0 + 0.721053 0.129622 0 0.734224 0.123616 0 0.746779 0.117872 0 0.758747 0.112382 0 + 0.770154 0.107136 0 0.781027 0.102127 0 0.79139 0.097346 0 0.801266 0.0927843 0 + 0.810679 0.0884333 0 0.819648 0.0842844 0 0.828196 0.0803291 0 0.836342 0.0765593 0 + 0.844104 0.0729669 0 0.8515 0.0695442 0 0.858548 0.0662837 0 0.865263 0.0631781 0 + 0.87166 0.0602208 0 0.877756 0.0574052 0 0.883563 0.0547251 0 0.889096 0.0521749 0 + 0.894367 0.0497492 0 0.899387 0.0474431 0 0.90417 0.0452524 0 0.908725 0.0431731 0 + 0.913064 0.0412021 0 0.917196 0.0393368 0 0.92113 0.0375758 0 0.924877 0.0359184 0 + 0.928444 0.0343656 0 0.931841 0.0329198 0 0.935075 0.0315857 0 0.938154 0.030371 0 + 0.941087 0.0292867 0 0.94388 0.0283481 0 0.94654 0.0275711 0 0.94908 0.0269417 0 + 0.951518 0.0262385 0 0.953874 0.0244683 0 0.14783 0.20318 0 0.182611 0.19271 0 + 0.220541 0.183173 0 0.256768 0.174658 0 0.291345 0.166756 0 0.32435 0.15927 0 + 0.355854 0.152118 0 0.385925 0.145261 0 0.414625 0.13868 0 0.442013 0.132364 0 + 0.468149 0.126307 0 0.493084 0.1205 0 0.516873 0.114937 0 0.539564 0.109612 0 + 0.561206 0.104519 0 0.581844 0.09965 0 0.601523 0.0949981 0 0.620287 0.0905561 0 + 0.638174 0.0863163 0 0.655226 0.0822712 0 0.671481 0.0784131 0 0.686973 0.0747345 0 + 0.701739 0.0712279 0 0.715811 0.067886 0 0.729222 0.0647017 0 0.742003 0.0616681 0 + 0.754182 0.0587786 0 0.765787 0.0560268 0 0.776846 0.0534067 0 0.787384 0.0509125 0 + 0.797425 0.0485389 0 0.806993 0.0462807 0 0.81611 0.0441335 0 0.824796 0.0420929 0 + 0.833073 0.0401551 0 0.84096 0.0383169 0 0.848475 0.0365756 0 0.855636 0.0349292 0 + 0.86246 0.0333765 0 0.868964 0.0319174 0 0.875163 0.030553 0 0.881075 0.029286 0 + 0.886714 0.0281212 0 0.892096 0.0270662 0 0.897238 0.0261321 0 0.902156 0.0253336 0 + 0.90687 0.0246859 0 0.911401 0.0241706 0 0.915775 0.0235607 0 0.919977 0.0218988 0 + -0.157832 0.165157 0 -0.109046 0.156119 0 -0.0576631 0.148314 0 -0.00874361 0.141401 0 + 0.0379427 0.135003 0 0.082531 0.128948 0 0.125122 0.123163 0 0.165802 0.117615 0 + 0.204651 0.112286 0 0.241746 0.107171 0 0.27716 0.102262 0 0.310961 0.0975546 0 + 0.343219 0.0930452 0 0.373997 0.0887286 0 0.403359 0.0845998 0 0.431365 0.0806533 0 + 0.458075 0.0768835 0 0.483545 0.0732845 0 0.507829 0.0698501 0 0.530981 0.0665742 0 + 0.553052 0.0634506 0 0.574089 0.060473 0 0.594141 0.0576353 0 0.613253 0.0549316 0 + 0.631466 0.0523561 0 0.648824 0.049903 0 0.665366 0.047567 0 0.68113 0.045343 0 + 0.696152 0.0432259 0 0.710467 0.0412112 0 0.724107 0.0392946 0 0.737106 0.037472 0 + 0.749492 0.0357398 0 0.761296 0.0340945 0 0.772544 0.0325334 0 0.783263 0.0310539 0 + 0.793478 0.0296541 0 0.803215 0.0283326 0 0.812496 0.0270889 0 0.821345 0.0259232 0 + 0.829783 0.0248368 0 0.837833 0.0238327 0 0.845518 0.0229155 0 0.85286 0.0220925 0 + 0.859883 0.0213741 0 0.866612 0.0207734 0 0.873076 0.0203036 0 0.879308 0.0199424 0 + 0.885336 0.0194679 0 0.891113 0.0180079 0 -0.390709 0.116477 0 -0.331012 0.109781 0 + -0.269443 0.10429 0 -0.21086 0.0994221 0 -0.154963 0.0949154 0 -0.101571 0.0906509 0 + -0.0505541 0.0865747 0 -0.00180854 0.0826627 0 0.0447595 0.0789043 0 0.0892381 0.0752941 0 + 0.131711 0.071829 0 0.17226 0.0685067 0 0.210964 0.0653244 0 0.247898 0.0622794 0 + 0.283137 0.0593682 0 0.316753 0.0565872 0 0.348814 0.0539325 0 0.379389 0.0513997 0 + 0.408543 0.0489845 0 0.436337 0.0466823 0 0.462834 0.0444886 0 0.488092 0.0423988 0 + 0.512166 0.0404084 0 0.535112 0.0385132 0 0.55698 0.0367088 0 0.577821 0.0349912 0 + 0.597682 0.0333564 0 0.616609 0.0318009 0 0.634646 0.0303211 0 0.651834 0.0289139 0 + 0.668213 0.0275761 0 0.683822 0.026305 0 0.698696 0.0250982 0 0.712871 0.0239535 0 + 0.726379 0.022869 0 0.739254 0.0218434 0 0.751525 0.0208754 0 0.763222 0.0199646 0 + 0.774373 0.0191111 0 0.785006 0.0183155 0 0.795149 0.0175796 0 0.804828 0.0169061 0 + 0.814072 0.0162995 0 0.822908 0.0157663 0 0.831365 0.0153161 0 0.839477 0.0149582 0 + 0.847282 0.0147039 0 0.854817 0.0145283 0 0.862113 0.0142231 0 0.869094 0.0130461 0 + -0.536321 0.0602471 0 -0.469597 0.0566689 0 -0.401714 0.0538401 0 -0.337109 0.0513215 0 + -0.27546 0.0489797 0 -0.216566 0.0467575 0 -0.160284 0.0446291 0 -0.106499 0.0425832 0 + -0.0551064 0.0406156 0 -0.00601266 0.0387249 0 0.0408736 0.0369106 0 0.0856403 0.0351725 0 + 0.128373 0.0335099 0 0.169154 0.0319217 0 0.208064 0.0304063 0 0.245183 0.028962 0 + 0.280585 0.0275864 0 0.314346 0.0262771 0 0.346537 0.0250315 0 0.377228 0.023847 0 + 0.406485 0.0227208 0 0.434373 0.0216502 0 0.460954 0.0206326 0 0.486288 0.0196654 0 + 0.510433 0.0187463 0 0.533443 0.0178729 0 0.555371 0.0170431 0 0.576268 0.016255 0 + 0.596182 0.0155066 0 0.615159 0.0147963 0 0.633243 0.0141227 0 0.650477 0.0134845 0 + 0.666901 0.0128805 0 0.682552 0.0123099 0 0.697469 0.0117721 0 0.711687 0.0112668 0 + 0.725238 0.0107939 0 0.738157 0.0103537 0 0.750475 0.00994702 0 0.762222 0.00957518 0 + 0.773429 0.00924008 0 0.784126 0.00894445 0 0.794344 0.00869202 0 0.804115 0.00848841 0 + 0.813472 0.00834213 0 0.822454 0.0082569 0 0.831104 0.00824172 0 0.839463 0.00827493 0 + 0.84756 0.00816267 0 0.855301 0.00732832 0 -0.585739 6.04353e-05 0 -0.51647 9.39844e-05 0 + -0.44645 9.23559e-05 0 -0.379805 6.8784e-05 0 -0.3162 2.95756e-05 0 -0.255433 -2.09306e-05 0 + -0.197357 -7.89559e-05 0 -0.141853 -0.000140979 0 -0.0888153 -0.00020376 0 -0.0381481 -0.000264459 0 + 0.0102415 -0.000320745 0 0.0564433 -0.000370839 0 0.100545 -0.000413556 0 0.14263 -0.000448241 0 + 0.182783 -0.000474693 0 0.221085 -0.000493081 0 0.257614 -0.000503845 0 0.292446 -0.000507614 0 + 0.325657 -0.000505124 0 0.357318 -0.000497154 0 0.387497 -0.00048448 0 0.416264 -0.000467834 0 + 0.44368 -0.000447878 0 0.46981 -0.00042519 0 0.494712 -0.000400253 0 0.518443 -0.000373445 0 + 0.541058 -0.000345043 0 0.562609 -0.000315217 0 0.583146 -0.00028403 0 0.602717 -0.000251438 0 + 0.621367 -0.000217284 0 0.639141 -0.000181296 0 0.656079 -0.000143077 0 0.672222 -0.000102093 0 + 0.687607 -5.76622e-05 0 0.702272 -8.93246e-06 0 0.71625 4.51398e-05 0 0.729577 0.00010582 0 + 0.742285 0.000174629 0 0.754406 0.00025339 0 0.765971 0.000344277 0 0.777012 0.000449866 0 + 0.787561 0.000573202 0 0.79765 0.000718515 0 0.807318 0.000891875 0 0.816604 0.00109335 0 + 0.825551 0.001327 0 0.834211 0.00157458 0 0.842591 0.00168197 0 0.850596 0.00121171 0 + -0.53629 -0.0601363 0 -0.469519 -0.0564936 0 -0.401601 -0.0536713 0 -0.336952 -0.0512027 0 + -0.275253 -0.0489415 0 -0.216306 -0.0468215 0 -0.159969 -0.0448091 0 -0.106129 -0.0428863 0 + -0.0546862 -0.0410424 0 -0.00554768 -0.0392704 0 0.0413761 -0.0375655 0 0.0861717 -0.035924 0 + 0.128924 -0.0343431 0 0.169716 -0.0328206 0 0.208628 -0.0313546 0 0.245739 -0.0299437 0 + 0.281127 -0.0285867 0 0.314867 -0.0272824 0 0.34703 -0.0260297 0 0.377688 -0.0248275 0 + 0.406909 -0.0236745 0 0.434757 -0.0225697 0 0.461297 -0.0215115 0 0.486589 -0.0204986 0 + 0.51069 -0.0195295 0 0.533657 -0.0186026 0 0.555543 -0.0177163 0 0.576398 -0.016869 0 + 0.596272 -0.0160588 0 0.61521 -0.015284 0 0.633257 -0.0145429 0 0.650456 -0.0138335 0 + 0.666847 -0.013154 0 0.682468 -0.0125024 0 0.697357 -0.0118767 0 0.711549 -0.011275 0 + 0.725078 -0.0106951 0 0.737977 -0.0101348 0 0.750278 -0.00959182 0 0.762012 -0.00906391 0 + 0.773209 -0.00854866 0 0.783902 -0.00804368 0 0.79412 -0.00754658 0 0.803896 -0.00705479 0 + 0.813267 -0.00656583 0 0.822272 -0.00608097 0 0.830954 -0.00560283 0 0.839362 -0.00514985 0 + 0.847507 -0.00481375 0 0.855284 -0.00491827 0 -0.390654 -0.116393 0 -0.330872 -0.109641 0 + -0.269235 -0.104168 0 -0.210567 -0.0993591 0 -0.154573 -0.0949393 0 -0.101075 -0.09078 0 + -0.0499512 -0.0868197 0 -0.00110124 -0.0830276 0 0.0455635 -0.0793869 0 0.0901268 -0.0758874 0 + 0.13267 -0.0725221 0 0.173272 -0.0692857 0 0.212011 -0.0661742 0 0.248962 -0.0631838 0 + 0.2842 -0.0603116 0 0.317798 -0.0575545 0 0.349828 -0.0549098 0 0.380358 -0.0523746 0 + 0.409455 -0.0499461 0 0.437184 -0.0476212 0 0.463609 -0.045397 0 0.488789 -0.0432702 0 + 0.512783 -0.0412375 0 0.535645 -0.0392956 0 0.557429 -0.0374411 0 0.578186 -0.0356704 0 + 0.597965 -0.0339801 0 0.616812 -0.0323668 0 0.634771 -0.030827 0 0.651884 -0.0293572 0 + 0.668193 -0.0279542 0 0.683735 -0.0266145 0 0.698546 -0.0253349 0 0.712663 -0.024112 0 + 0.726119 -0.0229427 0 0.738946 -0.0218239 0 0.751174 -0.0207523 0 0.762835 -0.0197251 0 + 0.773956 -0.0187392 0 0.784566 -0.0177918 0 0.794693 -0.0168806 0 0.804365 -0.0160032 0 + 0.813611 -0.0151581 0 0.82246 -0.0143442 0 0.830946 -0.013562 0 0.839105 -0.0128151 0 + 0.846975 -0.012111 0 0.8546 -0.011468 0 0.862002 -0.0109335 0 0.869066 -0.0106715 0 + -0.157763 -0.165107 0 -0.108869 -0.156035 0 -0.0573911 -0.148266 0 -0.00834992 -0.141428 0 + 0.0384768 -0.135127 0 0.0832157 -0.129182 0 0.125959 -0.123512 0 0.166785 -0.118077 0 + 0.205767 -0.112856 0 0.242977 -0.107837 0 0.278482 -0.103011 0 0.31235 -0.0983727 0 + 0.344647 -0.093916 0 0.375439 -0.0896365 0 0.40479 -0.0855301 0 0.432763 -0.0815925 0 + 0.459418 -0.0778195 0 0.484816 -0.0742069 0 0.509014 -0.07075 0 0.532068 -0.0674442 0 + 0.554031 -0.0642846 0 0.574956 -0.0612662 0 0.59489 -0.0583839 0 0.613882 -0.0556326 0 + 0.631977 -0.053007 0 0.649216 -0.0505019 0 0.665642 -0.0481123 0 0.681293 -0.0458329 0 + 0.696207 -0.0436589 0 0.710418 -0.0415852 0 0.723961 -0.0396072 0 0.736868 -0.0377201 0 + 0.749169 -0.0359195 0 0.760893 -0.0342008 0 0.77207 -0.0325597 0 0.782725 -0.0309923 0 + 0.792885 -0.0294944 0 0.802574 -0.0280625 0 0.811817 -0.0266928 0 0.820637 -0.0253825 0 + 0.829058 -0.0241287 0 0.837104 -0.0229295 0 0.844798 -0.0217841 0 0.852167 -0.0206928 0 + 0.859237 -0.0196582 0 0.866039 -0.0186867 0 0.872605 -0.0177891 0 0.878972 -0.0169829 0 + 0.885157 -0.0162889 0 0.891065 -0.0156939 0 0.147899 -0.203163 0 0.182796 -0.192696 0 + 0.220842 -0.183225 0 0.257221 -0.174806 0 0.291974 -0.167012 0 0.325166 -0.159641 0 + 0.356857 -0.1526 0 0.387102 -0.145846 0 0.415956 -0.139356 0 0.443473 -0.133117 0 + 0.469705 -0.12712 0 0.494705 -0.121358 0 0.518523 -0.115824 0 0.541212 -0.110513 0 + 0.562821 -0.105421 0 0.5834 -0.100542 0 0.602996 -0.0958711 0 0.621657 -0.091402 0 + 0.639426 -0.0871289 0 0.656348 -0.0830456 0 0.672462 -0.0791457 0 0.68781 -0.0754225 0 + 0.702428 -0.0718694 0 0.716351 -0.0684795 0 0.729615 -0.0652462 0 0.74225 -0.0621628 0 + 0.754288 -0.0592227 0 0.765759 -0.0564194 0 0.776688 -0.0537467 0 0.787103 -0.0511985 0 + 0.797029 -0.0487689 0 0.806489 -0.046452 0 0.815506 -0.0442423 0 0.824102 -0.0421346 0 + 0.832298 -0.0401236 0 0.840113 -0.0382045 0 0.847566 -0.0363727 0 0.854677 -0.0346239 0 + 0.861462 -0.0329541 0 0.86794 -0.03136 0 0.874129 -0.0298389 0 0.880045 -0.0283891 0 + 0.885708 -0.0270102 0 0.891135 -0.0257037 0 0.896349 -0.024474 0 0.90137 -0.0233294 0 + 0.906225 -0.0222833 0 0.910938 -0.0213525 0 0.915524 -0.0205363 0 0.919907 -0.0196793 0 + 0.507497 -0.228179 0 0.526471 -0.217168 0 0.548497 -0.206811 0 0.569827 -0.197388 0 + 0.590272 -0.188588 0 0.609794 -0.180236 0 0.628407 -0.172247 0 0.64614 -0.16458 0 + 0.663024 -0.157212 0 0.679091 -0.150129 0 0.694374 -0.143321 0 0.708907 -0.136783 0 + 0.722725 -0.130507 0 0.735861 -0.124489 0 0.748349 -0.118723 0 0.760221 -0.113202 0 + 0.77151 -0.10792 0 0.782246 -0.10287 0 0.792458 -0.0980458 0 0.802174 -0.0934386 0 + 0.81142 -0.089041 0 0.820219 -0.0848451 0 0.828597 -0.0808428 0 0.836573 -0.0770262 0 + 0.84417 -0.0733874 0 0.851405 -0.0699185 0 0.858298 -0.066612 0 0.864866 -0.0634603 0 + 0.871125 -0.0604563 0 0.87709 -0.057593 0 0.882776 -0.0548637 0 0.888196 -0.0522618 0 + 0.893365 -0.0497811 0 0.898294 -0.0474158 0 0.902995 -0.0451601 0 0.907481 -0.0430086 0 + 0.911762 -0.0409563 0 0.91585 -0.0389986 0 0.919754 -0.0371313 0 0.923486 -0.0353509 0 + 0.927056 -0.0336547 0 0.930475 -0.0320413 0 0.933753 -0.0305106 0 0.936903 -0.0290651 0 + 0.939936 -0.0277102 0 0.942868 -0.0264556 0 0.945711 -0.025316 0 0.948483 -0.0243081 0 + 0.95119 -0.0234145 0 0.95378 -0.02238 0 0.898544 -0.238997 0 0.90091 -0.227813 0 + 0.905442 -0.217412 0 0.910206 -0.207663 0 0.914911 -0.198432 0 0.919425 -0.189622 0 + 0.923706 -0.181177 0 0.927741 -0.173064 0 0.931529 -0.165265 0 0.935078 -0.157768 0 + 0.9384 -0.150565 0 0.941507 -0.143651 0 0.944413 -0.137019 0 0.947134 -0.130664 0 + 0.949685 -0.124579 0 0.95208 -0.118759 0 0.954331 -0.113195 0 0.956451 -0.10788 0 + 0.95845 -0.102805 0 0.960339 -0.0979628 0 0.962127 -0.0933432 0 0.963821 -0.0889377 0 + 0.965428 -0.0847376 0 0.966954 -0.0807339 0 0.968406 -0.0769181 0 0.969787 -0.0732816 0 + 0.971103 -0.0698162 0 0.972357 -0.0665139 0 0.973554 -0.063367 0 0.974697 -0.0603682 0 + 0.975788 -0.0575102 0 0.976831 -0.0547862 0 0.977829 -0.0521898 0 0.978784 -0.0497146 0 + 0.979699 -0.0473548 0 0.980578 -0.0451049 0 0.981421 -0.0429596 0 0.982232 -0.0409142 0 + 0.983014 -0.0389646 0 0.983769 -0.0371071 0 0.9845 -0.0353393 0 0.98521 -0.0336598 0 + 0.985903 -0.032069 0 0.986582 -0.0305696 0 0.98725 -0.0291676 0 0.987913 -0.0278735 0 + 0.988575 -0.0267028 0 0.989241 -0.0256712 0 0.98991 -0.024752 0 0.990554 -0.02363 0 + 1.29626 -0.235039 0 1.28232 -0.224084 0 1.26919 -0.214261 0 1.25698 -0.204861 0 + 1.24552 -0.195823 0 1.23462 -0.187127 0 1.2242 -0.178758 0 1.21418 -0.170703 0 + 1.20455 -0.162954 0 1.19529 -0.155505 0 1.18637 -0.148352 0 1.1778 -0.141491 0 + 1.16956 -0.134916 0 1.16166 -0.128621 0 1.15408 -0.1226 0 1.14682 -0.116847 0 + 1.13988 -0.111351 0 1.13323 -0.106106 0 1.12689 -0.101102 0 1.12083 -0.0963293 0 + 1.11504 -0.0917792 0 1.10952 -0.0874422 0 1.10426 -0.0833091 0 1.09925 -0.0793707 0 + 1.09446 -0.0756181 0 1.08991 -0.0720429 0 1.08557 -0.0686366 0 1.08144 -0.0653913 0 + 1.0775 -0.0622992 0 1.07376 -0.0593529 0 1.07019 -0.0565454 0 1.0668 -0.0538699 0 + 1.06357 -0.0513201 0 1.06049 -0.0488897 0 1.05757 -0.0465731 0 1.05479 -0.0443649 0 + 1.05215 -0.0422599 0 1.04963 -0.0402537 0 1.04725 -0.0383421 0 1.04498 -0.0365219 0 + 1.04284 -0.0347906 0 1.0408 -0.033147 0 1.03887 -0.0315915 0 1.03704 -0.030127 0 + 1.03531 -0.0287596 0 1.03367 -0.0274998 0 1.03211 -0.0263631 0 1.03064 -0.0253653 0 + 1.02925 -0.0244764 0 1.02792 -0.0233574 0 1.67554 -0.216324 0 1.64633 -0.206331 0 + 1.61642 -0.197578 0 1.58808 -0.189111 0 1.56115 -0.180851 0 1.53545 -0.172826 0 + 1.51088 -0.165061 0 1.48735 -0.157568 0 1.46482 -0.150355 0 1.44323 -0.143422 0 + 1.42257 -0.136771 0 1.4028 -0.130398 0 1.38389 -0.124298 0 1.36583 -0.118465 0 + 1.34858 -0.112893 0 1.33211 -0.107573 0 1.3164 -0.102497 0 1.30141 -0.097656 0 + 1.28712 -0.0930407 0 1.27349 -0.0886418 0 1.2605 -0.08445 0 1.24813 -0.0804563 0 + 1.23634 -0.0766516 0 1.2251 -0.0730272 0 1.2144 -0.0695746 0 1.2042 -0.0662858 0 + 1.19449 -0.0631528 0 1.18524 -0.0601683 0 1.17643 -0.0573249 0 1.16803 -0.0546159 0 + 1.16004 -0.0520347 0 1.15243 -0.049575 0 1.14518 -0.0472311 0 1.13828 -0.0449973 0 + 1.1317 -0.0428682 0 1.12544 -0.0408391 0 1.11949 -0.0389052 0 1.11382 -0.0370624 0 + 1.10842 -0.035307 0 1.10328 -0.033636 0 1.09839 -0.0320471 0 1.09374 -0.0305393 0 + 1.08932 -0.0291129 0 1.0851 -0.0277705 0 1.08108 -0.0265177 0 1.07725 -0.0253644 0 + 1.07359 -0.0243258 0 1.07008 -0.0234187 0 1.06672 -0.0226174 0 1.06352 -0.0215899 0 + 2.01234 -0.184102 0 1.96972 -0.175714 0 1.92501 -0.168494 0 1.88238 -0.161419 0 + 1.84165 -0.154417 0 1.80271 -0.147548 0 1.76544 -0.140868 0 1.72978 -0.134411 0 + 1.69567 -0.128194 0 1.66306 -0.122227 0 1.63191 -0.11651 0 1.60215 -0.111041 0 + 1.57376 -0.105814 0 1.54667 -0.100824 0 1.52083 -0.0960626 0 1.49619 -0.0915217 0 + 1.47271 -0.0871928 0 1.45034 -0.0830674 0 1.42901 -0.0791367 0 1.4087 -0.0753922 0 + 1.38934 -0.0718255 0 1.3709 -0.0684283 0 1.35333 -0.0651927 0 1.3366 -0.0621109 0 + 1.32066 -0.0591757 0 1.30547 -0.0563799 0 1.29101 -0.0537169 0 1.27723 -0.05118 0 + 1.26411 -0.0487633 0 1.2516 -0.0464608 0 1.23969 -0.0442671 0 1.22835 -0.0421767 0 + 1.21754 -0.0401847 0 1.20725 -0.0382864 0 1.19744 -0.0364773 0 1.18811 -0.0347532 0 + 1.17921 -0.0331102 0 1.17074 -0.0315448 0 1.16268 -0.0300539 0 1.155 -0.0286348 0 + 1.14768 -0.0272856 0 1.14071 -0.0260053 0 1.13407 -0.0247939 0 1.12774 -0.0236536 0 + 1.1217 -0.022589 0 1.11593 -0.0216086 0 1.1104 -0.0207266 0 1.10508 -0.0199617 0 + 1.09998 -0.0193018 0 1.09512 -0.0184516 0 2.2854 -0.140392 0 2.23194 -0.134212 0 + 2.17523 -0.128863 0 2.12093 -0.123504 0 2.06889 -0.118123 0 2.01904 -0.112808 0 + 1.97134 -0.107632 0 1.92573 -0.102633 0 1.88216 -0.0978314 0 1.84058 -0.0932335 0 + 1.8009 -0.0888387 0 1.76307 -0.0846431 0 1.727 -0.0806408 0 1.69263 -0.0768248 0 + 1.65987 -0.0731878 0 1.62867 -0.0697225 0 1.59893 -0.0664215 0 1.57061 -0.0632773 0 + 1.54363 -0.0602828 0 1.51792 -0.057431 0 1.49344 -0.0547152 0 1.47012 -0.0521289 0 + 1.4479 -0.0496657 0 1.42674 -0.0473199 0 1.40658 -0.0450856 0 1.38737 -0.0429574 0 + 1.36908 -0.0409302 0 1.35165 -0.0389991 0 1.33504 -0.0371593 0 1.31922 -0.0354064 0 + 1.30415 -0.0337363 0 1.28979 -0.0321449 0 1.27611 -0.0306284 0 1.26308 -0.0291832 0 + 1.25067 -0.0278059 0 1.23884 -0.0264935 0 1.22757 -0.0252428 0 1.21684 -0.0240513 0 + 1.20662 -0.0229165 0 1.19688 -0.0218363 0 1.1876 -0.0208093 0 1.17876 -0.0198342 0 + 1.17033 -0.0189112 0 1.16229 -0.0180414 0 1.15462 -0.0172278 0 1.14728 -0.0164771 0 + 1.14024 -0.015801 0 1.13346 -0.0152197 0 1.12694 -0.0147432 0 1.12073 -0.0141526 0 + 2.47746 -0.0878818 0 2.41618 -0.0843527 0 2.35078 -0.0810423 0 2.28794 -0.0776148 0 + 2.22766 -0.0741495 0 2.16995 -0.070737 0 2.11481 -0.0674305 0 2.0622 -0.0642545 0 + 2.01202 -0.0612173 0 1.9642 -0.0583191 0 1.91862 -0.0555564 0 1.87521 -0.0529241 0 + 1.83384 -0.0504166 0 1.79444 -0.0480285 0 1.75691 -0.0457543 0 1.72116 -0.0435886 0 + 1.68711 -0.0415262 0 1.65467 -0.0395624 0 1.62377 -0.0376923 0 1.59433 -0.0359114 0 + 1.56629 -0.0342155 0 1.53958 -0.0326003 0 1.51413 -0.0310619 0 1.48988 -0.0295966 0 + 1.46679 -0.0282009 0 1.44478 -0.0268713 0 1.42381 -0.0256047 0 1.40383 -0.024398 0 + 1.3848 -0.0232483 0 1.36666 -0.0221528 0 1.34938 -0.0211089 0 1.33292 -0.0201142 0 + 1.31723 -0.0191663 0 1.30228 -0.018263 0 1.28804 -0.0174021 0 1.27447 -0.0165818 0 + 1.26155 -0.0158001 0 1.24923 -0.0150553 0 1.23749 -0.014346 0 1.22631 -0.0136707 0 + 1.21566 -0.0130283 0 1.2055 -0.012418 0 1.19582 -0.0118396 0 1.18659 -0.0112934 0 + 1.17777 -0.0107808 0 1.16934 -0.0103053 0 1.16125 -0.00987476 0 1.15348 -0.00950592 0 + 1.14596 -0.00922838 0 1.13878 -0.00895564 0 2.57602 -0.0299003 0 2.50966 -0.0288379 0 + 2.43899 -0.0277012 0 2.37125 -0.0264925 0 2.30654 -0.0252746 0 2.24484 -0.0240858 0 + 2.18605 -0.0229433 0 2.13006 -0.0218524 0 2.07673 -0.0208135 0 2.02593 -0.0198248 0 + 1.97754 -0.0188841 0 1.93145 -0.0179888 0 1.88754 -0.0171367 0 1.84572 -0.0163255 0 + 1.80587 -0.0155533 0 1.7679 -0.014818 0 1.73173 -0.0141178 0 1.69727 -0.0134511 0 + 1.66444 -0.0128162 0 1.63315 -0.0122115 0 1.60335 -0.0116356 0 1.57494 -0.011087 0 + 1.54788 -0.0105645 0 1.52209 -0.0100667 0 1.49751 -0.00959245 0 1.4741 -0.00914065 0 + 1.45178 -0.0087102 0 1.43052 -0.00830005 0 1.41026 -0.00790925 0 1.39095 -0.00753685 0 + 1.37255 -0.00718199 0 1.35502 -0.00684383 0 1.33832 -0.00652157 0 1.3224 -0.00621446 0 + 1.30722 -0.00592179 0 1.29277 -0.00564288 0 1.27899 -0.00537711 0 1.26587 -0.0051239 0 + 1.25336 -0.00488269 0 1.24144 -0.00465301 0 1.23008 -0.00443444 0 1.21925 -0.00422667 0 + 1.20893 -0.00402949 0 1.19909 -0.00384289 0 1.18971 -0.00366716 0 1.18074 -0.00350328 0 + 1.17217 -0.00335373 0 1.16395 -0.00322528 0 1.156 -0.00313604 0 1.14822 -0.00308372 0 + </DataArray> + <DataArray type="Float32" Name="process rank" NumberOfComponents="1" format="ascii"> + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 0 0 0 0 0 0 0 0 + 0 0 0 0 + </DataArray> + <DataArray type="Float32" Name="pressureExact" NumberOfComponents="1" format="ascii"> + -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 + 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 + 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 + 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 + 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 + 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 + 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 + 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 + 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 + -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 + 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 + 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 + 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 + -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 + 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 + 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 + 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 + -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 + 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 + 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 + 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 + -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 + 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 + 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 + 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 + -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 + 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 + 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 + 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 + 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 + 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 + 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 + 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 + 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 + -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 + 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 + 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 + 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 + -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 + 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 + 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 + 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 + -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 + 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 + 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 + 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 + -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 + 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 + 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 + 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 + -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 + 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 + 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 + 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 + 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 + 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 + 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 + 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 + 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 + -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 + 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 + 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 + 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 + -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 + 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 + 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 + 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 + -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 + 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 + 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 + 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 + -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 + 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 + 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 + 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 + -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 + 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 + 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 + 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 + 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 + 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 + 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 + 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 + 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 + -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 + 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 + 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 + 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 + -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 + 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 + 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 + 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 + -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 + 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 + 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 + 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 + -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 + 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 + 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 + 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 + -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 + 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 + 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 + 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 + 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 + 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 + 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 + 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 + 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 + -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 + 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 + 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 + 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 + -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 + 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 + 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 + 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 + -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 + 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 + 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 + 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 + -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 + 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 + 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 + 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 + -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 + 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 + 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 + 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 + 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 + 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 + 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 + 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 + 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 + -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 + 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 + 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 + 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 + -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 + 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 + 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 + 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 + -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 + 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 + 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 + 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 + -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 + 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 + 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 + 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 + -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 + 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 + 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 + 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 + 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 + 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 + 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 + 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 + 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 + -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 + 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 + 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 + 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 + -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 + 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 + 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 + 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 + -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 + 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 + 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 + 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 + -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 + 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 + 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 + 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 + -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 + 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 + 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 + 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 + 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 + 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 + 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 + 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 + 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 + -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 + 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 + 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 + 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 + -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 + 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 + 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 + 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 + -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 + 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 + 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 + 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 -0.749079 -0.634319 + -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 0.107054 0.143156 + 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 0.376383 0.387741 + 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 0.461112 0.464685 + 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 0.487766 0.48889 + -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 0.0235222 0.067299 + 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 0.350105 0.363877 + 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 0.452845 0.457177 + 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 0.485166 0.486528 + 0.487766 0.48889 -0.749079 -0.634319 -0.530102 -0.435461 -0.349515 -0.271465 -0.200586 -0.136219 -0.0777661 -0.0246834 + 0.0235222 0.067299 0.107054 0.143156 0.175941 0.205714 0.232752 0.257306 0.279603 0.299852 0.318241 0.33494 + 0.350105 0.363877 0.376383 0.387741 0.398055 0.407421 0.415927 0.423651 0.430666 0.437036 0.442821 0.448074 + 0.452845 0.457177 0.461112 0.464685 0.467929 0.470876 0.473552 0.475981 0.478188 0.480192 0.482012 0.483665 + 0.485166 0.486528 0.487766 0.48889 + </DataArray> + <DataArray type="Float32" Name="velocityExact" NumberOfComponents="3" format="ascii"> + 2.56809 0.0303848 0 2.49432 0.0289554 0 2.42402 0.0275932 0 2.35703 0.0262951 0 + 2.29319 0.025058 0 2.23235 0.0238792 0 2.17438 0.0227558 0 2.11913 0.0216853 0 + 2.06648 0.0206651 0 2.01631 0.0196929 0 1.9685 0.0187665 0 1.92293 0.0178836 0 + 1.87952 0.0170423 0 1.83814 0.0162406 0 1.79871 0.0154765 0 1.76113 0.0147484 0 + 1.72533 0.0140546 0 1.6912 0.0133934 0 1.65869 0.0127633 0 1.6277 0.0121629 0 + 1.59817 0.0115907 0 1.57003 0.0110454 0 1.54321 0.0105258 0 1.51766 0.0100306 0 + 1.4933 0.00955872 0 1.4701 0.00910904 0 1.44798 0.00868051 0 1.42691 0.00827214 0 + 1.40682 0.00788298 0 1.38768 0.00751213 0 1.36945 0.00715872 0 1.35207 0.00682195 0 + 1.3355 0.00650101 0 1.31972 0.00619517 0 1.30468 0.00590373 0 1.29034 0.00562599 0 + 1.27669 0.00536132 0 1.26367 0.0051091 0 1.25127 0.00486874 0 1.23944 0.00463969 0 + 1.22818 0.00442142 0 1.21745 0.00421342 0 1.20722 0.0040152 0 1.19747 0.00382631 0 + 1.18818 0.0036463 0 1.17932 0.00347476 0 1.17089 0.00331129 0 1.16285 0.00315552 0 + 1.15519 0.00300707 0 1.14789 0.0028656 0 2.46956 0.0892452 0 2.40043 0.0850467 0 + 2.33455 0.0810457 0 2.27176 0.077233 0 2.21193 0.0735996 0 2.15492 0.0701372 0 + 2.10059 0.0668376 0 2.04881 0.0636933 0 1.99947 0.0606968 0 1.95245 0.0578414 0 + 1.90764 0.0551203 0 1.86494 0.0525272 0 1.82425 0.0500561 0 1.78548 0.0477012 0 + 1.74852 0.0454571 0 1.71331 0.0433186 0 1.67975 0.0412807 0 1.64777 0.0393387 0 + 1.6173 0.037488 0 1.58826 0.0357244 0 1.56058 0.0340438 0 1.53421 0.0324422 0 + 1.50908 0.030916 0 1.48513 0.0294616 0 1.46231 0.0280756 0 1.44056 0.0267548 0 + 1.41983 0.0254961 0 1.40008 0.0242966 0 1.38126 0.0231536 0 1.36332 0.0220644 0 + 1.34623 0.0210264 0 1.32994 0.0200372 0 1.31442 0.0190946 0 1.29963 0.0181963 0 + 1.28553 0.0173402 0 1.2721 0.0165245 0 1.2593 0.0157471 0 1.2471 0.0150063 0 + 1.23548 0.0143003 0 1.2244 0.0136276 0 1.21384 0.0129865 0 1.20378 0.0123755 0 + 1.1942 0.0117933 0 1.18506 0.0112385 0 1.17635 0.0107098 0 1.16806 0.010206 0 + 1.16015 0.00972582 0 1.15262 0.00926828 0 1.14544 0.00883226 0 1.1386 0.00841675 0 + 2.2787 0.142498 0 2.21854 0.135794 0 2.16122 0.129406 0 2.10659 0.123318 0 + 2.05453 0.117517 0 2.00492 0.111988 0 1.95764 0.10672 0 1.91259 0.101699 0 + 1.86966 0.0969148 0 1.82875 0.0923555 0 1.78976 0.0880107 0 1.7526 0.0838702 0 + 1.7172 0.0799246 0 1.68346 0.0761646 0 1.65131 0.0725815 0 1.62066 0.0691669 0 + 1.59147 0.065913 0 1.56364 0.0628122 0 1.53712 0.0598572 0 1.51186 0.0570413 0 + 1.48778 0.0543578 0 1.46483 0.0518005 0 1.44296 0.0493636 0 1.42212 0.0470413 0 + 1.40226 0.0448283 0 1.38334 0.0427194 0 1.36531 0.0407097 0 1.34812 0.0387945 0 + 1.33174 0.0369694 0 1.31614 0.0352302 0 1.30126 0.0335728 0 1.28709 0.0319934 0 + 1.27358 0.0304883 0 1.26071 0.029054 0 1.24845 0.0276872 0 1.23676 0.0263846 0 + 1.22562 0.0251434 0 1.21501 0.0239605 0 1.20489 0.0228333 0 1.19525 0.0217591 0 + 1.18607 0.0207355 0 1.17732 0.01976 0 1.16897 0.0188304 0 1.16102 0.0179445 0 + 1.15345 0.0171004 0 1.14623 0.0162959 0 1.13935 0.0155292 0 1.13279 0.0147987 0 + 1.12655 0.0141025 0 1.12059 0.013439 0 2.00748 0.186797 0 1.96009 0.178009 0 + 1.91492 0.169635 0 1.87188 0.161655 0 1.83086 0.15405 0 1.79177 0.146803 0 + 1.75453 0.139896 0 1.71903 0.133315 0 1.6852 0.127043 0 1.65297 0.121067 0 + 1.62225 0.115371 0 1.59298 0.109943 0 1.56508 0.104771 0 1.5385 0.0998423 0 + 1.51316 0.0951453 0 1.48902 0.0906692 0 1.46602 0.0864037 0 1.44409 0.0823389 0 + 1.4232 0.0784653 0 1.40329 0.074774 0 1.38432 0.0712563 0 1.36624 0.0679041 0 + 1.34901 0.0647096 0 1.33259 0.0616653 0 1.31694 0.0587643 0 1.30203 0.0559998 0 + 1.28782 0.0533653 0 1.27428 0.0508548 0 1.26138 0.0484623 0 1.24908 0.0461824 0 + 1.23737 0.0440098 0 1.2262 0.0419394 0 1.21556 0.0399664 0 1.20542 0.0380862 0 + 1.19575 0.0362944 0 1.18654 0.034587 0 1.17777 0.0329599 0 1.1694 0.0314093 0 + 1.16144 0.0299316 0 1.15384 0.0285235 0 1.1466 0.0271817 0 1.13971 0.0259029 0 + 1.13313 0.0246843 0 1.12687 0.0235231 0 1.1209 0.0224164 0 1.11521 0.0213619 0 + 1.10979 0.0203569 0 1.10463 0.0193992 0 1.09971 0.0184866 0 1.09502 0.0176169 0 + 1.67297 0.219359 0 1.64131 0.20904 0 1.61114 0.199205 0 1.58239 0.189834 0 + 1.55499 0.180903 0 1.52888 0.172393 0 1.504 0.164283 0 1.48029 0.156554 0 + 1.45769 0.149189 0 1.43616 0.142171 0 1.41564 0.135482 0 1.39609 0.129108 0 + 1.37746 0.123035 0 1.3597 0.117247 0 1.34278 0.111731 0 1.32665 0.106474 0 + 1.31128 0.101465 0 1.29664 0.096692 0 1.28268 0.0921432 0 1.26939 0.0878084 0 + 1.25671 0.0836775 0 1.24464 0.0797409 0 1.23313 0.0759895 0 1.22216 0.0724147 0 + 1.21171 0.0690079 0 1.20175 0.0657615 0 1.19226 0.0626678 0 1.18321 0.0597196 0 + 1.17459 0.0569101 0 1.16638 0.0542328 0 1.15855 0.0516815 0 1.15109 0.0492502 0 + 1.14399 0.0469332 0 1.13721 0.0447253 0 1.13076 0.0426212 0 1.12461 0.0406161 0 + 1.11874 0.0387053 0 1.11316 0.0368845 0 1.10783 0.0351493 0 1.10276 0.0334957 0 + 1.09793 0.0319199 0 1.09332 0.0304182 0 1.08893 0.0289872 0 1.08475 0.0276235 0 + 1.08076 0.026324 0 1.07696 0.0250856 0 1.07334 0.0239055 0 1.06989 0.0227808 0 + 1.0666 0.0217091 0 1.06347 0.0206878 0 1.29617 0.238138 0 1.28223 0.226935 0 + 1.26896 0.216259 0 1.2563 0.206085 0 1.24425 0.19639 0 1.23276 0.187151 0 + 1.22181 0.178346 0 1.21137 0.169956 0 1.20143 0.161961 0 1.19195 0.154341 0 + 1.18292 0.14708 0 1.17432 0.140161 0 1.16611 0.133567 0 1.1583 0.127284 0 + 1.15085 0.121296 0 1.14376 0.115589 0 1.13699 0.110152 0 1.13055 0.10497 0 + 1.12441 0.100031 0 1.11855 0.0953254 0 1.11298 0.0908409 0 1.10766 0.0865673 0 + 1.1026 0.0824948 0 1.09777 0.0786139 0 1.09317 0.0749156 0 1.08879 0.0713912 0 + 1.08461 0.0680326 0 1.08063 0.0648321 0 1.07684 0.0617821 0 1.07322 0.0588756 0 + 1.06978 0.0561058 0 1.06649 0.0534663 0 1.06337 0.0509511 0 1.06039 0.0485541 0 + 1.05754 0.0462699 0 1.05484 0.0440931 0 1.05226 0.0420188 0 1.0498 0.0400421 0 + 1.04746 0.0381583 0 1.04522 0.0363632 0 1.0431 0.0346525 0 1.04107 0.0330223 0 + 1.03914 0.0314688 0 1.0373 0.0299883 0 1.03554 0.0285775 0 1.03387 0.0272331 0 + 1.03228 0.025952 0 1.03076 0.0247311 0 1.02931 0.0235676 0 1.02793 0.0224589 0 + 0.900756 0.241954 0 0.905425 0.230571 0 0.909874 0.219724 0 0.914114 0.209387 0 + 0.918155 0.199537 0 0.922005 0.19015 0 0.925674 0.181204 0 0.929171 0.17268 0 + 0.932503 0.164556 0 0.935678 0.156814 0 0.938704 0.149437 0 0.941588 0.142407 0 + 0.944336 0.135708 0 0.946955 0.129323 0 0.94945 0.123239 0 0.951828 0.117442 0 + 0.954094 0.111917 0 0.956254 0.106652 0 0.958312 0.101634 0 0.960273 0.0968529 0 + 0.962142 0.0922965 0 0.963923 0.0879544 0 0.96562 0.0838167 0 0.967238 0.0798736 0 + 0.968779 0.076116 0 0.970248 0.0725351 0 0.971647 0.0691227 0 0.972981 0.0658709 0 + 0.974252 0.062772 0 0.975464 0.059819 0 0.976618 0.0570048 0 0.977718 0.0543231 0 + 0.978766 0.0517675 0 0.979765 0.0493321 0 0.980717 0.0470113 0 0.981624 0.0447997 0 + 0.982489 0.0426921 0 0.983312 0.0406837 0 0.984098 0.0387697 0 0.984846 0.0369458 0 + 0.985559 0.0352077 0 0.986238 0.0335514 0 0.986885 0.031973 0 0.987502 0.0304688 0 + 0.98809 0.0290354 0 0.988651 0.0276695 0 0.989185 0.0263678 0 0.989693 0.0251273 0 + 0.990178 0.0239452 0 0.99064 0.0228187 0 0.511581 0.230567 0 0.534559 0.21972 0 + 0.556455 0.209383 0 0.577321 0.199533 0 0.597206 0.190146 0 0.616155 0.181201 0 + 0.634213 0.172676 0 0.651421 0.164553 0 0.66782 0.156811 0 0.683447 0.149434 0 + 0.698339 0.142404 0 0.712531 0.135705 0 0.726055 0.129321 0 0.738942 0.123237 0 + 0.751224 0.117439 0 0.762927 0.111914 0 0.77408 0.106649 0 0.784708 0.101632 0 + 0.794837 0.096851 0 0.804488 0.0922947 0 0.813686 0.0879527 0 0.822451 0.083815 0 + 0.830804 0.079872 0 0.838764 0.0761145 0 0.846349 0.0725337 0 0.853577 0.0691214 0 + 0.860466 0.0658696 0 0.86703 0.0627708 0 0.873286 0.0598178 0 0.879247 0.0570037 0 + 0.884928 0.054322 0 0.890341 0.0517664 0 0.8955 0.0493311 0 0.900416 0.0470104 0 + 0.905101 0.0447988 0 0.909565 0.0426913 0 0.91382 0.0406829 0 0.917874 0.038769 0 + 0.921738 0.0369451 0 0.92542 0.035207 0 0.928928 0.0335507 0 0.932272 0.0319724 0 + 0.935458 0.0304682 0 0.938494 0.0290349 0 0.941388 0.0276689 0 0.944145 0.0263673 0 + 0.946773 0.0251268 0 0.949277 0.0239448 0 0.951663 0.0228183 0 0.953937 0.0217448 0 + 0.153096 0.204692 0 0.192938 0.195063 0 0.230906 0.185886 0 0.267087 0.177141 0 + 0.301567 0.168808 0 0.334424 0.160866 0 0.365736 0.153298 0 0.395574 0.146086 0 + 0.424009 0.139214 0 0.451106 0.132665 0 0.476929 0.126423 0 0.501536 0.120476 0 + 0.524986 0.114808 0 0.547333 0.109407 0 0.568629 0.10426 0 0.588922 0.0993553 0 + 0.608261 0.0946812 0 0.62669 0.0902269 0 0.644252 0.0859823 0 0.660988 0.0819373 0 + 0.676937 0.0780826 0 0.692135 0.0744092 0 0.706619 0.0709087 0 0.720421 0.0675728 0 + 0.733573 0.0643939 0 0.746107 0.0613645 0 0.758051 0.0584777 0 0.769434 0.0557266 0 + 0.780281 0.053105 0 0.790617 0.0506067 0 0.800468 0.0482259 0 0.809854 0.0459572 0 + 0.8188 0.0437951 0 0.827324 0.0417348 0 0.835448 0.0397714 0 0.843189 0.0379004 0 + 0.850566 0.0361174 0 0.857596 0.0344183 0 0.864295 0.0327991 0 0.870679 0.0312561 0 + 0.876763 0.0297856 0 0.882561 0.0283844 0 0.888086 0.0270491 0 0.893351 0.0257766 0 + 0.898368 0.0245639 0 0.903149 0.0234083 0 0.907705 0.0223071 0 0.912047 0.0212577 0 + 0.916185 0.0202576 0 0.920128 0.0193046 0 -0.152176 0.165956 0 -0.0979723 0.158149 0 + -0.0463188 0.150709 0 0.00290468 0.143619 0 0.0498125 0.136862 0 0.0945135 0.130424 0 + 0.137112 0.124288 0 0.177706 0.118441 0 0.21639 0.112869 0 0.253255 0.107559 0 + 0.288385 0.102499 0 0.321862 0.0976771 0 0.353765 0.0930819 0 0.384167 0.0887029 0 + 0.413138 0.0845299 0 0.440747 0.0805533 0 0.467057 0.0767637 0 0.492129 0.0731524 0 + 0.516021 0.069711 0 0.53879 0.0664314 0 0.560487 0.0633062 0 0.581164 0.060328 0 + 0.600868 0.0574899 0 0.619645 0.0547853 0 0.637538 0.052208 0 0.65459 0.0497519 0 + 0.67084 0.0474113 0 0.686325 0.0451809 0 0.701082 0.0430554 0 0.715144 0.0410299 0 + 0.728545 0.0390996 0 0.741315 0.0372602 0 0.753485 0.0355073 0 0.765082 0.0338369 0 + 0.776134 0.0322451 0 0.786665 0.0307281 0 0.796702 0.0292825 0 0.806266 0.0279049 0 + 0.81538 0.0265922 0 0.824065 0.0253412 0 0.832342 0.024149 0 0.840229 0.0230129 0 + 0.847746 0.0219303 0 0.854908 0.0208986 0 0.861734 0.0199154 0 0.868239 0.0189785 0 + 0.874437 0.0180857 0 0.880344 0.0172349 0 0.885974 0.016424 0 0.891338 0.0156514 0 + -0.385052 0.116793 0 -0.319893 0.111298 0 -0.257799 0.106062 0 -0.198627 0.101073 0 + -0.142238 0.0963176 0 -0.088502 0.0917864 0 -0.037294 0.0874684 0 0.0115049 0.0833535 0 + 0.0580081 0.0794322 0 0.102324 0.0756953 0 0.144554 0.0721343 0 0.184798 0.0687407 0 + 0.223149 0.0655069 0 0.259696 0.0624251 0 0.294523 0.0594884 0 0.327712 0.0566898 0 + 0.359339 0.0540228 0 0.389479 0.0514814 0 0.4182 0.0490595 0 0.445571 0.0467515 0 + 0.471653 0.0445521 0 0.496509 0.0424562 0 0.520196 0.0404588 0 0.542768 0.0385555 0 + 0.564278 0.0367416 0 0.584776 0.0350132 0 0.60431 0.033366 0 0.622925 0.0317963 0 + 0.640665 0.0303005 0 0.657569 0.028875 0 0.673679 0.0275166 0 0.68903 0.0262221 0 + 0.70366 0.0249885 0 0.717601 0.0238129 0 0.730886 0.0226926 0 0.743547 0.0216251 0 + 0.755611 0.0206077 0 0.767108 0.0196383 0 0.778065 0.0187144 0 0.788506 0.017834 0 + 0.798455 0.016995 0 0.807937 0.0161955 0 0.816972 0.0154336 0 0.825583 0.0147075 0 + 0.833788 0.0140156 0 0.841607 0.0133562 0 0.849059 0.0127279 0 0.85616 0.0121291 0 + 0.862927 0.0115585 0 0.869375 0.0110147 0 -0.5309 0.0602904 0 -0.45888 0.0574541 0 + -0.390247 0.0547512 0 -0.324844 0.0521755 0 -0.262517 0.0497209 0 -0.203123 0.0473818 0 + -0.146523 0.0451527 0 -0.0925852 0.0430286 0 -0.0411851 0.0410043 0 0.00779687 0.0390753 0 + 0.0544745 0.037237 0 0.0989563 0.0354852 0 0.141345 0.0338158 0 0.18174 0.032225 0 + 0.220235 0.030709 0 0.256919 0.0292643 0 0.291876 0.0278876 0 0.32519 0.0265756 0 + 0.356936 0.0253254 0 0.387188 0.024134 0 0.416018 0.0229986 0 0.443491 0.0219166 0 + 0.469672 0.0208856 0 0.494621 0.019903 0 0.518396 0.0189667 0 0.541053 0.0180744 0 + 0.562644 0.0172241 0 0.583219 0.0164138 0 0.602826 0.0156416 0 0.621511 0.0149058 0 + 0.639317 0.0142046 0 0.656285 0.0135363 0 0.672455 0.0128995 0 0.687864 0.0122926 0 + 0.702548 0.0117143 0 0.716542 0.0111633 0 0.729877 0.0106381 0 0.742585 0.0101376 0 + 0.754695 0.0096607 0 0.766235 0.00920622 0 0.777232 0.00877312 0 0.787712 0.00836039 0 + 0.797699 0.00796708 0 0.807216 0.00759227 0 0.816286 0.0072351 0 0.824928 0.00689473 0 + 0.833165 0.00657037 0 0.841013 0.00626127 0 0.848493 0.00596671 0 0.85562 0.00568601 0 + -0.580556 -1.58545e-17 0 -0.5062 -1.51086e-17 0 -0.435341 -1.43978e-17 0 -0.367817 -1.37205e-17 0 + -0.303468 -1.3075e-17 0 -0.242147 -1.24599e-17 0 -0.183711 -1.18737e-17 0 -0.128024 -1.13151e-17 0 + -0.0749569 -1.07828e-17 0 -0.0243861 -1.02756e-17 0 0.0238056 -9.79215e-18 0 0.0697301 -9.33148e-18 0 + 0.113494 -8.89249e-18 0 0.155199 -8.47414e-18 0 0.194943 -8.07548e-18 0 0.232816 -7.69558e-18 0 + 0.268908 -7.33354e-18 0 0.303302 -6.98854e-18 0 0.336077 -6.65977e-18 0 0.367311 -6.34646e-18 0 + 0.397076 -6.0479e-18 0 0.42544 -5.76338e-18 0 0.45247 -5.49224e-18 0 0.478228 -5.23386e-18 0 + 0.502775 -4.98764e-18 0 0.526166 -4.753e-18 0 0.548458 -4.52939e-18 0 0.5697 -4.31631e-18 0 + 0.589943 -4.11325e-18 0 0.609234 -3.91975e-18 0 0.627618 -3.73535e-18 0 0.645136 -3.55962e-18 0 + 0.661831 -3.39216e-18 0 0.67774 -3.23258e-18 0 0.6929 -3.0805e-18 0 0.707347 -2.93558e-18 0 + 0.721115 -2.79748e-18 0 0.734235 -2.66587e-18 0 0.746738 -2.54046e-18 0 0.758652 -2.42094e-18 0 + 0.770007 -2.30705e-18 0 0.780826 -2.19852e-18 0 0.791137 -2.09509e-18 0 0.800963 -1.99653e-18 0 + 0.810327 -1.9026e-18 0 0.81925 -1.81309e-18 0 0.827753 -1.7278e-18 0 0.835856 -1.64651e-18 0 + 0.843578 -1.56906e-18 0 0.850937 -1.49524e-18 0 -0.5309 -0.0602904 0 -0.45888 -0.0574541 0 + -0.390247 -0.0547512 0 -0.324844 -0.0521755 0 -0.262517 -0.0497209 0 -0.203123 -0.0473818 0 + -0.146523 -0.0451527 0 -0.0925852 -0.0430286 0 -0.0411851 -0.0410043 0 0.00779687 -0.0390753 0 + 0.0544745 -0.037237 0 0.0989563 -0.0354852 0 0.141345 -0.0338158 0 0.18174 -0.032225 0 + 0.220235 -0.030709 0 0.256919 -0.0292643 0 0.291876 -0.0278876 0 0.32519 -0.0265756 0 + 0.356936 -0.0253254 0 0.387188 -0.024134 0 0.416018 -0.0229986 0 0.443491 -0.0219166 0 + 0.469672 -0.0208856 0 0.494621 -0.019903 0 0.518396 -0.0189667 0 0.541053 -0.0180744 0 + 0.562644 -0.0172241 0 0.583219 -0.0164138 0 0.602826 -0.0156416 0 0.621511 -0.0149058 0 + 0.639317 -0.0142046 0 0.656285 -0.0135363 0 0.672455 -0.0128995 0 0.687864 -0.0122926 0 + 0.702548 -0.0117143 0 0.716542 -0.0111633 0 0.729877 -0.0106381 0 0.742585 -0.0101376 0 + 0.754695 -0.0096607 0 0.766235 -0.00920622 0 0.777232 -0.00877312 0 0.787712 -0.00836039 0 + 0.797699 -0.00796708 0 0.807216 -0.00759227 0 0.816286 -0.0072351 0 0.824928 -0.00689473 0 + 0.833165 -0.00657037 0 0.841013 -0.00626127 0 0.848493 -0.00596671 0 0.85562 -0.00568601 0 + -0.385052 -0.116793 0 -0.319893 -0.111298 0 -0.257799 -0.106062 0 -0.198627 -0.101073 0 + -0.142238 -0.0963176 0 -0.088502 -0.0917864 0 -0.037294 -0.0874684 0 0.0115049 -0.0833535 0 + 0.0580081 -0.0794322 0 0.102324 -0.0756953 0 0.144554 -0.0721343 0 0.184798 -0.0687407 0 + 0.223149 -0.0655069 0 0.259696 -0.0624251 0 0.294523 -0.0594884 0 0.327712 -0.0566898 0 + 0.359339 -0.0540228 0 0.389479 -0.0514814 0 0.4182 -0.0490595 0 0.445571 -0.0467515 0 + 0.471653 -0.0445521 0 0.496509 -0.0424562 0 0.520196 -0.0404588 0 0.542768 -0.0385555 0 + 0.564278 -0.0367416 0 0.584776 -0.0350132 0 0.60431 -0.033366 0 0.622925 -0.0317963 0 + 0.640665 -0.0303005 0 0.657569 -0.028875 0 0.673679 -0.0275166 0 0.68903 -0.0262221 0 + 0.70366 -0.0249885 0 0.717601 -0.0238129 0 0.730886 -0.0226926 0 0.743547 -0.0216251 0 + 0.755611 -0.0206077 0 0.767108 -0.0196383 0 0.778065 -0.0187144 0 0.788506 -0.017834 0 + 0.798455 -0.016995 0 0.807937 -0.0161955 0 0.816972 -0.0154336 0 0.825583 -0.0147075 0 + 0.833788 -0.0140156 0 0.841607 -0.0133562 0 0.849059 -0.0127279 0 0.85616 -0.0121291 0 + 0.862927 -0.0115585 0 0.869375 -0.0110147 0 -0.152176 -0.165956 0 -0.0979723 -0.158149 0 + -0.0463188 -0.150709 0 0.00290468 -0.143619 0 0.0498125 -0.136862 0 0.0945135 -0.130424 0 + 0.137112 -0.124288 0 0.177706 -0.118441 0 0.21639 -0.112869 0 0.253255 -0.107559 0 + 0.288385 -0.102499 0 0.321862 -0.0976771 0 0.353765 -0.0930819 0 0.384167 -0.0887029 0 + 0.413138 -0.0845299 0 0.440747 -0.0805533 0 0.467057 -0.0767637 0 0.492129 -0.0731524 0 + 0.516021 -0.069711 0 0.53879 -0.0664314 0 0.560487 -0.0633062 0 0.581164 -0.060328 0 + 0.600868 -0.0574899 0 0.619645 -0.0547853 0 0.637538 -0.052208 0 0.65459 -0.0497519 0 + 0.67084 -0.0474113 0 0.686325 -0.0451809 0 0.701082 -0.0430554 0 0.715144 -0.0410299 0 + 0.728545 -0.0390996 0 0.741315 -0.0372602 0 0.753485 -0.0355073 0 0.765082 -0.0338369 0 + 0.776134 -0.0322451 0 0.786665 -0.0307281 0 0.796702 -0.0292825 0 0.806266 -0.0279049 0 + 0.81538 -0.0265922 0 0.824065 -0.0253412 0 0.832342 -0.024149 0 0.840229 -0.0230129 0 + 0.847746 -0.0219303 0 0.854908 -0.0208986 0 0.861734 -0.0199154 0 0.868239 -0.0189785 0 + 0.874437 -0.0180857 0 0.880344 -0.0172349 0 0.885974 -0.016424 0 0.891338 -0.0156514 0 + 0.153096 -0.204692 0 0.192938 -0.195063 0 0.230906 -0.185886 0 0.267087 -0.177141 0 + 0.301567 -0.168808 0 0.334424 -0.160866 0 0.365736 -0.153298 0 0.395574 -0.146086 0 + 0.424009 -0.139214 0 0.451106 -0.132665 0 0.476929 -0.126423 0 0.501536 -0.120476 0 + 0.524986 -0.114808 0 0.547333 -0.109407 0 0.568629 -0.10426 0 0.588922 -0.0993553 0 + 0.608261 -0.0946812 0 0.62669 -0.0902269 0 0.644252 -0.0859823 0 0.660988 -0.0819373 0 + 0.676937 -0.0780826 0 0.692135 -0.0744092 0 0.706619 -0.0709087 0 0.720421 -0.0675728 0 + 0.733573 -0.0643939 0 0.746107 -0.0613645 0 0.758051 -0.0584777 0 0.769434 -0.0557266 0 + 0.780281 -0.053105 0 0.790617 -0.0506067 0 0.800468 -0.0482259 0 0.809854 -0.0459572 0 + 0.8188 -0.0437951 0 0.827324 -0.0417348 0 0.835448 -0.0397714 0 0.843189 -0.0379004 0 + 0.850566 -0.0361174 0 0.857596 -0.0344183 0 0.864295 -0.0327991 0 0.870679 -0.0312561 0 + 0.876763 -0.0297856 0 0.882561 -0.0283844 0 0.888086 -0.0270491 0 0.893351 -0.0257766 0 + 0.898368 -0.0245639 0 0.903149 -0.0234083 0 0.907705 -0.0223071 0 0.912047 -0.0212577 0 + 0.916185 -0.0202576 0 0.920128 -0.0193046 0 0.511581 -0.230567 0 0.534559 -0.21972 0 + 0.556455 -0.209383 0 0.577321 -0.199533 0 0.597206 -0.190146 0 0.616155 -0.181201 0 + 0.634213 -0.172676 0 0.651421 -0.164553 0 0.66782 -0.156811 0 0.683447 -0.149434 0 + 0.698339 -0.142404 0 0.712531 -0.135705 0 0.726055 -0.129321 0 0.738942 -0.123237 0 + 0.751224 -0.117439 0 0.762927 -0.111914 0 0.77408 -0.106649 0 0.784708 -0.101632 0 + 0.794837 -0.096851 0 0.804488 -0.0922947 0 0.813686 -0.0879527 0 0.822451 -0.083815 0 + 0.830804 -0.079872 0 0.838764 -0.0761145 0 0.846349 -0.0725337 0 0.853577 -0.0691214 0 + 0.860466 -0.0658696 0 0.86703 -0.0627708 0 0.873286 -0.0598178 0 0.879247 -0.0570037 0 + 0.884928 -0.054322 0 0.890341 -0.0517664 0 0.8955 -0.0493311 0 0.900416 -0.0470104 0 + 0.905101 -0.0447988 0 0.909565 -0.0426913 0 0.91382 -0.0406829 0 0.917874 -0.038769 0 + 0.921738 -0.0369451 0 0.92542 -0.035207 0 0.928928 -0.0335507 0 0.932272 -0.0319724 0 + 0.935458 -0.0304682 0 0.938494 -0.0290349 0 0.941388 -0.0276689 0 0.944145 -0.0263673 0 + 0.946773 -0.0251268 0 0.949277 -0.0239448 0 0.951663 -0.0228183 0 0.953937 -0.0217448 0 + 0.900756 -0.241954 0 0.905425 -0.230571 0 0.909874 -0.219724 0 0.914114 -0.209387 0 + 0.918155 -0.199537 0 0.922005 -0.19015 0 0.925674 -0.181204 0 0.929171 -0.17268 0 + 0.932503 -0.164556 0 0.935678 -0.156814 0 0.938704 -0.149437 0 0.941588 -0.142407 0 + 0.944336 -0.135708 0 0.946955 -0.129323 0 0.94945 -0.123239 0 0.951828 -0.117442 0 + 0.954094 -0.111917 0 0.956254 -0.106652 0 0.958312 -0.101634 0 0.960273 -0.0968529 0 + 0.962142 -0.0922965 0 0.963923 -0.0879544 0 0.96562 -0.0838167 0 0.967238 -0.0798736 0 + 0.968779 -0.076116 0 0.970248 -0.0725351 0 0.971647 -0.0691227 0 0.972981 -0.0658709 0 + 0.974252 -0.062772 0 0.975464 -0.059819 0 0.976618 -0.0570048 0 0.977718 -0.0543231 0 + 0.978766 -0.0517675 0 0.979765 -0.0493321 0 0.980717 -0.0470113 0 0.981624 -0.0447997 0 + 0.982489 -0.0426921 0 0.983312 -0.0406837 0 0.984098 -0.0387697 0 0.984846 -0.0369458 0 + 0.985559 -0.0352077 0 0.986238 -0.0335514 0 0.986885 -0.031973 0 0.987502 -0.0304688 0 + 0.98809 -0.0290354 0 0.988651 -0.0276695 0 0.989185 -0.0263678 0 0.989693 -0.0251273 0 + 0.990178 -0.0239452 0 0.99064 -0.0228187 0 1.29617 -0.238138 0 1.28223 -0.226935 0 + 1.26896 -0.216259 0 1.2563 -0.206085 0 1.24425 -0.19639 0 1.23276 -0.187151 0 + 1.22181 -0.178346 0 1.21137 -0.169956 0 1.20143 -0.161961 0 1.19195 -0.154341 0 + 1.18292 -0.14708 0 1.17432 -0.140161 0 1.16611 -0.133567 0 1.1583 -0.127284 0 + 1.15085 -0.121296 0 1.14376 -0.115589 0 1.13699 -0.110152 0 1.13055 -0.10497 0 + 1.12441 -0.100031 0 1.11855 -0.0953254 0 1.11298 -0.0908409 0 1.10766 -0.0865673 0 + 1.1026 -0.0824948 0 1.09777 -0.0786139 0 1.09317 -0.0749156 0 1.08879 -0.0713912 0 + 1.08461 -0.0680326 0 1.08063 -0.0648321 0 1.07684 -0.0617821 0 1.07322 -0.0588756 0 + 1.06978 -0.0561058 0 1.06649 -0.0534663 0 1.06337 -0.0509511 0 1.06039 -0.0485541 0 + 1.05754 -0.0462699 0 1.05484 -0.0440931 0 1.05226 -0.0420188 0 1.0498 -0.0400421 0 + 1.04746 -0.0381583 0 1.04522 -0.0363632 0 1.0431 -0.0346525 0 1.04107 -0.0330223 0 + 1.03914 -0.0314688 0 1.0373 -0.0299883 0 1.03554 -0.0285775 0 1.03387 -0.0272331 0 + 1.03228 -0.025952 0 1.03076 -0.0247311 0 1.02931 -0.0235676 0 1.02793 -0.0224589 0 + 1.67297 -0.219359 0 1.64131 -0.20904 0 1.61114 -0.199205 0 1.58239 -0.189834 0 + 1.55499 -0.180903 0 1.52888 -0.172393 0 1.504 -0.164283 0 1.48029 -0.156554 0 + 1.45769 -0.149189 0 1.43616 -0.142171 0 1.41564 -0.135482 0 1.39609 -0.129108 0 + 1.37746 -0.123035 0 1.3597 -0.117247 0 1.34278 -0.111731 0 1.32665 -0.106474 0 + 1.31128 -0.101465 0 1.29664 -0.096692 0 1.28268 -0.0921432 0 1.26939 -0.0878084 0 + 1.25671 -0.0836775 0 1.24464 -0.0797409 0 1.23313 -0.0759895 0 1.22216 -0.0724147 0 + 1.21171 -0.0690079 0 1.20175 -0.0657615 0 1.19226 -0.0626678 0 1.18321 -0.0597196 0 + 1.17459 -0.0569101 0 1.16638 -0.0542328 0 1.15855 -0.0516815 0 1.15109 -0.0492502 0 + 1.14399 -0.0469332 0 1.13721 -0.0447253 0 1.13076 -0.0426212 0 1.12461 -0.0406161 0 + 1.11874 -0.0387053 0 1.11316 -0.0368845 0 1.10783 -0.0351493 0 1.10276 -0.0334957 0 + 1.09793 -0.0319199 0 1.09332 -0.0304182 0 1.08893 -0.0289872 0 1.08475 -0.0276235 0 + 1.08076 -0.026324 0 1.07696 -0.0250856 0 1.07334 -0.0239055 0 1.06989 -0.0227808 0 + 1.0666 -0.0217091 0 1.06347 -0.0206878 0 2.00748 -0.186797 0 1.96009 -0.178009 0 + 1.91492 -0.169635 0 1.87188 -0.161655 0 1.83086 -0.15405 0 1.79177 -0.146803 0 + 1.75453 -0.139896 0 1.71903 -0.133315 0 1.6852 -0.127043 0 1.65297 -0.121067 0 + 1.62225 -0.115371 0 1.59298 -0.109943 0 1.56508 -0.104771 0 1.5385 -0.0998423 0 + 1.51316 -0.0951453 0 1.48902 -0.0906692 0 1.46602 -0.0864037 0 1.44409 -0.0823389 0 + 1.4232 -0.0784653 0 1.40329 -0.074774 0 1.38432 -0.0712563 0 1.36624 -0.0679041 0 + 1.34901 -0.0647096 0 1.33259 -0.0616653 0 1.31694 -0.0587643 0 1.30203 -0.0559998 0 + 1.28782 -0.0533653 0 1.27428 -0.0508548 0 1.26138 -0.0484623 0 1.24908 -0.0461824 0 + 1.23737 -0.0440098 0 1.2262 -0.0419394 0 1.21556 -0.0399664 0 1.20542 -0.0380862 0 + 1.19575 -0.0362944 0 1.18654 -0.034587 0 1.17777 -0.0329599 0 1.1694 -0.0314093 0 + 1.16144 -0.0299316 0 1.15384 -0.0285235 0 1.1466 -0.0271817 0 1.13971 -0.0259029 0 + 1.13313 -0.0246843 0 1.12687 -0.0235231 0 1.1209 -0.0224164 0 1.11521 -0.0213619 0 + 1.10979 -0.0203569 0 1.10463 -0.0193992 0 1.09971 -0.0184866 0 1.09502 -0.0176169 0 + 2.2787 -0.142498 0 2.21854 -0.135794 0 2.16122 -0.129406 0 2.10659 -0.123318 0 + 2.05453 -0.117517 0 2.00492 -0.111988 0 1.95764 -0.10672 0 1.91259 -0.101699 0 + 1.86966 -0.0969148 0 1.82875 -0.0923555 0 1.78976 -0.0880107 0 1.7526 -0.0838702 0 + 1.7172 -0.0799246 0 1.68346 -0.0761646 0 1.65131 -0.0725815 0 1.62066 -0.0691669 0 + 1.59147 -0.065913 0 1.56364 -0.0628122 0 1.53712 -0.0598572 0 1.51186 -0.0570413 0 + 1.48778 -0.0543578 0 1.46483 -0.0518005 0 1.44296 -0.0493636 0 1.42212 -0.0470413 0 + 1.40226 -0.0448283 0 1.38334 -0.0427194 0 1.36531 -0.0407097 0 1.34812 -0.0387945 0 + 1.33174 -0.0369694 0 1.31614 -0.0352302 0 1.30126 -0.0335728 0 1.28709 -0.0319934 0 + 1.27358 -0.0304883 0 1.26071 -0.029054 0 1.24845 -0.0276872 0 1.23676 -0.0263846 0 + 1.22562 -0.0251434 0 1.21501 -0.0239605 0 1.20489 -0.0228333 0 1.19525 -0.0217591 0 + 1.18607 -0.0207355 0 1.17732 -0.01976 0 1.16897 -0.0188304 0 1.16102 -0.0179445 0 + 1.15345 -0.0171004 0 1.14623 -0.0162959 0 1.13935 -0.0155292 0 1.13279 -0.0147987 0 + 1.12655 -0.0141025 0 1.12059 -0.013439 0 2.46956 -0.0892452 0 2.40043 -0.0850467 0 + 2.33455 -0.0810457 0 2.27176 -0.077233 0 2.21193 -0.0735996 0 2.15492 -0.0701372 0 + 2.10059 -0.0668376 0 2.04881 -0.0636933 0 1.99947 -0.0606968 0 1.95245 -0.0578414 0 + 1.90764 -0.0551203 0 1.86494 -0.0525272 0 1.82425 -0.0500561 0 1.78548 -0.0477012 0 + 1.74852 -0.0454571 0 1.71331 -0.0433186 0 1.67975 -0.0412807 0 1.64777 -0.0393387 0 + 1.6173 -0.037488 0 1.58826 -0.0357244 0 1.56058 -0.0340438 0 1.53421 -0.0324422 0 + 1.50908 -0.030916 0 1.48513 -0.0294616 0 1.46231 -0.0280756 0 1.44056 -0.0267548 0 + 1.41983 -0.0254961 0 1.40008 -0.0242966 0 1.38126 -0.0231536 0 1.36332 -0.0220644 0 + 1.34623 -0.0210264 0 1.32994 -0.0200372 0 1.31442 -0.0190946 0 1.29963 -0.0181963 0 + 1.28553 -0.0173402 0 1.2721 -0.0165245 0 1.2593 -0.0157471 0 1.2471 -0.0150063 0 + 1.23548 -0.0143003 0 1.2244 -0.0136276 0 1.21384 -0.0129865 0 1.20378 -0.0123755 0 + 1.1942 -0.0117933 0 1.18506 -0.0112385 0 1.17635 -0.0107098 0 1.16806 -0.010206 0 + 1.16015 -0.00972582 0 1.15262 -0.00926828 0 1.14544 -0.00883226 0 1.1386 -0.00841675 0 + 2.56809 -0.0303848 0 2.49432 -0.0289554 0 2.42402 -0.0275932 0 2.35703 -0.0262951 0 + 2.29319 -0.025058 0 2.23235 -0.0238792 0 2.17438 -0.0227558 0 2.11913 -0.0216853 0 + 2.06648 -0.0206651 0 2.01631 -0.0196929 0 1.9685 -0.0187665 0 1.92293 -0.0178836 0 + 1.87952 -0.0170423 0 1.83814 -0.0162406 0 1.79871 -0.0154765 0 1.76113 -0.0147484 0 + 1.72533 -0.0140546 0 1.6912 -0.0133934 0 1.65869 -0.0127633 0 1.6277 -0.0121629 0 + 1.59817 -0.0115907 0 1.57003 -0.0110454 0 1.54321 -0.0105258 0 1.51766 -0.0100306 0 + 1.4933 -0.00955872 0 1.4701 -0.00910904 0 1.44798 -0.00868051 0 1.42691 -0.00827214 0 + 1.40682 -0.00788298 0 1.38768 -0.00751213 0 1.36945 -0.00715872 0 1.35207 -0.00682195 0 + 1.3355 -0.00650101 0 1.31972 -0.00619517 0 1.30468 -0.00590373 0 1.29034 -0.00562599 0 + 1.27669 -0.00536132 0 1.26367 -0.0051091 0 1.25127 -0.00486874 0 1.23944 -0.00463969 0 + 1.22818 -0.00442142 0 1.21745 -0.00421342 0 1.20722 -0.0040152 0 1.19747 -0.00382631 0 + 1.18818 -0.0036463 0 1.17932 -0.00347476 0 1.17089 -0.00331129 0 1.16285 -0.00315552 0 + 1.15519 -0.00300707 0 1.14789 -0.0028656 0 2.56809 0.0303848 0 2.49432 0.0289554 0 + 2.42402 0.0275932 0 2.35703 0.0262951 0 2.29319 0.025058 0 2.23235 0.0238792 0 + 2.17438 0.0227558 0 2.11913 0.0216853 0 2.06648 0.0206651 0 2.01631 0.0196929 0 + 1.9685 0.0187665 0 1.92293 0.0178836 0 1.87952 0.0170423 0 1.83814 0.0162406 0 + 1.79871 0.0154765 0 1.76113 0.0147484 0 1.72533 0.0140546 0 1.6912 0.0133934 0 + 1.65869 0.0127633 0 1.6277 0.0121629 0 1.59817 0.0115907 0 1.57003 0.0110454 0 + 1.54321 0.0105258 0 1.51766 0.0100306 0 1.4933 0.00955872 0 1.4701 0.00910904 0 + 1.44798 0.00868051 0 1.42691 0.00827214 0 1.40682 0.00788298 0 1.38768 0.00751213 0 + 1.36945 0.00715872 0 1.35207 0.00682195 0 1.3355 0.00650101 0 1.31972 0.00619517 0 + 1.30468 0.00590373 0 1.29034 0.00562599 0 1.27669 0.00536132 0 1.26367 0.0051091 0 + 1.25127 0.00486874 0 1.23944 0.00463969 0 1.22818 0.00442142 0 1.21745 0.00421342 0 + 1.20722 0.0040152 0 1.19747 0.00382631 0 1.18818 0.0036463 0 1.17932 0.00347476 0 + 1.17089 0.00331129 0 1.16285 0.00315552 0 1.15519 0.00300707 0 1.14789 0.0028656 0 + 2.46956 0.0892452 0 2.40043 0.0850467 0 2.33455 0.0810457 0 2.27176 0.077233 0 + 2.21193 0.0735996 0 2.15492 0.0701372 0 2.10059 0.0668376 0 2.04881 0.0636933 0 + 1.99947 0.0606968 0 1.95245 0.0578414 0 1.90764 0.0551203 0 1.86494 0.0525272 0 + 1.82425 0.0500561 0 1.78548 0.0477012 0 1.74852 0.0454571 0 1.71331 0.0433186 0 + 1.67975 0.0412807 0 1.64777 0.0393387 0 1.6173 0.037488 0 1.58826 0.0357244 0 + 1.56058 0.0340438 0 1.53421 0.0324422 0 1.50908 0.030916 0 1.48513 0.0294616 0 + 1.46231 0.0280756 0 1.44056 0.0267548 0 1.41983 0.0254961 0 1.40008 0.0242966 0 + 1.38126 0.0231536 0 1.36332 0.0220644 0 1.34623 0.0210264 0 1.32994 0.0200372 0 + 1.31442 0.0190946 0 1.29963 0.0181963 0 1.28553 0.0173402 0 1.2721 0.0165245 0 + 1.2593 0.0157471 0 1.2471 0.0150063 0 1.23548 0.0143003 0 1.2244 0.0136276 0 + 1.21384 0.0129865 0 1.20378 0.0123755 0 1.1942 0.0117933 0 1.18506 0.0112385 0 + 1.17635 0.0107098 0 1.16806 0.010206 0 1.16015 0.00972582 0 1.15262 0.00926828 0 + 1.14544 0.00883226 0 1.1386 0.00841675 0 2.2787 0.142498 0 2.21854 0.135794 0 + 2.16122 0.129406 0 2.10659 0.123318 0 2.05453 0.117517 0 2.00492 0.111988 0 + 1.95764 0.10672 0 1.91259 0.101699 0 1.86966 0.0969148 0 1.82875 0.0923555 0 + 1.78976 0.0880107 0 1.7526 0.0838702 0 1.7172 0.0799246 0 1.68346 0.0761646 0 + 1.65131 0.0725815 0 1.62066 0.0691669 0 1.59147 0.065913 0 1.56364 0.0628122 0 + 1.53712 0.0598572 0 1.51186 0.0570413 0 1.48778 0.0543578 0 1.46483 0.0518005 0 + 1.44296 0.0493636 0 1.42212 0.0470413 0 1.40226 0.0448283 0 1.38334 0.0427194 0 + 1.36531 0.0407097 0 1.34812 0.0387945 0 1.33174 0.0369694 0 1.31614 0.0352302 0 + 1.30126 0.0335728 0 1.28709 0.0319934 0 1.27358 0.0304883 0 1.26071 0.029054 0 + 1.24845 0.0276872 0 1.23676 0.0263846 0 1.22562 0.0251434 0 1.21501 0.0239605 0 + 1.20489 0.0228333 0 1.19525 0.0217591 0 1.18607 0.0207355 0 1.17732 0.01976 0 + 1.16897 0.0188304 0 1.16102 0.0179445 0 1.15345 0.0171004 0 1.14623 0.0162959 0 + 1.13935 0.0155292 0 1.13279 0.0147987 0 1.12655 0.0141025 0 1.12059 0.013439 0 + 2.00748 0.186797 0 1.96009 0.178009 0 1.91492 0.169635 0 1.87188 0.161655 0 + 1.83086 0.15405 0 1.79177 0.146803 0 1.75453 0.139896 0 1.71903 0.133315 0 + 1.6852 0.127043 0 1.65297 0.121067 0 1.62225 0.115371 0 1.59298 0.109943 0 + 1.56508 0.104771 0 1.5385 0.0998423 0 1.51316 0.0951453 0 1.48902 0.0906692 0 + 1.46602 0.0864037 0 1.44409 0.0823389 0 1.4232 0.0784653 0 1.40329 0.074774 0 + 1.38432 0.0712563 0 1.36624 0.0679041 0 1.34901 0.0647096 0 1.33259 0.0616653 0 + 1.31694 0.0587643 0 1.30203 0.0559998 0 1.28782 0.0533653 0 1.27428 0.0508548 0 + 1.26138 0.0484623 0 1.24908 0.0461824 0 1.23737 0.0440098 0 1.2262 0.0419394 0 + 1.21556 0.0399664 0 1.20542 0.0380862 0 1.19575 0.0362944 0 1.18654 0.034587 0 + 1.17777 0.0329599 0 1.1694 0.0314093 0 1.16144 0.0299316 0 1.15384 0.0285235 0 + 1.1466 0.0271817 0 1.13971 0.0259029 0 1.13313 0.0246843 0 1.12687 0.0235231 0 + 1.1209 0.0224164 0 1.11521 0.0213619 0 1.10979 0.0203569 0 1.10463 0.0193992 0 + 1.09971 0.0184866 0 1.09502 0.0176169 0 1.67297 0.219359 0 1.64131 0.20904 0 + 1.61114 0.199205 0 1.58239 0.189834 0 1.55499 0.180903 0 1.52888 0.172393 0 + 1.504 0.164283 0 1.48029 0.156554 0 1.45769 0.149189 0 1.43616 0.142171 0 + 1.41564 0.135482 0 1.39609 0.129108 0 1.37746 0.123035 0 1.3597 0.117247 0 + 1.34278 0.111731 0 1.32665 0.106474 0 1.31128 0.101465 0 1.29664 0.096692 0 + 1.28268 0.0921432 0 1.26939 0.0878084 0 1.25671 0.0836775 0 1.24464 0.0797409 0 + 1.23313 0.0759895 0 1.22216 0.0724147 0 1.21171 0.0690079 0 1.20175 0.0657615 0 + 1.19226 0.0626678 0 1.18321 0.0597196 0 1.17459 0.0569101 0 1.16638 0.0542328 0 + 1.15855 0.0516815 0 1.15109 0.0492502 0 1.14399 0.0469332 0 1.13721 0.0447253 0 + 1.13076 0.0426212 0 1.12461 0.0406161 0 1.11874 0.0387053 0 1.11316 0.0368845 0 + 1.10783 0.0351493 0 1.10276 0.0334957 0 1.09793 0.0319199 0 1.09332 0.0304182 0 + 1.08893 0.0289872 0 1.08475 0.0276235 0 1.08076 0.026324 0 1.07696 0.0250856 0 + 1.07334 0.0239055 0 1.06989 0.0227808 0 1.0666 0.0217091 0 1.06347 0.0206878 0 + 1.29617 0.238138 0 1.28223 0.226935 0 1.26896 0.216259 0 1.2563 0.206085 0 + 1.24425 0.19639 0 1.23276 0.187151 0 1.22181 0.178346 0 1.21137 0.169956 0 + 1.20143 0.161961 0 1.19195 0.154341 0 1.18292 0.14708 0 1.17432 0.140161 0 + 1.16611 0.133567 0 1.1583 0.127284 0 1.15085 0.121296 0 1.14376 0.115589 0 + 1.13699 0.110152 0 1.13055 0.10497 0 1.12441 0.100031 0 1.11855 0.0953254 0 + 1.11298 0.0908409 0 1.10766 0.0865673 0 1.1026 0.0824948 0 1.09777 0.0786139 0 + 1.09317 0.0749156 0 1.08879 0.0713912 0 1.08461 0.0680326 0 1.08063 0.0648321 0 + 1.07684 0.0617821 0 1.07322 0.0588756 0 1.06978 0.0561058 0 1.06649 0.0534663 0 + 1.06337 0.0509511 0 1.06039 0.0485541 0 1.05754 0.0462699 0 1.05484 0.0440931 0 + 1.05226 0.0420188 0 1.0498 0.0400421 0 1.04746 0.0381583 0 1.04522 0.0363632 0 + 1.0431 0.0346525 0 1.04107 0.0330223 0 1.03914 0.0314688 0 1.0373 0.0299883 0 + 1.03554 0.0285775 0 1.03387 0.0272331 0 1.03228 0.025952 0 1.03076 0.0247311 0 + 1.02931 0.0235676 0 1.02793 0.0224589 0 0.900756 0.241954 0 0.905425 0.230571 0 + 0.909874 0.219724 0 0.914114 0.209387 0 0.918155 0.199537 0 0.922005 0.19015 0 + 0.925674 0.181204 0 0.929171 0.17268 0 0.932503 0.164556 0 0.935678 0.156814 0 + 0.938704 0.149437 0 0.941588 0.142407 0 0.944336 0.135708 0 0.946955 0.129323 0 + 0.94945 0.123239 0 0.951828 0.117442 0 0.954094 0.111917 0 0.956254 0.106652 0 + 0.958312 0.101634 0 0.960273 0.0968529 0 0.962142 0.0922965 0 0.963923 0.0879544 0 + 0.96562 0.0838167 0 0.967238 0.0798736 0 0.968779 0.076116 0 0.970248 0.0725351 0 + 0.971647 0.0691227 0 0.972981 0.0658709 0 0.974252 0.062772 0 0.975464 0.059819 0 + 0.976618 0.0570048 0 0.977718 0.0543231 0 0.978766 0.0517675 0 0.979765 0.0493321 0 + 0.980717 0.0470113 0 0.981624 0.0447997 0 0.982489 0.0426921 0 0.983312 0.0406837 0 + 0.984098 0.0387697 0 0.984846 0.0369458 0 0.985559 0.0352077 0 0.986238 0.0335514 0 + 0.986885 0.031973 0 0.987502 0.0304688 0 0.98809 0.0290354 0 0.988651 0.0276695 0 + 0.989185 0.0263678 0 0.989693 0.0251273 0 0.990178 0.0239452 0 0.99064 0.0228187 0 + 0.511581 0.230567 0 0.534559 0.21972 0 0.556455 0.209383 0 0.577321 0.199533 0 + 0.597206 0.190146 0 0.616155 0.181201 0 0.634213 0.172676 0 0.651421 0.164553 0 + 0.66782 0.156811 0 0.683447 0.149434 0 0.698339 0.142404 0 0.712531 0.135705 0 + 0.726055 0.129321 0 0.738942 0.123237 0 0.751224 0.117439 0 0.762927 0.111914 0 + 0.77408 0.106649 0 0.784708 0.101632 0 0.794837 0.096851 0 0.804488 0.0922947 0 + 0.813686 0.0879527 0 0.822451 0.083815 0 0.830804 0.079872 0 0.838764 0.0761145 0 + 0.846349 0.0725337 0 0.853577 0.0691214 0 0.860466 0.0658696 0 0.86703 0.0627708 0 + 0.873286 0.0598178 0 0.879247 0.0570037 0 0.884928 0.054322 0 0.890341 0.0517664 0 + 0.8955 0.0493311 0 0.900416 0.0470104 0 0.905101 0.0447988 0 0.909565 0.0426913 0 + 0.91382 0.0406829 0 0.917874 0.038769 0 0.921738 0.0369451 0 0.92542 0.035207 0 + 0.928928 0.0335507 0 0.932272 0.0319724 0 0.935458 0.0304682 0 0.938494 0.0290349 0 + 0.941388 0.0276689 0 0.944145 0.0263673 0 0.946773 0.0251268 0 0.949277 0.0239448 0 + 0.951663 0.0228183 0 0.953937 0.0217448 0 0.153096 0.204692 0 0.192938 0.195063 0 + 0.230906 0.185886 0 0.267087 0.177141 0 0.301567 0.168808 0 0.334424 0.160866 0 + 0.365736 0.153298 0 0.395574 0.146086 0 0.424009 0.139214 0 0.451106 0.132665 0 + 0.476929 0.126423 0 0.501536 0.120476 0 0.524986 0.114808 0 0.547333 0.109407 0 + 0.568629 0.10426 0 0.588922 0.0993553 0 0.608261 0.0946812 0 0.62669 0.0902269 0 + 0.644252 0.0859823 0 0.660988 0.0819373 0 0.676937 0.0780826 0 0.692135 0.0744092 0 + 0.706619 0.0709087 0 0.720421 0.0675728 0 0.733573 0.0643939 0 0.746107 0.0613645 0 + 0.758051 0.0584777 0 0.769434 0.0557266 0 0.780281 0.053105 0 0.790617 0.0506067 0 + 0.800468 0.0482259 0 0.809854 0.0459572 0 0.8188 0.0437951 0 0.827324 0.0417348 0 + 0.835448 0.0397714 0 0.843189 0.0379004 0 0.850566 0.0361174 0 0.857596 0.0344183 0 + 0.864295 0.0327991 0 0.870679 0.0312561 0 0.876763 0.0297856 0 0.882561 0.0283844 0 + 0.888086 0.0270491 0 0.893351 0.0257766 0 0.898368 0.0245639 0 0.903149 0.0234083 0 + 0.907705 0.0223071 0 0.912047 0.0212577 0 0.916185 0.0202576 0 0.920128 0.0193046 0 + -0.152176 0.165956 0 -0.0979723 0.158149 0 -0.0463188 0.150709 0 0.00290468 0.143619 0 + 0.0498125 0.136862 0 0.0945135 0.130424 0 0.137112 0.124288 0 0.177706 0.118441 0 + 0.21639 0.112869 0 0.253255 0.107559 0 0.288385 0.102499 0 0.321862 0.0976771 0 + 0.353765 0.0930819 0 0.384167 0.0887029 0 0.413138 0.0845299 0 0.440747 0.0805533 0 + 0.467057 0.0767637 0 0.492129 0.0731524 0 0.516021 0.069711 0 0.53879 0.0664314 0 + 0.560487 0.0633062 0 0.581164 0.060328 0 0.600868 0.0574899 0 0.619645 0.0547853 0 + 0.637538 0.052208 0 0.65459 0.0497519 0 0.67084 0.0474113 0 0.686325 0.0451809 0 + 0.701082 0.0430554 0 0.715144 0.0410299 0 0.728545 0.0390996 0 0.741315 0.0372602 0 + 0.753485 0.0355073 0 0.765082 0.0338369 0 0.776134 0.0322451 0 0.786665 0.0307281 0 + 0.796702 0.0292825 0 0.806266 0.0279049 0 0.81538 0.0265922 0 0.824065 0.0253412 0 + 0.832342 0.024149 0 0.840229 0.0230129 0 0.847746 0.0219303 0 0.854908 0.0208986 0 + 0.861734 0.0199154 0 0.868239 0.0189785 0 0.874437 0.0180857 0 0.880344 0.0172349 0 + 0.885974 0.016424 0 0.891338 0.0156514 0 -0.385052 0.116793 0 -0.319893 0.111298 0 + -0.257799 0.106062 0 -0.198627 0.101073 0 -0.142238 0.0963176 0 -0.088502 0.0917864 0 + -0.037294 0.0874684 0 0.0115049 0.0833535 0 0.0580081 0.0794322 0 0.102324 0.0756953 0 + 0.144554 0.0721343 0 0.184798 0.0687407 0 0.223149 0.0655069 0 0.259696 0.0624251 0 + 0.294523 0.0594884 0 0.327712 0.0566898 0 0.359339 0.0540228 0 0.389479 0.0514814 0 + 0.4182 0.0490595 0 0.445571 0.0467515 0 0.471653 0.0445521 0 0.496509 0.0424562 0 + 0.520196 0.0404588 0 0.542768 0.0385555 0 0.564278 0.0367416 0 0.584776 0.0350132 0 + 0.60431 0.033366 0 0.622925 0.0317963 0 0.640665 0.0303005 0 0.657569 0.028875 0 + 0.673679 0.0275166 0 0.68903 0.0262221 0 0.70366 0.0249885 0 0.717601 0.0238129 0 + 0.730886 0.0226926 0 0.743547 0.0216251 0 0.755611 0.0206077 0 0.767108 0.0196383 0 + 0.778065 0.0187144 0 0.788506 0.017834 0 0.798455 0.016995 0 0.807937 0.0161955 0 + 0.816972 0.0154336 0 0.825583 0.0147075 0 0.833788 0.0140156 0 0.841607 0.0133562 0 + 0.849059 0.0127279 0 0.85616 0.0121291 0 0.862927 0.0115585 0 0.869375 0.0110147 0 + -0.5309 0.0602904 0 -0.45888 0.0574541 0 -0.390247 0.0547512 0 -0.324844 0.0521755 0 + -0.262517 0.0497209 0 -0.203123 0.0473818 0 -0.146523 0.0451527 0 -0.0925852 0.0430286 0 + -0.0411851 0.0410043 0 0.00779687 0.0390753 0 0.0544745 0.037237 0 0.0989563 0.0354852 0 + 0.141345 0.0338158 0 0.18174 0.032225 0 0.220235 0.030709 0 0.256919 0.0292643 0 + 0.291876 0.0278876 0 0.32519 0.0265756 0 0.356936 0.0253254 0 0.387188 0.024134 0 + 0.416018 0.0229986 0 0.443491 0.0219166 0 0.469672 0.0208856 0 0.494621 0.019903 0 + 0.518396 0.0189667 0 0.541053 0.0180744 0 0.562644 0.0172241 0 0.583219 0.0164138 0 + 0.602826 0.0156416 0 0.621511 0.0149058 0 0.639317 0.0142046 0 0.656285 0.0135363 0 + 0.672455 0.0128995 0 0.687864 0.0122926 0 0.702548 0.0117143 0 0.716542 0.0111633 0 + 0.729877 0.0106381 0 0.742585 0.0101376 0 0.754695 0.0096607 0 0.766235 0.00920622 0 + 0.777232 0.00877312 0 0.787712 0.00836039 0 0.797699 0.00796708 0 0.807216 0.00759227 0 + 0.816286 0.0072351 0 0.824928 0.00689473 0 0.833165 0.00657037 0 0.841013 0.00626127 0 + 0.848493 0.00596671 0 0.85562 0.00568601 0 -0.580556 5.93787e-17 0 -0.5062 5.65853e-17 0 + -0.435341 5.39233e-17 0 -0.367817 5.13865e-17 0 -0.303468 4.8969e-17 0 -0.242147 4.66653e-17 0 + -0.183711 4.447e-17 0 -0.128024 4.23779e-17 0 -0.0749569 4.03843e-17 0 -0.0243861 3.84844e-17 0 + 0.0238056 3.66739e-17 0 0.0697301 3.49486e-17 0 0.113494 3.33045e-17 0 0.155199 3.17377e-17 0 + 0.194943 3.02446e-17 0 0.232816 2.88218e-17 0 0.268908 2.74659e-17 0 0.303302 2.61737e-17 0 + 0.336077 2.49424e-17 0 0.367311 2.3769e-17 0 0.397076 2.26508e-17 0 0.42544 2.15852e-17 0 + 0.45247 2.05698e-17 0 0.478228 1.96021e-17 0 0.502775 1.86799e-17 0 0.526166 1.78011e-17 0 + 0.548458 1.69637e-17 0 0.5697 1.61656e-17 0 0.589943 1.54051e-17 0 0.609234 1.46804e-17 0 + 0.627618 1.39898e-17 0 0.645136 1.33316e-17 0 0.661831 1.27044e-17 0 0.67774 1.21068e-17 0 + 0.6929 1.15372e-17 0 0.707347 1.09944e-17 0 0.721115 1.04772e-17 0 0.734235 9.98432e-18 0 + 0.746738 9.51462e-18 0 0.758652 9.06701e-18 0 0.770007 8.64046e-18 0 0.780826 8.23397e-18 0 + 0.791137 7.84661e-18 0 0.800963 7.47747e-18 0 0.810327 7.12569e-18 0 0.81925 6.79047e-18 0 + 0.827753 6.47102e-18 0 0.835856 6.16659e-18 0 0.843578 5.87649e-18 0 0.850937 5.60003e-18 0 + -0.5309 -0.0602904 0 -0.45888 -0.0574541 0 -0.390247 -0.0547512 0 -0.324844 -0.0521755 0 + -0.262517 -0.0497209 0 -0.203123 -0.0473818 0 -0.146523 -0.0451527 0 -0.0925852 -0.0430286 0 + -0.0411851 -0.0410043 0 0.00779687 -0.0390753 0 0.0544745 -0.037237 0 0.0989563 -0.0354852 0 + 0.141345 -0.0338158 0 0.18174 -0.032225 0 0.220235 -0.030709 0 0.256919 -0.0292643 0 + 0.291876 -0.0278876 0 0.32519 -0.0265756 0 0.356936 -0.0253254 0 0.387188 -0.024134 0 + 0.416018 -0.0229986 0 0.443491 -0.0219166 0 0.469672 -0.0208856 0 0.494621 -0.019903 0 + 0.518396 -0.0189667 0 0.541053 -0.0180744 0 0.562644 -0.0172241 0 0.583219 -0.0164138 0 + 0.602826 -0.0156416 0 0.621511 -0.0149058 0 0.639317 -0.0142046 0 0.656285 -0.0135363 0 + 0.672455 -0.0128995 0 0.687864 -0.0122926 0 0.702548 -0.0117143 0 0.716542 -0.0111633 0 + 0.729877 -0.0106381 0 0.742585 -0.0101376 0 0.754695 -0.0096607 0 0.766235 -0.00920622 0 + 0.777232 -0.00877312 0 0.787712 -0.00836039 0 0.797699 -0.00796708 0 0.807216 -0.00759227 0 + 0.816286 -0.0072351 0 0.824928 -0.00689473 0 0.833165 -0.00657037 0 0.841013 -0.00626127 0 + 0.848493 -0.00596671 0 0.85562 -0.00568601 0 -0.385052 -0.116793 0 -0.319893 -0.111298 0 + -0.257799 -0.106062 0 -0.198627 -0.101073 0 -0.142238 -0.0963176 0 -0.088502 -0.0917864 0 + -0.037294 -0.0874684 0 0.0115049 -0.0833535 0 0.0580081 -0.0794322 0 0.102324 -0.0756953 0 + 0.144554 -0.0721343 0 0.184798 -0.0687407 0 0.223149 -0.0655069 0 0.259696 -0.0624251 0 + 0.294523 -0.0594884 0 0.327712 -0.0566898 0 0.359339 -0.0540228 0 0.389479 -0.0514814 0 + 0.4182 -0.0490595 0 0.445571 -0.0467515 0 0.471653 -0.0445521 0 0.496509 -0.0424562 0 + 0.520196 -0.0404588 0 0.542768 -0.0385555 0 0.564278 -0.0367416 0 0.584776 -0.0350132 0 + 0.60431 -0.033366 0 0.622925 -0.0317963 0 0.640665 -0.0303005 0 0.657569 -0.028875 0 + 0.673679 -0.0275166 0 0.68903 -0.0262221 0 0.70366 -0.0249885 0 0.717601 -0.0238129 0 + 0.730886 -0.0226926 0 0.743547 -0.0216251 0 0.755611 -0.0206077 0 0.767108 -0.0196383 0 + 0.778065 -0.0187144 0 0.788506 -0.017834 0 0.798455 -0.016995 0 0.807937 -0.0161955 0 + 0.816972 -0.0154336 0 0.825583 -0.0147075 0 0.833788 -0.0140156 0 0.841607 -0.0133562 0 + 0.849059 -0.0127279 0 0.85616 -0.0121291 0 0.862927 -0.0115585 0 0.869375 -0.0110147 0 + -0.152176 -0.165956 0 -0.0979723 -0.158149 0 -0.0463188 -0.150709 0 0.00290468 -0.143619 0 + 0.0498125 -0.136862 0 0.0945135 -0.130424 0 0.137112 -0.124288 0 0.177706 -0.118441 0 + 0.21639 -0.112869 0 0.253255 -0.107559 0 0.288385 -0.102499 0 0.321862 -0.0976771 0 + 0.353765 -0.0930819 0 0.384167 -0.0887029 0 0.413138 -0.0845299 0 0.440747 -0.0805533 0 + 0.467057 -0.0767637 0 0.492129 -0.0731524 0 0.516021 -0.069711 0 0.53879 -0.0664314 0 + 0.560487 -0.0633062 0 0.581164 -0.060328 0 0.600868 -0.0574899 0 0.619645 -0.0547853 0 + 0.637538 -0.052208 0 0.65459 -0.0497519 0 0.67084 -0.0474113 0 0.686325 -0.0451809 0 + 0.701082 -0.0430554 0 0.715144 -0.0410299 0 0.728545 -0.0390996 0 0.741315 -0.0372602 0 + 0.753485 -0.0355073 0 0.765082 -0.0338369 0 0.776134 -0.0322451 0 0.786665 -0.0307281 0 + 0.796702 -0.0292825 0 0.806266 -0.0279049 0 0.81538 -0.0265922 0 0.824065 -0.0253412 0 + 0.832342 -0.024149 0 0.840229 -0.0230129 0 0.847746 -0.0219303 0 0.854908 -0.0208986 0 + 0.861734 -0.0199154 0 0.868239 -0.0189785 0 0.874437 -0.0180857 0 0.880344 -0.0172349 0 + 0.885974 -0.016424 0 0.891338 -0.0156514 0 0.153096 -0.204692 0 0.192938 -0.195063 0 + 0.230906 -0.185886 0 0.267087 -0.177141 0 0.301567 -0.168808 0 0.334424 -0.160866 0 + 0.365736 -0.153298 0 0.395574 -0.146086 0 0.424009 -0.139214 0 0.451106 -0.132665 0 + 0.476929 -0.126423 0 0.501536 -0.120476 0 0.524986 -0.114808 0 0.547333 -0.109407 0 + 0.568629 -0.10426 0 0.588922 -0.0993553 0 0.608261 -0.0946812 0 0.62669 -0.0902269 0 + 0.644252 -0.0859823 0 0.660988 -0.0819373 0 0.676937 -0.0780826 0 0.692135 -0.0744092 0 + 0.706619 -0.0709087 0 0.720421 -0.0675728 0 0.733573 -0.0643939 0 0.746107 -0.0613645 0 + 0.758051 -0.0584777 0 0.769434 -0.0557266 0 0.780281 -0.053105 0 0.790617 -0.0506067 0 + 0.800468 -0.0482259 0 0.809854 -0.0459572 0 0.8188 -0.0437951 0 0.827324 -0.0417348 0 + 0.835448 -0.0397714 0 0.843189 -0.0379004 0 0.850566 -0.0361174 0 0.857596 -0.0344183 0 + 0.864295 -0.0327991 0 0.870679 -0.0312561 0 0.876763 -0.0297856 0 0.882561 -0.0283844 0 + 0.888086 -0.0270491 0 0.893351 -0.0257766 0 0.898368 -0.0245639 0 0.903149 -0.0234083 0 + 0.907705 -0.0223071 0 0.912047 -0.0212577 0 0.916185 -0.0202576 0 0.920128 -0.0193046 0 + 0.511581 -0.230567 0 0.534559 -0.21972 0 0.556455 -0.209383 0 0.577321 -0.199533 0 + 0.597206 -0.190146 0 0.616155 -0.181201 0 0.634213 -0.172676 0 0.651421 -0.164553 0 + 0.66782 -0.156811 0 0.683447 -0.149434 0 0.698339 -0.142404 0 0.712531 -0.135705 0 + 0.726055 -0.129321 0 0.738942 -0.123237 0 0.751224 -0.117439 0 0.762927 -0.111914 0 + 0.77408 -0.106649 0 0.784708 -0.101632 0 0.794837 -0.096851 0 0.804488 -0.0922947 0 + 0.813686 -0.0879527 0 0.822451 -0.083815 0 0.830804 -0.079872 0 0.838764 -0.0761145 0 + 0.846349 -0.0725337 0 0.853577 -0.0691214 0 0.860466 -0.0658696 0 0.86703 -0.0627708 0 + 0.873286 -0.0598178 0 0.879247 -0.0570037 0 0.884928 -0.054322 0 0.890341 -0.0517664 0 + 0.8955 -0.0493311 0 0.900416 -0.0470104 0 0.905101 -0.0447988 0 0.909565 -0.0426913 0 + 0.91382 -0.0406829 0 0.917874 -0.038769 0 0.921738 -0.0369451 0 0.92542 -0.035207 0 + 0.928928 -0.0335507 0 0.932272 -0.0319724 0 0.935458 -0.0304682 0 0.938494 -0.0290349 0 + 0.941388 -0.0276689 0 0.944145 -0.0263673 0 0.946773 -0.0251268 0 0.949277 -0.0239448 0 + 0.951663 -0.0228183 0 0.953937 -0.0217448 0 0.900756 -0.241954 0 0.905425 -0.230571 0 + 0.909874 -0.219724 0 0.914114 -0.209387 0 0.918155 -0.199537 0 0.922005 -0.19015 0 + 0.925674 -0.181204 0 0.929171 -0.17268 0 0.932503 -0.164556 0 0.935678 -0.156814 0 + 0.938704 -0.149437 0 0.941588 -0.142407 0 0.944336 -0.135708 0 0.946955 -0.129323 0 + 0.94945 -0.123239 0 0.951828 -0.117442 0 0.954094 -0.111917 0 0.956254 -0.106652 0 + 0.958312 -0.101634 0 0.960273 -0.0968529 0 0.962142 -0.0922965 0 0.963923 -0.0879544 0 + 0.96562 -0.0838167 0 0.967238 -0.0798736 0 0.968779 -0.076116 0 0.970248 -0.0725351 0 + 0.971647 -0.0691227 0 0.972981 -0.0658709 0 0.974252 -0.062772 0 0.975464 -0.059819 0 + 0.976618 -0.0570048 0 0.977718 -0.0543231 0 0.978766 -0.0517675 0 0.979765 -0.0493321 0 + 0.980717 -0.0470113 0 0.981624 -0.0447997 0 0.982489 -0.0426921 0 0.983312 -0.0406837 0 + 0.984098 -0.0387697 0 0.984846 -0.0369458 0 0.985559 -0.0352077 0 0.986238 -0.0335514 0 + 0.986885 -0.031973 0 0.987502 -0.0304688 0 0.98809 -0.0290354 0 0.988651 -0.0276695 0 + 0.989185 -0.0263678 0 0.989693 -0.0251273 0 0.990178 -0.0239452 0 0.99064 -0.0228187 0 + 1.29617 -0.238138 0 1.28223 -0.226935 0 1.26896 -0.216259 0 1.2563 -0.206085 0 + 1.24425 -0.19639 0 1.23276 -0.187151 0 1.22181 -0.178346 0 1.21137 -0.169956 0 + 1.20143 -0.161961 0 1.19195 -0.154341 0 1.18292 -0.14708 0 1.17432 -0.140161 0 + 1.16611 -0.133567 0 1.1583 -0.127284 0 1.15085 -0.121296 0 1.14376 -0.115589 0 + 1.13699 -0.110152 0 1.13055 -0.10497 0 1.12441 -0.100031 0 1.11855 -0.0953254 0 + 1.11298 -0.0908409 0 1.10766 -0.0865673 0 1.1026 -0.0824948 0 1.09777 -0.0786139 0 + 1.09317 -0.0749156 0 1.08879 -0.0713912 0 1.08461 -0.0680326 0 1.08063 -0.0648321 0 + 1.07684 -0.0617821 0 1.07322 -0.0588756 0 1.06978 -0.0561058 0 1.06649 -0.0534663 0 + 1.06337 -0.0509511 0 1.06039 -0.0485541 0 1.05754 -0.0462699 0 1.05484 -0.0440931 0 + 1.05226 -0.0420188 0 1.0498 -0.0400421 0 1.04746 -0.0381583 0 1.04522 -0.0363632 0 + 1.0431 -0.0346525 0 1.04107 -0.0330223 0 1.03914 -0.0314688 0 1.0373 -0.0299883 0 + 1.03554 -0.0285775 0 1.03387 -0.0272331 0 1.03228 -0.025952 0 1.03076 -0.0247311 0 + 1.02931 -0.0235676 0 1.02793 -0.0224589 0 1.67297 -0.219359 0 1.64131 -0.20904 0 + 1.61114 -0.199205 0 1.58239 -0.189834 0 1.55499 -0.180903 0 1.52888 -0.172393 0 + 1.504 -0.164283 0 1.48029 -0.156554 0 1.45769 -0.149189 0 1.43616 -0.142171 0 + 1.41564 -0.135482 0 1.39609 -0.129108 0 1.37746 -0.123035 0 1.3597 -0.117247 0 + 1.34278 -0.111731 0 1.32665 -0.106474 0 1.31128 -0.101465 0 1.29664 -0.096692 0 + 1.28268 -0.0921432 0 1.26939 -0.0878084 0 1.25671 -0.0836775 0 1.24464 -0.0797409 0 + 1.23313 -0.0759895 0 1.22216 -0.0724147 0 1.21171 -0.0690079 0 1.20175 -0.0657615 0 + 1.19226 -0.0626678 0 1.18321 -0.0597196 0 1.17459 -0.0569101 0 1.16638 -0.0542328 0 + 1.15855 -0.0516815 0 1.15109 -0.0492502 0 1.14399 -0.0469332 0 1.13721 -0.0447253 0 + 1.13076 -0.0426212 0 1.12461 -0.0406161 0 1.11874 -0.0387053 0 1.11316 -0.0368845 0 + 1.10783 -0.0351493 0 1.10276 -0.0334957 0 1.09793 -0.0319199 0 1.09332 -0.0304182 0 + 1.08893 -0.0289872 0 1.08475 -0.0276235 0 1.08076 -0.026324 0 1.07696 -0.0250856 0 + 1.07334 -0.0239055 0 1.06989 -0.0227808 0 1.0666 -0.0217091 0 1.06347 -0.0206878 0 + 2.00748 -0.186797 0 1.96009 -0.178009 0 1.91492 -0.169635 0 1.87188 -0.161655 0 + 1.83086 -0.15405 0 1.79177 -0.146803 0 1.75453 -0.139896 0 1.71903 -0.133315 0 + 1.6852 -0.127043 0 1.65297 -0.121067 0 1.62225 -0.115371 0 1.59298 -0.109943 0 + 1.56508 -0.104771 0 1.5385 -0.0998423 0 1.51316 -0.0951453 0 1.48902 -0.0906692 0 + 1.46602 -0.0864037 0 1.44409 -0.0823389 0 1.4232 -0.0784653 0 1.40329 -0.074774 0 + 1.38432 -0.0712563 0 1.36624 -0.0679041 0 1.34901 -0.0647096 0 1.33259 -0.0616653 0 + 1.31694 -0.0587643 0 1.30203 -0.0559998 0 1.28782 -0.0533653 0 1.27428 -0.0508548 0 + 1.26138 -0.0484623 0 1.24908 -0.0461824 0 1.23737 -0.0440098 0 1.2262 -0.0419394 0 + 1.21556 -0.0399664 0 1.20542 -0.0380862 0 1.19575 -0.0362944 0 1.18654 -0.034587 0 + 1.17777 -0.0329599 0 1.1694 -0.0314093 0 1.16144 -0.0299316 0 1.15384 -0.0285235 0 + 1.1466 -0.0271817 0 1.13971 -0.0259029 0 1.13313 -0.0246843 0 1.12687 -0.0235231 0 + 1.1209 -0.0224164 0 1.11521 -0.0213619 0 1.10979 -0.0203569 0 1.10463 -0.0193992 0 + 1.09971 -0.0184866 0 1.09502 -0.0176169 0 2.2787 -0.142498 0 2.21854 -0.135794 0 + 2.16122 -0.129406 0 2.10659 -0.123318 0 2.05453 -0.117517 0 2.00492 -0.111988 0 + 1.95764 -0.10672 0 1.91259 -0.101699 0 1.86966 -0.0969148 0 1.82875 -0.0923555 0 + 1.78976 -0.0880107 0 1.7526 -0.0838702 0 1.7172 -0.0799246 0 1.68346 -0.0761646 0 + 1.65131 -0.0725815 0 1.62066 -0.0691669 0 1.59147 -0.065913 0 1.56364 -0.0628122 0 + 1.53712 -0.0598572 0 1.51186 -0.0570413 0 1.48778 -0.0543578 0 1.46483 -0.0518005 0 + 1.44296 -0.0493636 0 1.42212 -0.0470413 0 1.40226 -0.0448283 0 1.38334 -0.0427194 0 + 1.36531 -0.0407097 0 1.34812 -0.0387945 0 1.33174 -0.0369694 0 1.31614 -0.0352302 0 + 1.30126 -0.0335728 0 1.28709 -0.0319934 0 1.27358 -0.0304883 0 1.26071 -0.029054 0 + 1.24845 -0.0276872 0 1.23676 -0.0263846 0 1.22562 -0.0251434 0 1.21501 -0.0239605 0 + 1.20489 -0.0228333 0 1.19525 -0.0217591 0 1.18607 -0.0207355 0 1.17732 -0.01976 0 + 1.16897 -0.0188304 0 1.16102 -0.0179445 0 1.15345 -0.0171004 0 1.14623 -0.0162959 0 + 1.13935 -0.0155292 0 1.13279 -0.0147987 0 1.12655 -0.0141025 0 1.12059 -0.013439 0 + 2.46956 -0.0892452 0 2.40043 -0.0850467 0 2.33455 -0.0810457 0 2.27176 -0.077233 0 + 2.21193 -0.0735996 0 2.15492 -0.0701372 0 2.10059 -0.0668376 0 2.04881 -0.0636933 0 + 1.99947 -0.0606968 0 1.95245 -0.0578414 0 1.90764 -0.0551203 0 1.86494 -0.0525272 0 + 1.82425 -0.0500561 0 1.78548 -0.0477012 0 1.74852 -0.0454571 0 1.71331 -0.0433186 0 + 1.67975 -0.0412807 0 1.64777 -0.0393387 0 1.6173 -0.037488 0 1.58826 -0.0357244 0 + 1.56058 -0.0340438 0 1.53421 -0.0324422 0 1.50908 -0.030916 0 1.48513 -0.0294616 0 + 1.46231 -0.0280756 0 1.44056 -0.0267548 0 1.41983 -0.0254961 0 1.40008 -0.0242966 0 + 1.38126 -0.0231536 0 1.36332 -0.0220644 0 1.34623 -0.0210264 0 1.32994 -0.0200372 0 + 1.31442 -0.0190946 0 1.29963 -0.0181963 0 1.28553 -0.0173402 0 1.2721 -0.0165245 0 + 1.2593 -0.0157471 0 1.2471 -0.0150063 0 1.23548 -0.0143003 0 1.2244 -0.0136276 0 + 1.21384 -0.0129865 0 1.20378 -0.0123755 0 1.1942 -0.0117933 0 1.18506 -0.0112385 0 + 1.17635 -0.0107098 0 1.16806 -0.010206 0 1.16015 -0.00972582 0 1.15262 -0.00926828 0 + 1.14544 -0.00883226 0 1.1386 -0.00841675 0 2.56809 -0.0303848 0 2.49432 -0.0289554 0 + 2.42402 -0.0275932 0 2.35703 -0.0262951 0 2.29319 -0.025058 0 2.23235 -0.0238792 0 + 2.17438 -0.0227558 0 2.11913 -0.0216853 0 2.06648 -0.0206651 0 2.01631 -0.0196929 0 + 1.9685 -0.0187665 0 1.92293 -0.0178836 0 1.87952 -0.0170423 0 1.83814 -0.0162406 0 + 1.79871 -0.0154765 0 1.76113 -0.0147484 0 1.72533 -0.0140546 0 1.6912 -0.0133934 0 + 1.65869 -0.0127633 0 1.6277 -0.0121629 0 1.59817 -0.0115907 0 1.57003 -0.0110454 0 + 1.54321 -0.0105258 0 1.51766 -0.0100306 0 1.4933 -0.00955872 0 1.4701 -0.00910904 0 + 1.44798 -0.00868051 0 1.42691 -0.00827214 0 1.40682 -0.00788298 0 1.38768 -0.00751213 0 + 1.36945 -0.00715872 0 1.35207 -0.00682195 0 1.3355 -0.00650101 0 1.31972 -0.00619517 0 + 1.30468 -0.00590373 0 1.29034 -0.00562599 0 1.27669 -0.00536132 0 1.26367 -0.0051091 0 + 1.25127 -0.00486874 0 1.23944 -0.00463969 0 1.22818 -0.00442142 0 1.21745 -0.00421342 0 + 1.20722 -0.0040152 0 1.19747 -0.00382631 0 1.18818 -0.0036463 0 1.17932 -0.00347476 0 + 1.17089 -0.00331129 0 1.16285 -0.00315552 0 1.15519 -0.00300707 0 1.14789 -0.0028656 0 + </DataArray> + </CellData> + <Points> + <DataArray type="Float32" Name="Coordinates" NumberOfComponents="3" format="ascii"> + -0.5 -0.5 0 -0.45 -0.5 0 -0.5 -0.46 0 -0.45 -0.46 0 + -0.4 -0.5 0 -0.4 -0.46 0 -0.35 -0.5 0 -0.35 -0.46 0 + -0.3 -0.5 0 -0.3 -0.46 0 -0.25 -0.5 0 -0.25 -0.46 0 + -0.2 -0.5 0 -0.2 -0.46 0 -0.15 -0.5 0 -0.15 -0.46 0 + -0.1 -0.5 0 -0.1 -0.46 0 -0.05 -0.5 0 -0.05 -0.46 0 + 2.77556e-17 -0.5 0 2.77556e-17 -0.46 0 0.05 -0.5 0 0.05 -0.46 0 + 0.1 -0.5 0 0.1 -0.46 0 0.15 -0.5 0 0.15 -0.46 0 + 0.2 -0.5 0 0.2 -0.46 0 0.25 -0.5 0 0.25 -0.46 0 + 0.3 -0.5 0 0.3 -0.46 0 0.35 -0.5 0 0.35 -0.46 0 + 0.4 -0.5 0 0.4 -0.46 0 0.45 -0.5 0 0.45 -0.46 0 + 0.5 -0.5 0 0.5 -0.46 0 0.55 -0.5 0 0.55 -0.46 0 + 0.6 -0.5 0 0.6 -0.46 0 0.65 -0.5 0 0.65 -0.46 0 + 0.7 -0.5 0 0.7 -0.46 0 0.75 -0.5 0 0.75 -0.46 0 + 0.8 -0.5 0 0.8 -0.46 0 0.85 -0.5 0 0.85 -0.46 0 + 0.9 -0.5 0 0.9 -0.46 0 0.95 -0.5 0 0.95 -0.46 0 + 1 -0.5 0 1 -0.46 0 1.05 -0.5 0 1.05 -0.46 0 + 1.1 -0.5 0 1.1 -0.46 0 1.15 -0.5 0 1.15 -0.46 0 + 1.2 -0.5 0 1.2 -0.46 0 1.25 -0.5 0 1.25 -0.46 0 + 1.3 -0.5 0 1.3 -0.46 0 1.35 -0.5 0 1.35 -0.46 0 + 1.4 -0.5 0 1.4 -0.46 0 1.45 -0.5 0 1.45 -0.46 0 + 1.5 -0.5 0 1.5 -0.46 0 1.55 -0.5 0 1.55 -0.46 0 + 1.6 -0.5 0 1.6 -0.46 0 1.65 -0.5 0 1.65 -0.46 0 + 1.7 -0.5 0 1.7 -0.46 0 1.75 -0.5 0 1.75 -0.46 0 + 1.8 -0.5 0 1.8 -0.46 0 1.85 -0.5 0 1.85 -0.46 0 + 1.9 -0.5 0 1.9 -0.46 0 1.95 -0.5 0 1.95 -0.46 0 + 2 -0.5 0 2 -0.46 0 -0.5 -0.42 0 -0.45 -0.42 0 + -0.4 -0.42 0 -0.35 -0.42 0 -0.3 -0.42 0 -0.25 -0.42 0 + -0.2 -0.42 0 -0.15 -0.42 0 -0.1 -0.42 0 -0.05 -0.42 0 + 2.77556e-17 -0.42 0 0.05 -0.42 0 0.1 -0.42 0 0.15 -0.42 0 + 0.2 -0.42 0 0.25 -0.42 0 0.3 -0.42 0 0.35 -0.42 0 + 0.4 -0.42 0 0.45 -0.42 0 0.5 -0.42 0 0.55 -0.42 0 + 0.6 -0.42 0 0.65 -0.42 0 0.7 -0.42 0 0.75 -0.42 0 + 0.8 -0.42 0 0.85 -0.42 0 0.9 -0.42 0 0.95 -0.42 0 + 1 -0.42 0 1.05 -0.42 0 1.1 -0.42 0 1.15 -0.42 0 + 1.2 -0.42 0 1.25 -0.42 0 1.3 -0.42 0 1.35 -0.42 0 + 1.4 -0.42 0 1.45 -0.42 0 1.5 -0.42 0 1.55 -0.42 0 + 1.6 -0.42 0 1.65 -0.42 0 1.7 -0.42 0 1.75 -0.42 0 + 1.8 -0.42 0 1.85 -0.42 0 1.9 -0.42 0 1.95 -0.42 0 + 2 -0.42 0 -0.5 -0.38 0 -0.45 -0.38 0 -0.4 -0.38 0 + -0.35 -0.38 0 -0.3 -0.38 0 -0.25 -0.38 0 -0.2 -0.38 0 + -0.15 -0.38 0 -0.1 -0.38 0 -0.05 -0.38 0 2.77556e-17 -0.38 0 + 0.05 -0.38 0 0.1 -0.38 0 0.15 -0.38 0 0.2 -0.38 0 + 0.25 -0.38 0 0.3 -0.38 0 0.35 -0.38 0 0.4 -0.38 0 + 0.45 -0.38 0 0.5 -0.38 0 0.55 -0.38 0 0.6 -0.38 0 + 0.65 -0.38 0 0.7 -0.38 0 0.75 -0.38 0 0.8 -0.38 0 + 0.85 -0.38 0 0.9 -0.38 0 0.95 -0.38 0 1 -0.38 0 + 1.05 -0.38 0 1.1 -0.38 0 1.15 -0.38 0 1.2 -0.38 0 + 1.25 -0.38 0 1.3 -0.38 0 1.35 -0.38 0 1.4 -0.38 0 + 1.45 -0.38 0 1.5 -0.38 0 1.55 -0.38 0 1.6 -0.38 0 + 1.65 -0.38 0 1.7 -0.38 0 1.75 -0.38 0 1.8 -0.38 0 + 1.85 -0.38 0 1.9 -0.38 0 1.95 -0.38 0 2 -0.38 0 + -0.5 -0.34 0 -0.45 -0.34 0 -0.4 -0.34 0 -0.35 -0.34 0 + -0.3 -0.34 0 -0.25 -0.34 0 -0.2 -0.34 0 -0.15 -0.34 0 + -0.1 -0.34 0 -0.05 -0.34 0 2.77556e-17 -0.34 0 0.05 -0.34 0 + 0.1 -0.34 0 0.15 -0.34 0 0.2 -0.34 0 0.25 -0.34 0 + 0.3 -0.34 0 0.35 -0.34 0 0.4 -0.34 0 0.45 -0.34 0 + 0.5 -0.34 0 0.55 -0.34 0 0.6 -0.34 0 0.65 -0.34 0 + 0.7 -0.34 0 0.75 -0.34 0 0.8 -0.34 0 0.85 -0.34 0 + 0.9 -0.34 0 0.95 -0.34 0 1 -0.34 0 1.05 -0.34 0 + 1.1 -0.34 0 1.15 -0.34 0 1.2 -0.34 0 1.25 -0.34 0 + 1.3 -0.34 0 1.35 -0.34 0 1.4 -0.34 0 1.45 -0.34 0 + 1.5 -0.34 0 1.55 -0.34 0 1.6 -0.34 0 1.65 -0.34 0 + 1.7 -0.34 0 1.75 -0.34 0 1.8 -0.34 0 1.85 -0.34 0 + 1.9 -0.34 0 1.95 -0.34 0 2 -0.34 0 -0.5 -0.3 0 + -0.45 -0.3 0 -0.4 -0.3 0 -0.35 -0.3 0 -0.3 -0.3 0 + -0.25 -0.3 0 -0.2 -0.3 0 -0.15 -0.3 0 -0.1 -0.3 0 + -0.05 -0.3 0 2.77556e-17 -0.3 0 0.05 -0.3 0 0.1 -0.3 0 + 0.15 -0.3 0 0.2 -0.3 0 0.25 -0.3 0 0.3 -0.3 0 + 0.35 -0.3 0 0.4 -0.3 0 0.45 -0.3 0 0.5 -0.3 0 + 0.55 -0.3 0 0.6 -0.3 0 0.65 -0.3 0 0.7 -0.3 0 + 0.75 -0.3 0 0.8 -0.3 0 0.85 -0.3 0 0.9 -0.3 0 + 0.95 -0.3 0 1 -0.3 0 1.05 -0.3 0 1.1 -0.3 0 + 1.15 -0.3 0 1.2 -0.3 0 1.25 -0.3 0 1.3 -0.3 0 + 1.35 -0.3 0 1.4 -0.3 0 1.45 -0.3 0 1.5 -0.3 0 + 1.55 -0.3 0 1.6 -0.3 0 1.65 -0.3 0 1.7 -0.3 0 + 1.75 -0.3 0 1.8 -0.3 0 1.85 -0.3 0 1.9 -0.3 0 + 1.95 -0.3 0 2 -0.3 0 -0.5 -0.26 0 -0.45 -0.26 0 + -0.4 -0.26 0 -0.35 -0.26 0 -0.3 -0.26 0 -0.25 -0.26 0 + -0.2 -0.26 0 -0.15 -0.26 0 -0.1 -0.26 0 -0.05 -0.26 0 + 2.77556e-17 -0.26 0 0.05 -0.26 0 0.1 -0.26 0 0.15 -0.26 0 + 0.2 -0.26 0 0.25 -0.26 0 0.3 -0.26 0 0.35 -0.26 0 + 0.4 -0.26 0 0.45 -0.26 0 0.5 -0.26 0 0.55 -0.26 0 + 0.6 -0.26 0 0.65 -0.26 0 0.7 -0.26 0 0.75 -0.26 0 + 0.8 -0.26 0 0.85 -0.26 0 0.9 -0.26 0 0.95 -0.26 0 + 1 -0.26 0 1.05 -0.26 0 1.1 -0.26 0 1.15 -0.26 0 + 1.2 -0.26 0 1.25 -0.26 0 1.3 -0.26 0 1.35 -0.26 0 + 1.4 -0.26 0 1.45 -0.26 0 1.5 -0.26 0 1.55 -0.26 0 + 1.6 -0.26 0 1.65 -0.26 0 1.7 -0.26 0 1.75 -0.26 0 + 1.8 -0.26 0 1.85 -0.26 0 1.9 -0.26 0 1.95 -0.26 0 + 2 -0.26 0 -0.5 -0.22 0 -0.45 -0.22 0 -0.4 -0.22 0 + -0.35 -0.22 0 -0.3 -0.22 0 -0.25 -0.22 0 -0.2 -0.22 0 + -0.15 -0.22 0 -0.1 -0.22 0 -0.05 -0.22 0 2.77556e-17 -0.22 0 + 0.05 -0.22 0 0.1 -0.22 0 0.15 -0.22 0 0.2 -0.22 0 + 0.25 -0.22 0 0.3 -0.22 0 0.35 -0.22 0 0.4 -0.22 0 + 0.45 -0.22 0 0.5 -0.22 0 0.55 -0.22 0 0.6 -0.22 0 + 0.65 -0.22 0 0.7 -0.22 0 0.75 -0.22 0 0.8 -0.22 0 + 0.85 -0.22 0 0.9 -0.22 0 0.95 -0.22 0 1 -0.22 0 + 1.05 -0.22 0 1.1 -0.22 0 1.15 -0.22 0 1.2 -0.22 0 + 1.25 -0.22 0 1.3 -0.22 0 1.35 -0.22 0 1.4 -0.22 0 + 1.45 -0.22 0 1.5 -0.22 0 1.55 -0.22 0 1.6 -0.22 0 + 1.65 -0.22 0 1.7 -0.22 0 1.75 -0.22 0 1.8 -0.22 0 + 1.85 -0.22 0 1.9 -0.22 0 1.95 -0.22 0 2 -0.22 0 + -0.5 -0.18 0 -0.45 -0.18 0 -0.4 -0.18 0 -0.35 -0.18 0 + -0.3 -0.18 0 -0.25 -0.18 0 -0.2 -0.18 0 -0.15 -0.18 0 + -0.1 -0.18 0 -0.05 -0.18 0 2.77556e-17 -0.18 0 0.05 -0.18 0 + 0.1 -0.18 0 0.15 -0.18 0 0.2 -0.18 0 0.25 -0.18 0 + 0.3 -0.18 0 0.35 -0.18 0 0.4 -0.18 0 0.45 -0.18 0 + 0.5 -0.18 0 0.55 -0.18 0 0.6 -0.18 0 0.65 -0.18 0 + 0.7 -0.18 0 0.75 -0.18 0 0.8 -0.18 0 0.85 -0.18 0 + 0.9 -0.18 0 0.95 -0.18 0 1 -0.18 0 1.05 -0.18 0 + 1.1 -0.18 0 1.15 -0.18 0 1.2 -0.18 0 1.25 -0.18 0 + 1.3 -0.18 0 1.35 -0.18 0 1.4 -0.18 0 1.45 -0.18 0 + 1.5 -0.18 0 1.55 -0.18 0 1.6 -0.18 0 1.65 -0.18 0 + 1.7 -0.18 0 1.75 -0.18 0 1.8 -0.18 0 1.85 -0.18 0 + 1.9 -0.18 0 1.95 -0.18 0 2 -0.18 0 -0.5 -0.14 0 + -0.45 -0.14 0 -0.4 -0.14 0 -0.35 -0.14 0 -0.3 -0.14 0 + -0.25 -0.14 0 -0.2 -0.14 0 -0.15 -0.14 0 -0.1 -0.14 0 + -0.05 -0.14 0 2.77556e-17 -0.14 0 0.05 -0.14 0 0.1 -0.14 0 + 0.15 -0.14 0 0.2 -0.14 0 0.25 -0.14 0 0.3 -0.14 0 + 0.35 -0.14 0 0.4 -0.14 0 0.45 -0.14 0 0.5 -0.14 0 + 0.55 -0.14 0 0.6 -0.14 0 0.65 -0.14 0 0.7 -0.14 0 + 0.75 -0.14 0 0.8 -0.14 0 0.85 -0.14 0 0.9 -0.14 0 + 0.95 -0.14 0 1 -0.14 0 1.05 -0.14 0 1.1 -0.14 0 + 1.15 -0.14 0 1.2 -0.14 0 1.25 -0.14 0 1.3 -0.14 0 + 1.35 -0.14 0 1.4 -0.14 0 1.45 -0.14 0 1.5 -0.14 0 + 1.55 -0.14 0 1.6 -0.14 0 1.65 -0.14 0 1.7 -0.14 0 + 1.75 -0.14 0 1.8 -0.14 0 1.85 -0.14 0 1.9 -0.14 0 + 1.95 -0.14 0 2 -0.14 0 -0.5 -0.1 0 -0.45 -0.1 0 + -0.4 -0.1 0 -0.35 -0.1 0 -0.3 -0.1 0 -0.25 -0.1 0 + -0.2 -0.1 0 -0.15 -0.1 0 -0.1 -0.1 0 -0.05 -0.1 0 + 2.77556e-17 -0.1 0 0.05 -0.1 0 0.1 -0.1 0 0.15 -0.1 0 + 0.2 -0.1 0 0.25 -0.1 0 0.3 -0.1 0 0.35 -0.1 0 + 0.4 -0.1 0 0.45 -0.1 0 0.5 -0.1 0 0.55 -0.1 0 + 0.6 -0.1 0 0.65 -0.1 0 0.7 -0.1 0 0.75 -0.1 0 + 0.8 -0.1 0 0.85 -0.1 0 0.9 -0.1 0 0.95 -0.1 0 + 1 -0.1 0 1.05 -0.1 0 1.1 -0.1 0 1.15 -0.1 0 + 1.2 -0.1 0 1.25 -0.1 0 1.3 -0.1 0 1.35 -0.1 0 + 1.4 -0.1 0 1.45 -0.1 0 1.5 -0.1 0 1.55 -0.1 0 + 1.6 -0.1 0 1.65 -0.1 0 1.7 -0.1 0 1.75 -0.1 0 + 1.8 -0.1 0 1.85 -0.1 0 1.9 -0.1 0 1.95 -0.1 0 + 2 -0.1 0 -0.5 -0.06 0 -0.45 -0.06 0 -0.4 -0.06 0 + -0.35 -0.06 0 -0.3 -0.06 0 -0.25 -0.06 0 -0.2 -0.06 0 + -0.15 -0.06 0 -0.1 -0.06 0 -0.05 -0.06 0 2.77556e-17 -0.06 0 + 0.05 -0.06 0 0.1 -0.06 0 0.15 -0.06 0 0.2 -0.06 0 + 0.25 -0.06 0 0.3 -0.06 0 0.35 -0.06 0 0.4 -0.06 0 + 0.45 -0.06 0 0.5 -0.06 0 0.55 -0.06 0 0.6 -0.06 0 + 0.65 -0.06 0 0.7 -0.06 0 0.75 -0.06 0 0.8 -0.06 0 + 0.85 -0.06 0 0.9 -0.06 0 0.95 -0.06 0 1 -0.06 0 + 1.05 -0.06 0 1.1 -0.06 0 1.15 -0.06 0 1.2 -0.06 0 + 1.25 -0.06 0 1.3 -0.06 0 1.35 -0.06 0 1.4 -0.06 0 + 1.45 -0.06 0 1.5 -0.06 0 1.55 -0.06 0 1.6 -0.06 0 + 1.65 -0.06 0 1.7 -0.06 0 1.75 -0.06 0 1.8 -0.06 0 + 1.85 -0.06 0 1.9 -0.06 0 1.95 -0.06 0 2 -0.06 0 + -0.5 -0.02 0 -0.45 -0.02 0 -0.4 -0.02 0 -0.35 -0.02 0 + -0.3 -0.02 0 -0.25 -0.02 0 -0.2 -0.02 0 -0.15 -0.02 0 + -0.1 -0.02 0 -0.05 -0.02 0 2.77556e-17 -0.02 0 0.05 -0.02 0 + 0.1 -0.02 0 0.15 -0.02 0 0.2 -0.02 0 0.25 -0.02 0 + 0.3 -0.02 0 0.35 -0.02 0 0.4 -0.02 0 0.45 -0.02 0 + 0.5 -0.02 0 0.55 -0.02 0 0.6 -0.02 0 0.65 -0.02 0 + 0.7 -0.02 0 0.75 -0.02 0 0.8 -0.02 0 0.85 -0.02 0 + 0.9 -0.02 0 0.95 -0.02 0 1 -0.02 0 1.05 -0.02 0 + 1.1 -0.02 0 1.15 -0.02 0 1.2 -0.02 0 1.25 -0.02 0 + 1.3 -0.02 0 1.35 -0.02 0 1.4 -0.02 0 1.45 -0.02 0 + 1.5 -0.02 0 1.55 -0.02 0 1.6 -0.02 0 1.65 -0.02 0 + 1.7 -0.02 0 1.75 -0.02 0 1.8 -0.02 0 1.85 -0.02 0 + 1.9 -0.02 0 1.95 -0.02 0 2 -0.02 0 -0.5 0.02 0 + -0.45 0.02 0 -0.4 0.02 0 -0.35 0.02 0 -0.3 0.02 0 + -0.25 0.02 0 -0.2 0.02 0 -0.15 0.02 0 -0.1 0.02 0 + -0.05 0.02 0 2.77556e-17 0.02 0 0.05 0.02 0 0.1 0.02 0 + 0.15 0.02 0 0.2 0.02 0 0.25 0.02 0 0.3 0.02 0 + 0.35 0.02 0 0.4 0.02 0 0.45 0.02 0 0.5 0.02 0 + 0.55 0.02 0 0.6 0.02 0 0.65 0.02 0 0.7 0.02 0 + 0.75 0.02 0 0.8 0.02 0 0.85 0.02 0 0.9 0.02 0 + 0.95 0.02 0 1 0.02 0 1.05 0.02 0 1.1 0.02 0 + 1.15 0.02 0 1.2 0.02 0 1.25 0.02 0 1.3 0.02 0 + 1.35 0.02 0 1.4 0.02 0 1.45 0.02 0 1.5 0.02 0 + 1.55 0.02 0 1.6 0.02 0 1.65 0.02 0 1.7 0.02 0 + 1.75 0.02 0 1.8 0.02 0 1.85 0.02 0 1.9 0.02 0 + 1.95 0.02 0 2 0.02 0 -0.5 0.06 0 -0.45 0.06 0 + -0.4 0.06 0 -0.35 0.06 0 -0.3 0.06 0 -0.25 0.06 0 + -0.2 0.06 0 -0.15 0.06 0 -0.1 0.06 0 -0.05 0.06 0 + 2.77556e-17 0.06 0 0.05 0.06 0 0.1 0.06 0 0.15 0.06 0 + 0.2 0.06 0 0.25 0.06 0 0.3 0.06 0 0.35 0.06 0 + 0.4 0.06 0 0.45 0.06 0 0.5 0.06 0 0.55 0.06 0 + 0.6 0.06 0 0.65 0.06 0 0.7 0.06 0 0.75 0.06 0 + 0.8 0.06 0 0.85 0.06 0 0.9 0.06 0 0.95 0.06 0 + 1 0.06 0 1.05 0.06 0 1.1 0.06 0 1.15 0.06 0 + 1.2 0.06 0 1.25 0.06 0 1.3 0.06 0 1.35 0.06 0 + 1.4 0.06 0 1.45 0.06 0 1.5 0.06 0 1.55 0.06 0 + 1.6 0.06 0 1.65 0.06 0 1.7 0.06 0 1.75 0.06 0 + 1.8 0.06 0 1.85 0.06 0 1.9 0.06 0 1.95 0.06 0 + 2 0.06 0 -0.5 0.1 0 -0.45 0.1 0 -0.4 0.1 0 + -0.35 0.1 0 -0.3 0.1 0 -0.25 0.1 0 -0.2 0.1 0 + -0.15 0.1 0 -0.1 0.1 0 -0.05 0.1 0 2.77556e-17 0.1 0 + 0.05 0.1 0 0.1 0.1 0 0.15 0.1 0 0.2 0.1 0 + 0.25 0.1 0 0.3 0.1 0 0.35 0.1 0 0.4 0.1 0 + 0.45 0.1 0 0.5 0.1 0 0.55 0.1 0 0.6 0.1 0 + 0.65 0.1 0 0.7 0.1 0 0.75 0.1 0 0.8 0.1 0 + 0.85 0.1 0 0.9 0.1 0 0.95 0.1 0 1 0.1 0 + 1.05 0.1 0 1.1 0.1 0 1.15 0.1 0 1.2 0.1 0 + 1.25 0.1 0 1.3 0.1 0 1.35 0.1 0 1.4 0.1 0 + 1.45 0.1 0 1.5 0.1 0 1.55 0.1 0 1.6 0.1 0 + 1.65 0.1 0 1.7 0.1 0 1.75 0.1 0 1.8 0.1 0 + 1.85 0.1 0 1.9 0.1 0 1.95 0.1 0 2 0.1 0 + -0.5 0.14 0 -0.45 0.14 0 -0.4 0.14 0 -0.35 0.14 0 + -0.3 0.14 0 -0.25 0.14 0 -0.2 0.14 0 -0.15 0.14 0 + -0.1 0.14 0 -0.05 0.14 0 2.77556e-17 0.14 0 0.05 0.14 0 + 0.1 0.14 0 0.15 0.14 0 0.2 0.14 0 0.25 0.14 0 + 0.3 0.14 0 0.35 0.14 0 0.4 0.14 0 0.45 0.14 0 + 0.5 0.14 0 0.55 0.14 0 0.6 0.14 0 0.65 0.14 0 + 0.7 0.14 0 0.75 0.14 0 0.8 0.14 0 0.85 0.14 0 + 0.9 0.14 0 0.95 0.14 0 1 0.14 0 1.05 0.14 0 + 1.1 0.14 0 1.15 0.14 0 1.2 0.14 0 1.25 0.14 0 + 1.3 0.14 0 1.35 0.14 0 1.4 0.14 0 1.45 0.14 0 + 1.5 0.14 0 1.55 0.14 0 1.6 0.14 0 1.65 0.14 0 + 1.7 0.14 0 1.75 0.14 0 1.8 0.14 0 1.85 0.14 0 + 1.9 0.14 0 1.95 0.14 0 2 0.14 0 -0.5 0.18 0 + -0.45 0.18 0 -0.4 0.18 0 -0.35 0.18 0 -0.3 0.18 0 + -0.25 0.18 0 -0.2 0.18 0 -0.15 0.18 0 -0.1 0.18 0 + -0.05 0.18 0 2.77556e-17 0.18 0 0.05 0.18 0 0.1 0.18 0 + 0.15 0.18 0 0.2 0.18 0 0.25 0.18 0 0.3 0.18 0 + 0.35 0.18 0 0.4 0.18 0 0.45 0.18 0 0.5 0.18 0 + 0.55 0.18 0 0.6 0.18 0 0.65 0.18 0 0.7 0.18 0 + 0.75 0.18 0 0.8 0.18 0 0.85 0.18 0 0.9 0.18 0 + 0.95 0.18 0 1 0.18 0 1.05 0.18 0 1.1 0.18 0 + 1.15 0.18 0 1.2 0.18 0 1.25 0.18 0 1.3 0.18 0 + 1.35 0.18 0 1.4 0.18 0 1.45 0.18 0 1.5 0.18 0 + 1.55 0.18 0 1.6 0.18 0 1.65 0.18 0 1.7 0.18 0 + 1.75 0.18 0 1.8 0.18 0 1.85 0.18 0 1.9 0.18 0 + 1.95 0.18 0 2 0.18 0 -0.5 0.22 0 -0.45 0.22 0 + -0.4 0.22 0 -0.35 0.22 0 -0.3 0.22 0 -0.25 0.22 0 + -0.2 0.22 0 -0.15 0.22 0 -0.1 0.22 0 -0.05 0.22 0 + 2.77556e-17 0.22 0 0.05 0.22 0 0.1 0.22 0 0.15 0.22 0 + 0.2 0.22 0 0.25 0.22 0 0.3 0.22 0 0.35 0.22 0 + 0.4 0.22 0 0.45 0.22 0 0.5 0.22 0 0.55 0.22 0 + 0.6 0.22 0 0.65 0.22 0 0.7 0.22 0 0.75 0.22 0 + 0.8 0.22 0 0.85 0.22 0 0.9 0.22 0 0.95 0.22 0 + 1 0.22 0 1.05 0.22 0 1.1 0.22 0 1.15 0.22 0 + 1.2 0.22 0 1.25 0.22 0 1.3 0.22 0 1.35 0.22 0 + 1.4 0.22 0 1.45 0.22 0 1.5 0.22 0 1.55 0.22 0 + 1.6 0.22 0 1.65 0.22 0 1.7 0.22 0 1.75 0.22 0 + 1.8 0.22 0 1.85 0.22 0 1.9 0.22 0 1.95 0.22 0 + 2 0.22 0 -0.5 0.26 0 -0.45 0.26 0 -0.4 0.26 0 + -0.35 0.26 0 -0.3 0.26 0 -0.25 0.26 0 -0.2 0.26 0 + -0.15 0.26 0 -0.1 0.26 0 -0.05 0.26 0 2.77556e-17 0.26 0 + 0.05 0.26 0 0.1 0.26 0 0.15 0.26 0 0.2 0.26 0 + 0.25 0.26 0 0.3 0.26 0 0.35 0.26 0 0.4 0.26 0 + 0.45 0.26 0 0.5 0.26 0 0.55 0.26 0 0.6 0.26 0 + 0.65 0.26 0 0.7 0.26 0 0.75 0.26 0 0.8 0.26 0 + 0.85 0.26 0 0.9 0.26 0 0.95 0.26 0 1 0.26 0 + 1.05 0.26 0 1.1 0.26 0 1.15 0.26 0 1.2 0.26 0 + 1.25 0.26 0 1.3 0.26 0 1.35 0.26 0 1.4 0.26 0 + 1.45 0.26 0 1.5 0.26 0 1.55 0.26 0 1.6 0.26 0 + 1.65 0.26 0 1.7 0.26 0 1.75 0.26 0 1.8 0.26 0 + 1.85 0.26 0 1.9 0.26 0 1.95 0.26 0 2 0.26 0 + -0.5 0.3 0 -0.45 0.3 0 -0.4 0.3 0 -0.35 0.3 0 + -0.3 0.3 0 -0.25 0.3 0 -0.2 0.3 0 -0.15 0.3 0 + -0.1 0.3 0 -0.05 0.3 0 2.77556e-17 0.3 0 0.05 0.3 0 + 0.1 0.3 0 0.15 0.3 0 0.2 0.3 0 0.25 0.3 0 + 0.3 0.3 0 0.35 0.3 0 0.4 0.3 0 0.45 0.3 0 + 0.5 0.3 0 0.55 0.3 0 0.6 0.3 0 0.65 0.3 0 + 0.7 0.3 0 0.75 0.3 0 0.8 0.3 0 0.85 0.3 0 + 0.9 0.3 0 0.95 0.3 0 1 0.3 0 1.05 0.3 0 + 1.1 0.3 0 1.15 0.3 0 1.2 0.3 0 1.25 0.3 0 + 1.3 0.3 0 1.35 0.3 0 1.4 0.3 0 1.45 0.3 0 + 1.5 0.3 0 1.55 0.3 0 1.6 0.3 0 1.65 0.3 0 + 1.7 0.3 0 1.75 0.3 0 1.8 0.3 0 1.85 0.3 0 + 1.9 0.3 0 1.95 0.3 0 2 0.3 0 -0.5 0.34 0 + -0.45 0.34 0 -0.4 0.34 0 -0.35 0.34 0 -0.3 0.34 0 + -0.25 0.34 0 -0.2 0.34 0 -0.15 0.34 0 -0.1 0.34 0 + -0.05 0.34 0 2.77556e-17 0.34 0 0.05 0.34 0 0.1 0.34 0 + 0.15 0.34 0 0.2 0.34 0 0.25 0.34 0 0.3 0.34 0 + 0.35 0.34 0 0.4 0.34 0 0.45 0.34 0 0.5 0.34 0 + 0.55 0.34 0 0.6 0.34 0 0.65 0.34 0 0.7 0.34 0 + 0.75 0.34 0 0.8 0.34 0 0.85 0.34 0 0.9 0.34 0 + 0.95 0.34 0 1 0.34 0 1.05 0.34 0 1.1 0.34 0 + 1.15 0.34 0 1.2 0.34 0 1.25 0.34 0 1.3 0.34 0 + 1.35 0.34 0 1.4 0.34 0 1.45 0.34 0 1.5 0.34 0 + 1.55 0.34 0 1.6 0.34 0 1.65 0.34 0 1.7 0.34 0 + 1.75 0.34 0 1.8 0.34 0 1.85 0.34 0 1.9 0.34 0 + 1.95 0.34 0 2 0.34 0 -0.5 0.38 0 -0.45 0.38 0 + -0.4 0.38 0 -0.35 0.38 0 -0.3 0.38 0 -0.25 0.38 0 + -0.2 0.38 0 -0.15 0.38 0 -0.1 0.38 0 -0.05 0.38 0 + 2.77556e-17 0.38 0 0.05 0.38 0 0.1 0.38 0 0.15 0.38 0 + 0.2 0.38 0 0.25 0.38 0 0.3 0.38 0 0.35 0.38 0 + 0.4 0.38 0 0.45 0.38 0 0.5 0.38 0 0.55 0.38 0 + 0.6 0.38 0 0.65 0.38 0 0.7 0.38 0 0.75 0.38 0 + 0.8 0.38 0 0.85 0.38 0 0.9 0.38 0 0.95 0.38 0 + 1 0.38 0 1.05 0.38 0 1.1 0.38 0 1.15 0.38 0 + 1.2 0.38 0 1.25 0.38 0 1.3 0.38 0 1.35 0.38 0 + 1.4 0.38 0 1.45 0.38 0 1.5 0.38 0 1.55 0.38 0 + 1.6 0.38 0 1.65 0.38 0 1.7 0.38 0 1.75 0.38 0 + 1.8 0.38 0 1.85 0.38 0 1.9 0.38 0 1.95 0.38 0 + 2 0.38 0 -0.5 0.42 0 -0.45 0.42 0 -0.4 0.42 0 + -0.35 0.42 0 -0.3 0.42 0 -0.25 0.42 0 -0.2 0.42 0 + -0.15 0.42 0 -0.1 0.42 0 -0.05 0.42 0 2.77556e-17 0.42 0 + 0.05 0.42 0 0.1 0.42 0 0.15 0.42 0 0.2 0.42 0 + 0.25 0.42 0 0.3 0.42 0 0.35 0.42 0 0.4 0.42 0 + 0.45 0.42 0 0.5 0.42 0 0.55 0.42 0 0.6 0.42 0 + 0.65 0.42 0 0.7 0.42 0 0.75 0.42 0 0.8 0.42 0 + 0.85 0.42 0 0.9 0.42 0 0.95 0.42 0 1 0.42 0 + 1.05 0.42 0 1.1 0.42 0 1.15 0.42 0 1.2 0.42 0 + 1.25 0.42 0 1.3 0.42 0 1.35 0.42 0 1.4 0.42 0 + 1.45 0.42 0 1.5 0.42 0 1.55 0.42 0 1.6 0.42 0 + 1.65 0.42 0 1.7 0.42 0 1.75 0.42 0 1.8 0.42 0 + 1.85 0.42 0 1.9 0.42 0 1.95 0.42 0 2 0.42 0 + -0.5 0.46 0 -0.45 0.46 0 -0.4 0.46 0 -0.35 0.46 0 + -0.3 0.46 0 -0.25 0.46 0 -0.2 0.46 0 -0.15 0.46 0 + -0.1 0.46 0 -0.05 0.46 0 2.77556e-17 0.46 0 0.05 0.46 0 + 0.1 0.46 0 0.15 0.46 0 0.2 0.46 0 0.25 0.46 0 + 0.3 0.46 0 0.35 0.46 0 0.4 0.46 0 0.45 0.46 0 + 0.5 0.46 0 0.55 0.46 0 0.6 0.46 0 0.65 0.46 0 + 0.7 0.46 0 0.75 0.46 0 0.8 0.46 0 0.85 0.46 0 + 0.9 0.46 0 0.95 0.46 0 1 0.46 0 1.05 0.46 0 + 1.1 0.46 0 1.15 0.46 0 1.2 0.46 0 1.25 0.46 0 + 1.3 0.46 0 1.35 0.46 0 1.4 0.46 0 1.45 0.46 0 + 1.5 0.46 0 1.55 0.46 0 1.6 0.46 0 1.65 0.46 0 + 1.7 0.46 0 1.75 0.46 0 1.8 0.46 0 1.85 0.46 0 + 1.9 0.46 0 1.95 0.46 0 2 0.46 0 -0.5 0.5 0 + -0.45 0.5 0 -0.4 0.5 0 -0.35 0.5 0 -0.3 0.5 0 + -0.25 0.5 0 -0.2 0.5 0 -0.15 0.5 0 -0.1 0.5 0 + -0.05 0.5 0 2.77556e-17 0.5 0 0.05 0.5 0 0.1 0.5 0 + 0.15 0.5 0 0.2 0.5 0 0.25 0.5 0 0.3 0.5 0 + 0.35 0.5 0 0.4 0.5 0 0.45 0.5 0 0.5 0.5 0 + 0.55 0.5 0 0.6 0.5 0 0.65 0.5 0 0.7 0.5 0 + 0.75 0.5 0 0.8 0.5 0 0.85 0.5 0 0.9 0.5 0 + 0.95 0.5 0 1 0.5 0 1.05 0.5 0 1.1 0.5 0 + 1.15 0.5 0 1.2 0.5 0 1.25 0.5 0 1.3 0.5 0 + 1.35 0.5 0 1.4 0.5 0 1.45 0.5 0 1.5 0.5 0 + 1.55 0.5 0 1.6 0.5 0 1.65 0.5 0 1.7 0.5 0 + 1.75 0.5 0 1.8 0.5 0 1.85 0.5 0 1.9 0.5 0 + 1.95 0.5 0 2 0.5 0 -0.5 0.54 0 -0.45 0.54 0 + -0.4 0.54 0 -0.35 0.54 0 -0.3 0.54 0 -0.25 0.54 0 + -0.2 0.54 0 -0.15 0.54 0 -0.1 0.54 0 -0.05 0.54 0 + 2.77556e-17 0.54 0 0.05 0.54 0 0.1 0.54 0 0.15 0.54 0 + 0.2 0.54 0 0.25 0.54 0 0.3 0.54 0 0.35 0.54 0 + 0.4 0.54 0 0.45 0.54 0 0.5 0.54 0 0.55 0.54 0 + 0.6 0.54 0 0.65 0.54 0 0.7 0.54 0 0.75 0.54 0 + 0.8 0.54 0 0.85 0.54 0 0.9 0.54 0 0.95 0.54 0 + 1 0.54 0 1.05 0.54 0 1.1 0.54 0 1.15 0.54 0 + 1.2 0.54 0 1.25 0.54 0 1.3 0.54 0 1.35 0.54 0 + 1.4 0.54 0 1.45 0.54 0 1.5 0.54 0 1.55 0.54 0 + 1.6 0.54 0 1.65 0.54 0 1.7 0.54 0 1.75 0.54 0 + 1.8 0.54 0 1.85 0.54 0 1.9 0.54 0 1.95 0.54 0 + 2 0.54 0 -0.5 0.58 0 -0.45 0.58 0 -0.4 0.58 0 + -0.35 0.58 0 -0.3 0.58 0 -0.25 0.58 0 -0.2 0.58 0 + -0.15 0.58 0 -0.1 0.58 0 -0.05 0.58 0 2.77556e-17 0.58 0 + 0.05 0.58 0 0.1 0.58 0 0.15 0.58 0 0.2 0.58 0 + 0.25 0.58 0 0.3 0.58 0 0.35 0.58 0 0.4 0.58 0 + 0.45 0.58 0 0.5 0.58 0 0.55 0.58 0 0.6 0.58 0 + 0.65 0.58 0 0.7 0.58 0 0.75 0.58 0 0.8 0.58 0 + 0.85 0.58 0 0.9 0.58 0 0.95 0.58 0 1 0.58 0 + 1.05 0.58 0 1.1 0.58 0 1.15 0.58 0 1.2 0.58 0 + 1.25 0.58 0 1.3 0.58 0 1.35 0.58 0 1.4 0.58 0 + 1.45 0.58 0 1.5 0.58 0 1.55 0.58 0 1.6 0.58 0 + 1.65 0.58 0 1.7 0.58 0 1.75 0.58 0 1.8 0.58 0 + 1.85 0.58 0 1.9 0.58 0 1.95 0.58 0 2 0.58 0 + -0.5 0.62 0 -0.45 0.62 0 -0.4 0.62 0 -0.35 0.62 0 + -0.3 0.62 0 -0.25 0.62 0 -0.2 0.62 0 -0.15 0.62 0 + -0.1 0.62 0 -0.05 0.62 0 2.77556e-17 0.62 0 0.05 0.62 0 + 0.1 0.62 0 0.15 0.62 0 0.2 0.62 0 0.25 0.62 0 + 0.3 0.62 0 0.35 0.62 0 0.4 0.62 0 0.45 0.62 0 + 0.5 0.62 0 0.55 0.62 0 0.6 0.62 0 0.65 0.62 0 + 0.7 0.62 0 0.75 0.62 0 0.8 0.62 0 0.85 0.62 0 + 0.9 0.62 0 0.95 0.62 0 1 0.62 0 1.05 0.62 0 + 1.1 0.62 0 1.15 0.62 0 1.2 0.62 0 1.25 0.62 0 + 1.3 0.62 0 1.35 0.62 0 1.4 0.62 0 1.45 0.62 0 + 1.5 0.62 0 1.55 0.62 0 1.6 0.62 0 1.65 0.62 0 + 1.7 0.62 0 1.75 0.62 0 1.8 0.62 0 1.85 0.62 0 + 1.9 0.62 0 1.95 0.62 0 2 0.62 0 -0.5 0.66 0 + -0.45 0.66 0 -0.4 0.66 0 -0.35 0.66 0 -0.3 0.66 0 + -0.25 0.66 0 -0.2 0.66 0 -0.15 0.66 0 -0.1 0.66 0 + -0.05 0.66 0 2.77556e-17 0.66 0 0.05 0.66 0 0.1 0.66 0 + 0.15 0.66 0 0.2 0.66 0 0.25 0.66 0 0.3 0.66 0 + 0.35 0.66 0 0.4 0.66 0 0.45 0.66 0 0.5 0.66 0 + 0.55 0.66 0 0.6 0.66 0 0.65 0.66 0 0.7 0.66 0 + 0.75 0.66 0 0.8 0.66 0 0.85 0.66 0 0.9 0.66 0 + 0.95 0.66 0 1 0.66 0 1.05 0.66 0 1.1 0.66 0 + 1.15 0.66 0 1.2 0.66 0 1.25 0.66 0 1.3 0.66 0 + 1.35 0.66 0 1.4 0.66 0 1.45 0.66 0 1.5 0.66 0 + 1.55 0.66 0 1.6 0.66 0 1.65 0.66 0 1.7 0.66 0 + 1.75 0.66 0 1.8 0.66 0 1.85 0.66 0 1.9 0.66 0 + 1.95 0.66 0 2 0.66 0 -0.5 0.7 0 -0.45 0.7 0 + -0.4 0.7 0 -0.35 0.7 0 -0.3 0.7 0 -0.25 0.7 0 + -0.2 0.7 0 -0.15 0.7 0 -0.1 0.7 0 -0.05 0.7 0 + 2.77556e-17 0.7 0 0.05 0.7 0 0.1 0.7 0 0.15 0.7 0 + 0.2 0.7 0 0.25 0.7 0 0.3 0.7 0 0.35 0.7 0 + 0.4 0.7 0 0.45 0.7 0 0.5 0.7 0 0.55 0.7 0 + 0.6 0.7 0 0.65 0.7 0 0.7 0.7 0 0.75 0.7 0 + 0.8 0.7 0 0.85 0.7 0 0.9 0.7 0 0.95 0.7 0 + 1 0.7 0 1.05 0.7 0 1.1 0.7 0 1.15 0.7 0 + 1.2 0.7 0 1.25 0.7 0 1.3 0.7 0 1.35 0.7 0 + 1.4 0.7 0 1.45 0.7 0 1.5 0.7 0 1.55 0.7 0 + 1.6 0.7 0 1.65 0.7 0 1.7 0.7 0 1.75 0.7 0 + 1.8 0.7 0 1.85 0.7 0 1.9 0.7 0 1.95 0.7 0 + 2 0.7 0 -0.5 0.74 0 -0.45 0.74 0 -0.4 0.74 0 + -0.35 0.74 0 -0.3 0.74 0 -0.25 0.74 0 -0.2 0.74 0 + -0.15 0.74 0 -0.1 0.74 0 -0.05 0.74 0 2.77556e-17 0.74 0 + 0.05 0.74 0 0.1 0.74 0 0.15 0.74 0 0.2 0.74 0 + 0.25 0.74 0 0.3 0.74 0 0.35 0.74 0 0.4 0.74 0 + 0.45 0.74 0 0.5 0.74 0 0.55 0.74 0 0.6 0.74 0 + 0.65 0.74 0 0.7 0.74 0 0.75 0.74 0 0.8 0.74 0 + 0.85 0.74 0 0.9 0.74 0 0.95 0.74 0 1 0.74 0 + 1.05 0.74 0 1.1 0.74 0 1.15 0.74 0 1.2 0.74 0 + 1.25 0.74 0 1.3 0.74 0 1.35 0.74 0 1.4 0.74 0 + 1.45 0.74 0 1.5 0.74 0 1.55 0.74 0 1.6 0.74 0 + 1.65 0.74 0 1.7 0.74 0 1.75 0.74 0 1.8 0.74 0 + 1.85 0.74 0 1.9 0.74 0 1.95 0.74 0 2 0.74 0 + -0.5 0.78 0 -0.45 0.78 0 -0.4 0.78 0 -0.35 0.78 0 + -0.3 0.78 0 -0.25 0.78 0 -0.2 0.78 0 -0.15 0.78 0 + -0.1 0.78 0 -0.05 0.78 0 2.77556e-17 0.78 0 0.05 0.78 0 + 0.1 0.78 0 0.15 0.78 0 0.2 0.78 0 0.25 0.78 0 + 0.3 0.78 0 0.35 0.78 0 0.4 0.78 0 0.45 0.78 0 + 0.5 0.78 0 0.55 0.78 0 0.6 0.78 0 0.65 0.78 0 + 0.7 0.78 0 0.75 0.78 0 0.8 0.78 0 0.85 0.78 0 + 0.9 0.78 0 0.95 0.78 0 1 0.78 0 1.05 0.78 0 + 1.1 0.78 0 1.15 0.78 0 1.2 0.78 0 1.25 0.78 0 + 1.3 0.78 0 1.35 0.78 0 1.4 0.78 0 1.45 0.78 0 + 1.5 0.78 0 1.55 0.78 0 1.6 0.78 0 1.65 0.78 0 + 1.7 0.78 0 1.75 0.78 0 1.8 0.78 0 1.85 0.78 0 + 1.9 0.78 0 1.95 0.78 0 2 0.78 0 -0.5 0.82 0 + -0.45 0.82 0 -0.4 0.82 0 -0.35 0.82 0 -0.3 0.82 0 + -0.25 0.82 0 -0.2 0.82 0 -0.15 0.82 0 -0.1 0.82 0 + -0.05 0.82 0 2.77556e-17 0.82 0 0.05 0.82 0 0.1 0.82 0 + 0.15 0.82 0 0.2 0.82 0 0.25 0.82 0 0.3 0.82 0 + 0.35 0.82 0 0.4 0.82 0 0.45 0.82 0 0.5 0.82 0 + 0.55 0.82 0 0.6 0.82 0 0.65 0.82 0 0.7 0.82 0 + 0.75 0.82 0 0.8 0.82 0 0.85 0.82 0 0.9 0.82 0 + 0.95 0.82 0 1 0.82 0 1.05 0.82 0 1.1 0.82 0 + 1.15 0.82 0 1.2 0.82 0 1.25 0.82 0 1.3 0.82 0 + 1.35 0.82 0 1.4 0.82 0 1.45 0.82 0 1.5 0.82 0 + 1.55 0.82 0 1.6 0.82 0 1.65 0.82 0 1.7 0.82 0 + 1.75 0.82 0 1.8 0.82 0 1.85 0.82 0 1.9 0.82 0 + 1.95 0.82 0 2 0.82 0 -0.5 0.86 0 -0.45 0.86 0 + -0.4 0.86 0 -0.35 0.86 0 -0.3 0.86 0 -0.25 0.86 0 + -0.2 0.86 0 -0.15 0.86 0 -0.1 0.86 0 -0.05 0.86 0 + 2.77556e-17 0.86 0 0.05 0.86 0 0.1 0.86 0 0.15 0.86 0 + 0.2 0.86 0 0.25 0.86 0 0.3 0.86 0 0.35 0.86 0 + 0.4 0.86 0 0.45 0.86 0 0.5 0.86 0 0.55 0.86 0 + 0.6 0.86 0 0.65 0.86 0 0.7 0.86 0 0.75 0.86 0 + 0.8 0.86 0 0.85 0.86 0 0.9 0.86 0 0.95 0.86 0 + 1 0.86 0 1.05 0.86 0 1.1 0.86 0 1.15 0.86 0 + 1.2 0.86 0 1.25 0.86 0 1.3 0.86 0 1.35 0.86 0 + 1.4 0.86 0 1.45 0.86 0 1.5 0.86 0 1.55 0.86 0 + 1.6 0.86 0 1.65 0.86 0 1.7 0.86 0 1.75 0.86 0 + 1.8 0.86 0 1.85 0.86 0 1.9 0.86 0 1.95 0.86 0 + 2 0.86 0 -0.5 0.9 0 -0.45 0.9 0 -0.4 0.9 0 + -0.35 0.9 0 -0.3 0.9 0 -0.25 0.9 0 -0.2 0.9 0 + -0.15 0.9 0 -0.1 0.9 0 -0.05 0.9 0 2.77556e-17 0.9 0 + 0.05 0.9 0 0.1 0.9 0 0.15 0.9 0 0.2 0.9 0 + 0.25 0.9 0 0.3 0.9 0 0.35 0.9 0 0.4 0.9 0 + 0.45 0.9 0 0.5 0.9 0 0.55 0.9 0 0.6 0.9 0 + 0.65 0.9 0 0.7 0.9 0 0.75 0.9 0 0.8 0.9 0 + 0.85 0.9 0 0.9 0.9 0 0.95 0.9 0 1 0.9 0 + 1.05 0.9 0 1.1 0.9 0 1.15 0.9 0 1.2 0.9 0 + 1.25 0.9 0 1.3 0.9 0 1.35 0.9 0 1.4 0.9 0 + 1.45 0.9 0 1.5 0.9 0 1.55 0.9 0 1.6 0.9 0 + 1.65 0.9 0 1.7 0.9 0 1.75 0.9 0 1.8 0.9 0 + 1.85 0.9 0 1.9 0.9 0 1.95 0.9 0 2 0.9 0 + -0.5 0.94 0 -0.45 0.94 0 -0.4 0.94 0 -0.35 0.94 0 + -0.3 0.94 0 -0.25 0.94 0 -0.2 0.94 0 -0.15 0.94 0 + -0.1 0.94 0 -0.05 0.94 0 2.77556e-17 0.94 0 0.05 0.94 0 + 0.1 0.94 0 0.15 0.94 0 0.2 0.94 0 0.25 0.94 0 + 0.3 0.94 0 0.35 0.94 0 0.4 0.94 0 0.45 0.94 0 + 0.5 0.94 0 0.55 0.94 0 0.6 0.94 0 0.65 0.94 0 + 0.7 0.94 0 0.75 0.94 0 0.8 0.94 0 0.85 0.94 0 + 0.9 0.94 0 0.95 0.94 0 1 0.94 0 1.05 0.94 0 + 1.1 0.94 0 1.15 0.94 0 1.2 0.94 0 1.25 0.94 0 + 1.3 0.94 0 1.35 0.94 0 1.4 0.94 0 1.45 0.94 0 + 1.5 0.94 0 1.55 0.94 0 1.6 0.94 0 1.65 0.94 0 + 1.7 0.94 0 1.75 0.94 0 1.8 0.94 0 1.85 0.94 0 + 1.9 0.94 0 1.95 0.94 0 2 0.94 0 -0.5 0.98 0 + -0.45 0.98 0 -0.4 0.98 0 -0.35 0.98 0 -0.3 0.98 0 + -0.25 0.98 0 -0.2 0.98 0 -0.15 0.98 0 -0.1 0.98 0 + -0.05 0.98 0 2.77556e-17 0.98 0 0.05 0.98 0 0.1 0.98 0 + 0.15 0.98 0 0.2 0.98 0 0.25 0.98 0 0.3 0.98 0 + 0.35 0.98 0 0.4 0.98 0 0.45 0.98 0 0.5 0.98 0 + 0.55 0.98 0 0.6 0.98 0 0.65 0.98 0 0.7 0.98 0 + 0.75 0.98 0 0.8 0.98 0 0.85 0.98 0 0.9 0.98 0 + 0.95 0.98 0 1 0.98 0 1.05 0.98 0 1.1 0.98 0 + 1.15 0.98 0 1.2 0.98 0 1.25 0.98 0 1.3 0.98 0 + 1.35 0.98 0 1.4 0.98 0 1.45 0.98 0 1.5 0.98 0 + 1.55 0.98 0 1.6 0.98 0 1.65 0.98 0 1.7 0.98 0 + 1.75 0.98 0 1.8 0.98 0 1.85 0.98 0 1.9 0.98 0 + 1.95 0.98 0 2 0.98 0 -0.5 1.02 0 -0.45 1.02 0 + -0.4 1.02 0 -0.35 1.02 0 -0.3 1.02 0 -0.25 1.02 0 + -0.2 1.02 0 -0.15 1.02 0 -0.1 1.02 0 -0.05 1.02 0 + 2.77556e-17 1.02 0 0.05 1.02 0 0.1 1.02 0 0.15 1.02 0 + 0.2 1.02 0 0.25 1.02 0 0.3 1.02 0 0.35 1.02 0 + 0.4 1.02 0 0.45 1.02 0 0.5 1.02 0 0.55 1.02 0 + 0.6 1.02 0 0.65 1.02 0 0.7 1.02 0 0.75 1.02 0 + 0.8 1.02 0 0.85 1.02 0 0.9 1.02 0 0.95 1.02 0 + 1 1.02 0 1.05 1.02 0 1.1 1.02 0 1.15 1.02 0 + 1.2 1.02 0 1.25 1.02 0 1.3 1.02 0 1.35 1.02 0 + 1.4 1.02 0 1.45 1.02 0 1.5 1.02 0 1.55 1.02 0 + 1.6 1.02 0 1.65 1.02 0 1.7 1.02 0 1.75 1.02 0 + 1.8 1.02 0 1.85 1.02 0 1.9 1.02 0 1.95 1.02 0 + 2 1.02 0 -0.5 1.06 0 -0.45 1.06 0 -0.4 1.06 0 + -0.35 1.06 0 -0.3 1.06 0 -0.25 1.06 0 -0.2 1.06 0 + -0.15 1.06 0 -0.1 1.06 0 -0.05 1.06 0 2.77556e-17 1.06 0 + 0.05 1.06 0 0.1 1.06 0 0.15 1.06 0 0.2 1.06 0 + 0.25 1.06 0 0.3 1.06 0 0.35 1.06 0 0.4 1.06 0 + 0.45 1.06 0 0.5 1.06 0 0.55 1.06 0 0.6 1.06 0 + 0.65 1.06 0 0.7 1.06 0 0.75 1.06 0 0.8 1.06 0 + 0.85 1.06 0 0.9 1.06 0 0.95 1.06 0 1 1.06 0 + 1.05 1.06 0 1.1 1.06 0 1.15 1.06 0 1.2 1.06 0 + 1.25 1.06 0 1.3 1.06 0 1.35 1.06 0 1.4 1.06 0 + 1.45 1.06 0 1.5 1.06 0 1.55 1.06 0 1.6 1.06 0 + 1.65 1.06 0 1.7 1.06 0 1.75 1.06 0 1.8 1.06 0 + 1.85 1.06 0 1.9 1.06 0 1.95 1.06 0 2 1.06 0 + -0.5 1.1 0 -0.45 1.1 0 -0.4 1.1 0 -0.35 1.1 0 + -0.3 1.1 0 -0.25 1.1 0 -0.2 1.1 0 -0.15 1.1 0 + -0.1 1.1 0 -0.05 1.1 0 2.77556e-17 1.1 0 0.05 1.1 0 + 0.1 1.1 0 0.15 1.1 0 0.2 1.1 0 0.25 1.1 0 + 0.3 1.1 0 0.35 1.1 0 0.4 1.1 0 0.45 1.1 0 + 0.5 1.1 0 0.55 1.1 0 0.6 1.1 0 0.65 1.1 0 + 0.7 1.1 0 0.75 1.1 0 0.8 1.1 0 0.85 1.1 0 + 0.9 1.1 0 0.95 1.1 0 1 1.1 0 1.05 1.1 0 + 1.1 1.1 0 1.15 1.1 0 1.2 1.1 0 1.25 1.1 0 + 1.3 1.1 0 1.35 1.1 0 1.4 1.1 0 1.45 1.1 0 + 1.5 1.1 0 1.55 1.1 0 1.6 1.1 0 1.65 1.1 0 + 1.7 1.1 0 1.75 1.1 0 1.8 1.1 0 1.85 1.1 0 + 1.9 1.1 0 1.95 1.1 0 2 1.1 0 -0.5 1.14 0 + -0.45 1.14 0 -0.4 1.14 0 -0.35 1.14 0 -0.3 1.14 0 + -0.25 1.14 0 -0.2 1.14 0 -0.15 1.14 0 -0.1 1.14 0 + -0.05 1.14 0 2.77556e-17 1.14 0 0.05 1.14 0 0.1 1.14 0 + 0.15 1.14 0 0.2 1.14 0 0.25 1.14 0 0.3 1.14 0 + 0.35 1.14 0 0.4 1.14 0 0.45 1.14 0 0.5 1.14 0 + 0.55 1.14 0 0.6 1.14 0 0.65 1.14 0 0.7 1.14 0 + 0.75 1.14 0 0.8 1.14 0 0.85 1.14 0 0.9 1.14 0 + 0.95 1.14 0 1 1.14 0 1.05 1.14 0 1.1 1.14 0 + 1.15 1.14 0 1.2 1.14 0 1.25 1.14 0 1.3 1.14 0 + 1.35 1.14 0 1.4 1.14 0 1.45 1.14 0 1.5 1.14 0 + 1.55 1.14 0 1.6 1.14 0 1.65 1.14 0 1.7 1.14 0 + 1.75 1.14 0 1.8 1.14 0 1.85 1.14 0 1.9 1.14 0 + 1.95 1.14 0 2 1.14 0 -0.5 1.18 0 -0.45 1.18 0 + -0.4 1.18 0 -0.35 1.18 0 -0.3 1.18 0 -0.25 1.18 0 + -0.2 1.18 0 -0.15 1.18 0 -0.1 1.18 0 -0.05 1.18 0 + 2.77556e-17 1.18 0 0.05 1.18 0 0.1 1.18 0 0.15 1.18 0 + 0.2 1.18 0 0.25 1.18 0 0.3 1.18 0 0.35 1.18 0 + 0.4 1.18 0 0.45 1.18 0 0.5 1.18 0 0.55 1.18 0 + 0.6 1.18 0 0.65 1.18 0 0.7 1.18 0 0.75 1.18 0 + 0.8 1.18 0 0.85 1.18 0 0.9 1.18 0 0.95 1.18 0 + 1 1.18 0 1.05 1.18 0 1.1 1.18 0 1.15 1.18 0 + 1.2 1.18 0 1.25 1.18 0 1.3 1.18 0 1.35 1.18 0 + 1.4 1.18 0 1.45 1.18 0 1.5 1.18 0 1.55 1.18 0 + 1.6 1.18 0 1.65 1.18 0 1.7 1.18 0 1.75 1.18 0 + 1.8 1.18 0 1.85 1.18 0 1.9 1.18 0 1.95 1.18 0 + 2 1.18 0 -0.5 1.22 0 -0.45 1.22 0 -0.4 1.22 0 + -0.35 1.22 0 -0.3 1.22 0 -0.25 1.22 0 -0.2 1.22 0 + -0.15 1.22 0 -0.1 1.22 0 -0.05 1.22 0 2.77556e-17 1.22 0 + 0.05 1.22 0 0.1 1.22 0 0.15 1.22 0 0.2 1.22 0 + 0.25 1.22 0 0.3 1.22 0 0.35 1.22 0 0.4 1.22 0 + 0.45 1.22 0 0.5 1.22 0 0.55 1.22 0 0.6 1.22 0 + 0.65 1.22 0 0.7 1.22 0 0.75 1.22 0 0.8 1.22 0 + 0.85 1.22 0 0.9 1.22 0 0.95 1.22 0 1 1.22 0 + 1.05 1.22 0 1.1 1.22 0 1.15 1.22 0 1.2 1.22 0 + 1.25 1.22 0 1.3 1.22 0 1.35 1.22 0 1.4 1.22 0 + 1.45 1.22 0 1.5 1.22 0 1.55 1.22 0 1.6 1.22 0 + 1.65 1.22 0 1.7 1.22 0 1.75 1.22 0 1.8 1.22 0 + 1.85 1.22 0 1.9 1.22 0 1.95 1.22 0 2 1.22 0 + -0.5 1.26 0 -0.45 1.26 0 -0.4 1.26 0 -0.35 1.26 0 + -0.3 1.26 0 -0.25 1.26 0 -0.2 1.26 0 -0.15 1.26 0 + -0.1 1.26 0 -0.05 1.26 0 2.77556e-17 1.26 0 0.05 1.26 0 + 0.1 1.26 0 0.15 1.26 0 0.2 1.26 0 0.25 1.26 0 + 0.3 1.26 0 0.35 1.26 0 0.4 1.26 0 0.45 1.26 0 + 0.5 1.26 0 0.55 1.26 0 0.6 1.26 0 0.65 1.26 0 + 0.7 1.26 0 0.75 1.26 0 0.8 1.26 0 0.85 1.26 0 + 0.9 1.26 0 0.95 1.26 0 1 1.26 0 1.05 1.26 0 + 1.1 1.26 0 1.15 1.26 0 1.2 1.26 0 1.25 1.26 0 + 1.3 1.26 0 1.35 1.26 0 1.4 1.26 0 1.45 1.26 0 + 1.5 1.26 0 1.55 1.26 0 1.6 1.26 0 1.65 1.26 0 + 1.7 1.26 0 1.75 1.26 0 1.8 1.26 0 1.85 1.26 0 + 1.9 1.26 0 1.95 1.26 0 2 1.26 0 -0.5 1.3 0 + -0.45 1.3 0 -0.4 1.3 0 -0.35 1.3 0 -0.3 1.3 0 + -0.25 1.3 0 -0.2 1.3 0 -0.15 1.3 0 -0.1 1.3 0 + -0.05 1.3 0 2.77556e-17 1.3 0 0.05 1.3 0 0.1 1.3 0 + 0.15 1.3 0 0.2 1.3 0 0.25 1.3 0 0.3 1.3 0 + 0.35 1.3 0 0.4 1.3 0 0.45 1.3 0 0.5 1.3 0 + 0.55 1.3 0 0.6 1.3 0 0.65 1.3 0 0.7 1.3 0 + 0.75 1.3 0 0.8 1.3 0 0.85 1.3 0 0.9 1.3 0 + 0.95 1.3 0 1 1.3 0 1.05 1.3 0 1.1 1.3 0 + 1.15 1.3 0 1.2 1.3 0 1.25 1.3 0 1.3 1.3 0 + 1.35 1.3 0 1.4 1.3 0 1.45 1.3 0 1.5 1.3 0 + 1.55 1.3 0 1.6 1.3 0 1.65 1.3 0 1.7 1.3 0 + 1.75 1.3 0 1.8 1.3 0 1.85 1.3 0 1.9 1.3 0 + 1.95 1.3 0 2 1.3 0 -0.5 1.34 0 -0.45 1.34 0 + -0.4 1.34 0 -0.35 1.34 0 -0.3 1.34 0 -0.25 1.34 0 + -0.2 1.34 0 -0.15 1.34 0 -0.1 1.34 0 -0.05 1.34 0 + 2.77556e-17 1.34 0 0.05 1.34 0 0.1 1.34 0 0.15 1.34 0 + 0.2 1.34 0 0.25 1.34 0 0.3 1.34 0 0.35 1.34 0 + 0.4 1.34 0 0.45 1.34 0 0.5 1.34 0 0.55 1.34 0 + 0.6 1.34 0 0.65 1.34 0 0.7 1.34 0 0.75 1.34 0 + 0.8 1.34 0 0.85 1.34 0 0.9 1.34 0 0.95 1.34 0 + 1 1.34 0 1.05 1.34 0 1.1 1.34 0 1.15 1.34 0 + 1.2 1.34 0 1.25 1.34 0 1.3 1.34 0 1.35 1.34 0 + 1.4 1.34 0 1.45 1.34 0 1.5 1.34 0 1.55 1.34 0 + 1.6 1.34 0 1.65 1.34 0 1.7 1.34 0 1.75 1.34 0 + 1.8 1.34 0 1.85 1.34 0 1.9 1.34 0 1.95 1.34 0 + 2 1.34 0 -0.5 1.38 0 -0.45 1.38 0 -0.4 1.38 0 + -0.35 1.38 0 -0.3 1.38 0 -0.25 1.38 0 -0.2 1.38 0 + -0.15 1.38 0 -0.1 1.38 0 -0.05 1.38 0 2.77556e-17 1.38 0 + 0.05 1.38 0 0.1 1.38 0 0.15 1.38 0 0.2 1.38 0 + 0.25 1.38 0 0.3 1.38 0 0.35 1.38 0 0.4 1.38 0 + 0.45 1.38 0 0.5 1.38 0 0.55 1.38 0 0.6 1.38 0 + 0.65 1.38 0 0.7 1.38 0 0.75 1.38 0 0.8 1.38 0 + 0.85 1.38 0 0.9 1.38 0 0.95 1.38 0 1 1.38 0 + 1.05 1.38 0 1.1 1.38 0 1.15 1.38 0 1.2 1.38 0 + 1.25 1.38 0 1.3 1.38 0 1.35 1.38 0 1.4 1.38 0 + 1.45 1.38 0 1.5 1.38 0 1.55 1.38 0 1.6 1.38 0 + 1.65 1.38 0 1.7 1.38 0 1.75 1.38 0 1.8 1.38 0 + 1.85 1.38 0 1.9 1.38 0 1.95 1.38 0 2 1.38 0 + -0.5 1.42 0 -0.45 1.42 0 -0.4 1.42 0 -0.35 1.42 0 + -0.3 1.42 0 -0.25 1.42 0 -0.2 1.42 0 -0.15 1.42 0 + -0.1 1.42 0 -0.05 1.42 0 2.77556e-17 1.42 0 0.05 1.42 0 + 0.1 1.42 0 0.15 1.42 0 0.2 1.42 0 0.25 1.42 0 + 0.3 1.42 0 0.35 1.42 0 0.4 1.42 0 0.45 1.42 0 + 0.5 1.42 0 0.55 1.42 0 0.6 1.42 0 0.65 1.42 0 + 0.7 1.42 0 0.75 1.42 0 0.8 1.42 0 0.85 1.42 0 + 0.9 1.42 0 0.95 1.42 0 1 1.42 0 1.05 1.42 0 + 1.1 1.42 0 1.15 1.42 0 1.2 1.42 0 1.25 1.42 0 + 1.3 1.42 0 1.35 1.42 0 1.4 1.42 0 1.45 1.42 0 + 1.5 1.42 0 1.55 1.42 0 1.6 1.42 0 1.65 1.42 0 + 1.7 1.42 0 1.75 1.42 0 1.8 1.42 0 1.85 1.42 0 + 1.9 1.42 0 1.95 1.42 0 2 1.42 0 -0.5 1.46 0 + -0.45 1.46 0 -0.4 1.46 0 -0.35 1.46 0 -0.3 1.46 0 + -0.25 1.46 0 -0.2 1.46 0 -0.15 1.46 0 -0.1 1.46 0 + -0.05 1.46 0 2.77556e-17 1.46 0 0.05 1.46 0 0.1 1.46 0 + 0.15 1.46 0 0.2 1.46 0 0.25 1.46 0 0.3 1.46 0 + 0.35 1.46 0 0.4 1.46 0 0.45 1.46 0 0.5 1.46 0 + 0.55 1.46 0 0.6 1.46 0 0.65 1.46 0 0.7 1.46 0 + 0.75 1.46 0 0.8 1.46 0 0.85 1.46 0 0.9 1.46 0 + 0.95 1.46 0 1 1.46 0 1.05 1.46 0 1.1 1.46 0 + 1.15 1.46 0 1.2 1.46 0 1.25 1.46 0 1.3 1.46 0 + 1.35 1.46 0 1.4 1.46 0 1.45 1.46 0 1.5 1.46 0 + 1.55 1.46 0 1.6 1.46 0 1.65 1.46 0 1.7 1.46 0 + 1.75 1.46 0 1.8 1.46 0 1.85 1.46 0 1.9 1.46 0 + 1.95 1.46 0 2 1.46 0 -0.5 1.5 0 -0.45 1.5 0 + -0.4 1.5 0 -0.35 1.5 0 -0.3 1.5 0 -0.25 1.5 0 + -0.2 1.5 0 -0.15 1.5 0 -0.1 1.5 0 -0.05 1.5 0 + 2.77556e-17 1.5 0 0.05 1.5 0 0.1 1.5 0 0.15 1.5 0 + 0.2 1.5 0 0.25 1.5 0 0.3 1.5 0 0.35 1.5 0 + 0.4 1.5 0 0.45 1.5 0 0.5 1.5 0 0.55 1.5 0 + 0.6 1.5 0 0.65 1.5 0 0.7 1.5 0 0.75 1.5 0 + 0.8 1.5 0 0.85 1.5 0 0.9 1.5 0 0.95 1.5 0 + 1 1.5 0 1.05 1.5 0 1.1 1.5 0 1.15 1.5 0 + 1.2 1.5 0 1.25 1.5 0 1.3 1.5 0 1.35 1.5 0 + 1.4 1.5 0 1.45 1.5 0 1.5 1.5 0 1.55 1.5 0 + 1.6 1.5 0 1.65 1.5 0 1.7 1.5 0 1.75 1.5 0 + 1.8 1.5 0 1.85 1.5 0 1.9 1.5 0 1.95 1.5 0 + 2 1.5 0 + </DataArray> + </Points> + <Cells> + <DataArray type="Int32" Name="connectivity" NumberOfComponents="1" format="ascii"> + 0 1 3 2 1 4 5 3 4 6 7 5 + 6 8 9 7 8 10 11 9 10 12 13 11 + 12 14 15 13 14 16 17 15 16 18 19 17 + 18 20 21 19 20 22 23 21 22 24 25 23 + 24 26 27 25 26 28 29 27 28 30 31 29 + 30 32 33 31 32 34 35 33 34 36 37 35 + 36 38 39 37 38 40 41 39 40 42 43 41 + 42 44 45 43 44 46 47 45 46 48 49 47 + 48 50 51 49 50 52 53 51 52 54 55 53 + 54 56 57 55 56 58 59 57 58 60 61 59 + 60 62 63 61 62 64 65 63 64 66 67 65 + 66 68 69 67 68 70 71 69 70 72 73 71 + 72 74 75 73 74 76 77 75 76 78 79 77 + 78 80 81 79 80 82 83 81 82 84 85 83 + 84 86 87 85 86 88 89 87 88 90 91 89 + 90 92 93 91 92 94 95 93 94 96 97 95 + 96 98 99 97 98 100 101 99 2 3 103 102 + 3 5 104 103 5 7 105 104 7 9 106 105 + 9 11 107 106 11 13 108 107 13 15 109 108 + 15 17 110 109 17 19 111 110 19 21 112 111 + 21 23 113 112 23 25 114 113 25 27 115 114 + 27 29 116 115 29 31 117 116 31 33 118 117 + 33 35 119 118 35 37 120 119 37 39 121 120 + 39 41 122 121 41 43 123 122 43 45 124 123 + 45 47 125 124 47 49 126 125 49 51 127 126 + 51 53 128 127 53 55 129 128 55 57 130 129 + 57 59 131 130 59 61 132 131 61 63 133 132 + 63 65 134 133 65 67 135 134 67 69 136 135 + 69 71 137 136 71 73 138 137 73 75 139 138 + 75 77 140 139 77 79 141 140 79 81 142 141 + 81 83 143 142 83 85 144 143 85 87 145 144 + 87 89 146 145 89 91 147 146 91 93 148 147 + 93 95 149 148 95 97 150 149 97 99 151 150 + 99 101 152 151 102 103 154 153 103 104 155 154 + 104 105 156 155 105 106 157 156 106 107 158 157 + 107 108 159 158 108 109 160 159 109 110 161 160 + 110 111 162 161 111 112 163 162 112 113 164 163 + 113 114 165 164 114 115 166 165 115 116 167 166 + 116 117 168 167 117 118 169 168 118 119 170 169 + 119 120 171 170 120 121 172 171 121 122 173 172 + 122 123 174 173 123 124 175 174 124 125 176 175 + 125 126 177 176 126 127 178 177 127 128 179 178 + 128 129 180 179 129 130 181 180 130 131 182 181 + 131 132 183 182 132 133 184 183 133 134 185 184 + 134 135 186 185 135 136 187 186 136 137 188 187 + 137 138 189 188 138 139 190 189 139 140 191 190 + 140 141 192 191 141 142 193 192 142 143 194 193 + 143 144 195 194 144 145 196 195 145 146 197 196 + 146 147 198 197 147 148 199 198 148 149 200 199 + 149 150 201 200 150 151 202 201 151 152 203 202 + 153 154 205 204 154 155 206 205 155 156 207 206 + 156 157 208 207 157 158 209 208 158 159 210 209 + 159 160 211 210 160 161 212 211 161 162 213 212 + 162 163 214 213 163 164 215 214 164 165 216 215 + 165 166 217 216 166 167 218 217 167 168 219 218 + 168 169 220 219 169 170 221 220 170 171 222 221 + 171 172 223 222 172 173 224 223 173 174 225 224 + 174 175 226 225 175 176 227 226 176 177 228 227 + 177 178 229 228 178 179 230 229 179 180 231 230 + 180 181 232 231 181 182 233 232 182 183 234 233 + 183 184 235 234 184 185 236 235 185 186 237 236 + 186 187 238 237 187 188 239 238 188 189 240 239 + 189 190 241 240 190 191 242 241 191 192 243 242 + 192 193 244 243 193 194 245 244 194 195 246 245 + 195 196 247 246 196 197 248 247 197 198 249 248 + 198 199 250 249 199 200 251 250 200 201 252 251 + 201 202 253 252 202 203 254 253 204 205 256 255 + 205 206 257 256 206 207 258 257 207 208 259 258 + 208 209 260 259 209 210 261 260 210 211 262 261 + 211 212 263 262 212 213 264 263 213 214 265 264 + 214 215 266 265 215 216 267 266 216 217 268 267 + 217 218 269 268 218 219 270 269 219 220 271 270 + 220 221 272 271 221 222 273 272 222 223 274 273 + 223 224 275 274 224 225 276 275 225 226 277 276 + 226 227 278 277 227 228 279 278 228 229 280 279 + 229 230 281 280 230 231 282 281 231 232 283 282 + 232 233 284 283 233 234 285 284 234 235 286 285 + 235 236 287 286 236 237 288 287 237 238 289 288 + 238 239 290 289 239 240 291 290 240 241 292 291 + 241 242 293 292 242 243 294 293 243 244 295 294 + 244 245 296 295 245 246 297 296 246 247 298 297 + 247 248 299 298 248 249 300 299 249 250 301 300 + 250 251 302 301 251 252 303 302 252 253 304 303 + 253 254 305 304 255 256 307 306 256 257 308 307 + 257 258 309 308 258 259 310 309 259 260 311 310 + 260 261 312 311 261 262 313 312 262 263 314 313 + 263 264 315 314 264 265 316 315 265 266 317 316 + 266 267 318 317 267 268 319 318 268 269 320 319 + 269 270 321 320 270 271 322 321 271 272 323 322 + 272 273 324 323 273 274 325 324 274 275 326 325 + 275 276 327 326 276 277 328 327 277 278 329 328 + 278 279 330 329 279 280 331 330 280 281 332 331 + 281 282 333 332 282 283 334 333 283 284 335 334 + 284 285 336 335 285 286 337 336 286 287 338 337 + 287 288 339 338 288 289 340 339 289 290 341 340 + 290 291 342 341 291 292 343 342 292 293 344 343 + 293 294 345 344 294 295 346 345 295 296 347 346 + 296 297 348 347 297 298 349 348 298 299 350 349 + 299 300 351 350 300 301 352 351 301 302 353 352 + 302 303 354 353 303 304 355 354 304 305 356 355 + 306 307 358 357 307 308 359 358 308 309 360 359 + 309 310 361 360 310 311 362 361 311 312 363 362 + 312 313 364 363 313 314 365 364 314 315 366 365 + 315 316 367 366 316 317 368 367 317 318 369 368 + 318 319 370 369 319 320 371 370 320 321 372 371 + 321 322 373 372 322 323 374 373 323 324 375 374 + 324 325 376 375 325 326 377 376 326 327 378 377 + 327 328 379 378 328 329 380 379 329 330 381 380 + 330 331 382 381 331 332 383 382 332 333 384 383 + 333 334 385 384 334 335 386 385 335 336 387 386 + 336 337 388 387 337 338 389 388 338 339 390 389 + 339 340 391 390 340 341 392 391 341 342 393 392 + 342 343 394 393 343 344 395 394 344 345 396 395 + 345 346 397 396 346 347 398 397 347 348 399 398 + 348 349 400 399 349 350 401 400 350 351 402 401 + 351 352 403 402 352 353 404 403 353 354 405 404 + 354 355 406 405 355 356 407 406 357 358 409 408 + 358 359 410 409 359 360 411 410 360 361 412 411 + 361 362 413 412 362 363 414 413 363 364 415 414 + 364 365 416 415 365 366 417 416 366 367 418 417 + 367 368 419 418 368 369 420 419 369 370 421 420 + 370 371 422 421 371 372 423 422 372 373 424 423 + 373 374 425 424 374 375 426 425 375 376 427 426 + 376 377 428 427 377 378 429 428 378 379 430 429 + 379 380 431 430 380 381 432 431 381 382 433 432 + 382 383 434 433 383 384 435 434 384 385 436 435 + 385 386 437 436 386 387 438 437 387 388 439 438 + 388 389 440 439 389 390 441 440 390 391 442 441 + 391 392 443 442 392 393 444 443 393 394 445 444 + 394 395 446 445 395 396 447 446 396 397 448 447 + 397 398 449 448 398 399 450 449 399 400 451 450 + 400 401 452 451 401 402 453 452 402 403 454 453 + 403 404 455 454 404 405 456 455 405 406 457 456 + 406 407 458 457 408 409 460 459 409 410 461 460 + 410 411 462 461 411 412 463 462 412 413 464 463 + 413 414 465 464 414 415 466 465 415 416 467 466 + 416 417 468 467 417 418 469 468 418 419 470 469 + 419 420 471 470 420 421 472 471 421 422 473 472 + 422 423 474 473 423 424 475 474 424 425 476 475 + 425 426 477 476 426 427 478 477 427 428 479 478 + 428 429 480 479 429 430 481 480 430 431 482 481 + 431 432 483 482 432 433 484 483 433 434 485 484 + 434 435 486 485 435 436 487 486 436 437 488 487 + 437 438 489 488 438 439 490 489 439 440 491 490 + 440 441 492 491 441 442 493 492 442 443 494 493 + 443 444 495 494 444 445 496 495 445 446 497 496 + 446 447 498 497 447 448 499 498 448 449 500 499 + 449 450 501 500 450 451 502 501 451 452 503 502 + 452 453 504 503 453 454 505 504 454 455 506 505 + 455 456 507 506 456 457 508 507 457 458 509 508 + 459 460 511 510 460 461 512 511 461 462 513 512 + 462 463 514 513 463 464 515 514 464 465 516 515 + 465 466 517 516 466 467 518 517 467 468 519 518 + 468 469 520 519 469 470 521 520 470 471 522 521 + 471 472 523 522 472 473 524 523 473 474 525 524 + 474 475 526 525 475 476 527 526 476 477 528 527 + 477 478 529 528 478 479 530 529 479 480 531 530 + 480 481 532 531 481 482 533 532 482 483 534 533 + 483 484 535 534 484 485 536 535 485 486 537 536 + 486 487 538 537 487 488 539 538 488 489 540 539 + 489 490 541 540 490 491 542 541 491 492 543 542 + 492 493 544 543 493 494 545 544 494 495 546 545 + 495 496 547 546 496 497 548 547 497 498 549 548 + 498 499 550 549 499 500 551 550 500 501 552 551 + 501 502 553 552 502 503 554 553 503 504 555 554 + 504 505 556 555 505 506 557 556 506 507 558 557 + 507 508 559 558 508 509 560 559 510 511 562 561 + 511 512 563 562 512 513 564 563 513 514 565 564 + 514 515 566 565 515 516 567 566 516 517 568 567 + 517 518 569 568 518 519 570 569 519 520 571 570 + 520 521 572 571 521 522 573 572 522 523 574 573 + 523 524 575 574 524 525 576 575 525 526 577 576 + 526 527 578 577 527 528 579 578 528 529 580 579 + 529 530 581 580 530 531 582 581 531 532 583 582 + 532 533 584 583 533 534 585 584 534 535 586 585 + 535 536 587 586 536 537 588 587 537 538 589 588 + 538 539 590 589 539 540 591 590 540 541 592 591 + 541 542 593 592 542 543 594 593 543 544 595 594 + 544 545 596 595 545 546 597 596 546 547 598 597 + 547 548 599 598 548 549 600 599 549 550 601 600 + 550 551 602 601 551 552 603 602 552 553 604 603 + 553 554 605 604 554 555 606 605 555 556 607 606 + 556 557 608 607 557 558 609 608 558 559 610 609 + 559 560 611 610 561 562 613 612 562 563 614 613 + 563 564 615 614 564 565 616 615 565 566 617 616 + 566 567 618 617 567 568 619 618 568 569 620 619 + 569 570 621 620 570 571 622 621 571 572 623 622 + 572 573 624 623 573 574 625 624 574 575 626 625 + 575 576 627 626 576 577 628 627 577 578 629 628 + 578 579 630 629 579 580 631 630 580 581 632 631 + 581 582 633 632 582 583 634 633 583 584 635 634 + 584 585 636 635 585 586 637 636 586 587 638 637 + 587 588 639 638 588 589 640 639 589 590 641 640 + 590 591 642 641 591 592 643 642 592 593 644 643 + 593 594 645 644 594 595 646 645 595 596 647 646 + 596 597 648 647 597 598 649 648 598 599 650 649 + 599 600 651 650 600 601 652 651 601 602 653 652 + 602 603 654 653 603 604 655 654 604 605 656 655 + 605 606 657 656 606 607 658 657 607 608 659 658 + 608 609 660 659 609 610 661 660 610 611 662 661 + 612 613 664 663 613 614 665 664 614 615 666 665 + 615 616 667 666 616 617 668 667 617 618 669 668 + 618 619 670 669 619 620 671 670 620 621 672 671 + 621 622 673 672 622 623 674 673 623 624 675 674 + 624 625 676 675 625 626 677 676 626 627 678 677 + 627 628 679 678 628 629 680 679 629 630 681 680 + 630 631 682 681 631 632 683 682 632 633 684 683 + 633 634 685 684 634 635 686 685 635 636 687 686 + 636 637 688 687 637 638 689 688 638 639 690 689 + 639 640 691 690 640 641 692 691 641 642 693 692 + 642 643 694 693 643 644 695 694 644 645 696 695 + 645 646 697 696 646 647 698 697 647 648 699 698 + 648 649 700 699 649 650 701 700 650 651 702 701 + 651 652 703 702 652 653 704 703 653 654 705 704 + 654 655 706 705 655 656 707 706 656 657 708 707 + 657 658 709 708 658 659 710 709 659 660 711 710 + 660 661 712 711 661 662 713 712 663 664 715 714 + 664 665 716 715 665 666 717 716 666 667 718 717 + 667 668 719 718 668 669 720 719 669 670 721 720 + 670 671 722 721 671 672 723 722 672 673 724 723 + 673 674 725 724 674 675 726 725 675 676 727 726 + 676 677 728 727 677 678 729 728 678 679 730 729 + 679 680 731 730 680 681 732 731 681 682 733 732 + 682 683 734 733 683 684 735 734 684 685 736 735 + 685 686 737 736 686 687 738 737 687 688 739 738 + 688 689 740 739 689 690 741 740 690 691 742 741 + 691 692 743 742 692 693 744 743 693 694 745 744 + 694 695 746 745 695 696 747 746 696 697 748 747 + 697 698 749 748 698 699 750 749 699 700 751 750 + 700 701 752 751 701 702 753 752 702 703 754 753 + 703 704 755 754 704 705 756 755 705 706 757 756 + 706 707 758 757 707 708 759 758 708 709 760 759 + 709 710 761 760 710 711 762 761 711 712 763 762 + 712 713 764 763 714 715 766 765 715 716 767 766 + 716 717 768 767 717 718 769 768 718 719 770 769 + 719 720 771 770 720 721 772 771 721 722 773 772 + 722 723 774 773 723 724 775 774 724 725 776 775 + 725 726 777 776 726 727 778 777 727 728 779 778 + 728 729 780 779 729 730 781 780 730 731 782 781 + 731 732 783 782 732 733 784 783 733 734 785 784 + 734 735 786 785 735 736 787 786 736 737 788 787 + 737 738 789 788 738 739 790 789 739 740 791 790 + 740 741 792 791 741 742 793 792 742 743 794 793 + 743 744 795 794 744 745 796 795 745 746 797 796 + 746 747 798 797 747 748 799 798 748 749 800 799 + 749 750 801 800 750 751 802 801 751 752 803 802 + 752 753 804 803 753 754 805 804 754 755 806 805 + 755 756 807 806 756 757 808 807 757 758 809 808 + 758 759 810 809 759 760 811 810 760 761 812 811 + 761 762 813 812 762 763 814 813 763 764 815 814 + 765 766 817 816 766 767 818 817 767 768 819 818 + 768 769 820 819 769 770 821 820 770 771 822 821 + 771 772 823 822 772 773 824 823 773 774 825 824 + 774 775 826 825 775 776 827 826 776 777 828 827 + 777 778 829 828 778 779 830 829 779 780 831 830 + 780 781 832 831 781 782 833 832 782 783 834 833 + 783 784 835 834 784 785 836 835 785 786 837 836 + 786 787 838 837 787 788 839 838 788 789 840 839 + 789 790 841 840 790 791 842 841 791 792 843 842 + 792 793 844 843 793 794 845 844 794 795 846 845 + 795 796 847 846 796 797 848 847 797 798 849 848 + 798 799 850 849 799 800 851 850 800 801 852 851 + 801 802 853 852 802 803 854 853 803 804 855 854 + 804 805 856 855 805 806 857 856 806 807 858 857 + 807 808 859 858 808 809 860 859 809 810 861 860 + 810 811 862 861 811 812 863 862 812 813 864 863 + 813 814 865 864 814 815 866 865 816 817 868 867 + 817 818 869 868 818 819 870 869 819 820 871 870 + 820 821 872 871 821 822 873 872 822 823 874 873 + 823 824 875 874 824 825 876 875 825 826 877 876 + 826 827 878 877 827 828 879 878 828 829 880 879 + 829 830 881 880 830 831 882 881 831 832 883 882 + 832 833 884 883 833 834 885 884 834 835 886 885 + 835 836 887 886 836 837 888 887 837 838 889 888 + 838 839 890 889 839 840 891 890 840 841 892 891 + 841 842 893 892 842 843 894 893 843 844 895 894 + 844 845 896 895 845 846 897 896 846 847 898 897 + 847 848 899 898 848 849 900 899 849 850 901 900 + 850 851 902 901 851 852 903 902 852 853 904 903 + 853 854 905 904 854 855 906 905 855 856 907 906 + 856 857 908 907 857 858 909 908 858 859 910 909 + 859 860 911 910 860 861 912 911 861 862 913 912 + 862 863 914 913 863 864 915 914 864 865 916 915 + 865 866 917 916 867 868 919 918 868 869 920 919 + 869 870 921 920 870 871 922 921 871 872 923 922 + 872 873 924 923 873 874 925 924 874 875 926 925 + 875 876 927 926 876 877 928 927 877 878 929 928 + 878 879 930 929 879 880 931 930 880 881 932 931 + 881 882 933 932 882 883 934 933 883 884 935 934 + 884 885 936 935 885 886 937 936 886 887 938 937 + 887 888 939 938 888 889 940 939 889 890 941 940 + 890 891 942 941 891 892 943 942 892 893 944 943 + 893 894 945 944 894 895 946 945 895 896 947 946 + 896 897 948 947 897 898 949 948 898 899 950 949 + 899 900 951 950 900 901 952 951 901 902 953 952 + 902 903 954 953 903 904 955 954 904 905 956 955 + 905 906 957 956 906 907 958 957 907 908 959 958 + 908 909 960 959 909 910 961 960 910 911 962 961 + 911 912 963 962 912 913 964 963 913 914 965 964 + 914 915 966 965 915 916 967 966 916 917 968 967 + 918 919 970 969 919 920 971 970 920 921 972 971 + 921 922 973 972 922 923 974 973 923 924 975 974 + 924 925 976 975 925 926 977 976 926 927 978 977 + 927 928 979 978 928 929 980 979 929 930 981 980 + 930 931 982 981 931 932 983 982 932 933 984 983 + 933 934 985 984 934 935 986 985 935 936 987 986 + 936 937 988 987 937 938 989 988 938 939 990 989 + 939 940 991 990 940 941 992 991 941 942 993 992 + 942 943 994 993 943 944 995 994 944 945 996 995 + 945 946 997 996 946 947 998 997 947 948 999 998 + 948 949 1000 999 949 950 1001 1000 950 951 1002 1001 + 951 952 1003 1002 952 953 1004 1003 953 954 1005 1004 + 954 955 1006 1005 955 956 1007 1006 956 957 1008 1007 + 957 958 1009 1008 958 959 1010 1009 959 960 1011 1010 + 960 961 1012 1011 961 962 1013 1012 962 963 1014 1013 + 963 964 1015 1014 964 965 1016 1015 965 966 1017 1016 + 966 967 1018 1017 967 968 1019 1018 969 970 1021 1020 + 970 971 1022 1021 971 972 1023 1022 972 973 1024 1023 + 973 974 1025 1024 974 975 1026 1025 975 976 1027 1026 + 976 977 1028 1027 977 978 1029 1028 978 979 1030 1029 + 979 980 1031 1030 980 981 1032 1031 981 982 1033 1032 + 982 983 1034 1033 983 984 1035 1034 984 985 1036 1035 + 985 986 1037 1036 986 987 1038 1037 987 988 1039 1038 + 988 989 1040 1039 989 990 1041 1040 990 991 1042 1041 + 991 992 1043 1042 992 993 1044 1043 993 994 1045 1044 + 994 995 1046 1045 995 996 1047 1046 996 997 1048 1047 + 997 998 1049 1048 998 999 1050 1049 999 1000 1051 1050 + 1000 1001 1052 1051 1001 1002 1053 1052 1002 1003 1054 1053 + 1003 1004 1055 1054 1004 1005 1056 1055 1005 1006 1057 1056 + 1006 1007 1058 1057 1007 1008 1059 1058 1008 1009 1060 1059 + 1009 1010 1061 1060 1010 1011 1062 1061 1011 1012 1063 1062 + 1012 1013 1064 1063 1013 1014 1065 1064 1014 1015 1066 1065 + 1015 1016 1067 1066 1016 1017 1068 1067 1017 1018 1069 1068 + 1018 1019 1070 1069 1020 1021 1072 1071 1021 1022 1073 1072 + 1022 1023 1074 1073 1023 1024 1075 1074 1024 1025 1076 1075 + 1025 1026 1077 1076 1026 1027 1078 1077 1027 1028 1079 1078 + 1028 1029 1080 1079 1029 1030 1081 1080 1030 1031 1082 1081 + 1031 1032 1083 1082 1032 1033 1084 1083 1033 1034 1085 1084 + 1034 1035 1086 1085 1035 1036 1087 1086 1036 1037 1088 1087 + 1037 1038 1089 1088 1038 1039 1090 1089 1039 1040 1091 1090 + 1040 1041 1092 1091 1041 1042 1093 1092 1042 1043 1094 1093 + 1043 1044 1095 1094 1044 1045 1096 1095 1045 1046 1097 1096 + 1046 1047 1098 1097 1047 1048 1099 1098 1048 1049 1100 1099 + 1049 1050 1101 1100 1050 1051 1102 1101 1051 1052 1103 1102 + 1052 1053 1104 1103 1053 1054 1105 1104 1054 1055 1106 1105 + 1055 1056 1107 1106 1056 1057 1108 1107 1057 1058 1109 1108 + 1058 1059 1110 1109 1059 1060 1111 1110 1060 1061 1112 1111 + 1061 1062 1113 1112 1062 1063 1114 1113 1063 1064 1115 1114 + 1064 1065 1116 1115 1065 1066 1117 1116 1066 1067 1118 1117 + 1067 1068 1119 1118 1068 1069 1120 1119 1069 1070 1121 1120 + 1071 1072 1123 1122 1072 1073 1124 1123 1073 1074 1125 1124 + 1074 1075 1126 1125 1075 1076 1127 1126 1076 1077 1128 1127 + 1077 1078 1129 1128 1078 1079 1130 1129 1079 1080 1131 1130 + 1080 1081 1132 1131 1081 1082 1133 1132 1082 1083 1134 1133 + 1083 1084 1135 1134 1084 1085 1136 1135 1085 1086 1137 1136 + 1086 1087 1138 1137 1087 1088 1139 1138 1088 1089 1140 1139 + 1089 1090 1141 1140 1090 1091 1142 1141 1091 1092 1143 1142 + 1092 1093 1144 1143 1093 1094 1145 1144 1094 1095 1146 1145 + 1095 1096 1147 1146 1096 1097 1148 1147 1097 1098 1149 1148 + 1098 1099 1150 1149 1099 1100 1151 1150 1100 1101 1152 1151 + 1101 1102 1153 1152 1102 1103 1154 1153 1103 1104 1155 1154 + 1104 1105 1156 1155 1105 1106 1157 1156 1106 1107 1158 1157 + 1107 1108 1159 1158 1108 1109 1160 1159 1109 1110 1161 1160 + 1110 1111 1162 1161 1111 1112 1163 1162 1112 1113 1164 1163 + 1113 1114 1165 1164 1114 1115 1166 1165 1115 1116 1167 1166 + 1116 1117 1168 1167 1117 1118 1169 1168 1118 1119 1170 1169 + 1119 1120 1171 1170 1120 1121 1172 1171 1122 1123 1174 1173 + 1123 1124 1175 1174 1124 1125 1176 1175 1125 1126 1177 1176 + 1126 1127 1178 1177 1127 1128 1179 1178 1128 1129 1180 1179 + 1129 1130 1181 1180 1130 1131 1182 1181 1131 1132 1183 1182 + 1132 1133 1184 1183 1133 1134 1185 1184 1134 1135 1186 1185 + 1135 1136 1187 1186 1136 1137 1188 1187 1137 1138 1189 1188 + 1138 1139 1190 1189 1139 1140 1191 1190 1140 1141 1192 1191 + 1141 1142 1193 1192 1142 1143 1194 1193 1143 1144 1195 1194 + 1144 1145 1196 1195 1145 1146 1197 1196 1146 1147 1198 1197 + 1147 1148 1199 1198 1148 1149 1200 1199 1149 1150 1201 1200 + 1150 1151 1202 1201 1151 1152 1203 1202 1152 1153 1204 1203 + 1153 1154 1205 1204 1154 1155 1206 1205 1155 1156 1207 1206 + 1156 1157 1208 1207 1157 1158 1209 1208 1158 1159 1210 1209 + 1159 1160 1211 1210 1160 1161 1212 1211 1161 1162 1213 1212 + 1162 1163 1214 1213 1163 1164 1215 1214 1164 1165 1216 1215 + 1165 1166 1217 1216 1166 1167 1218 1217 1167 1168 1219 1218 + 1168 1169 1220 1219 1169 1170 1221 1220 1170 1171 1222 1221 + 1171 1172 1223 1222 1173 1174 1225 1224 1174 1175 1226 1225 + 1175 1176 1227 1226 1176 1177 1228 1227 1177 1178 1229 1228 + 1178 1179 1230 1229 1179 1180 1231 1230 1180 1181 1232 1231 + 1181 1182 1233 1232 1182 1183 1234 1233 1183 1184 1235 1234 + 1184 1185 1236 1235 1185 1186 1237 1236 1186 1187 1238 1237 + 1187 1188 1239 1238 1188 1189 1240 1239 1189 1190 1241 1240 + 1190 1191 1242 1241 1191 1192 1243 1242 1192 1193 1244 1243 + 1193 1194 1245 1244 1194 1195 1246 1245 1195 1196 1247 1246 + 1196 1197 1248 1247 1197 1198 1249 1248 1198 1199 1250 1249 + 1199 1200 1251 1250 1200 1201 1252 1251 1201 1202 1253 1252 + 1202 1203 1254 1253 1203 1204 1255 1254 1204 1205 1256 1255 + 1205 1206 1257 1256 1206 1207 1258 1257 1207 1208 1259 1258 + 1208 1209 1260 1259 1209 1210 1261 1260 1210 1211 1262 1261 + 1211 1212 1263 1262 1212 1213 1264 1263 1213 1214 1265 1264 + 1214 1215 1266 1265 1215 1216 1267 1266 1216 1217 1268 1267 + 1217 1218 1269 1268 1218 1219 1270 1269 1219 1220 1271 1270 + 1220 1221 1272 1271 1221 1222 1273 1272 1222 1223 1274 1273 + 1224 1225 1276 1275 1225 1226 1277 1276 1226 1227 1278 1277 + 1227 1228 1279 1278 1228 1229 1280 1279 1229 1230 1281 1280 + 1230 1231 1282 1281 1231 1232 1283 1282 1232 1233 1284 1283 + 1233 1234 1285 1284 1234 1235 1286 1285 1235 1236 1287 1286 + 1236 1237 1288 1287 1237 1238 1289 1288 1238 1239 1290 1289 + 1239 1240 1291 1290 1240 1241 1292 1291 1241 1242 1293 1292 + 1242 1243 1294 1293 1243 1244 1295 1294 1244 1245 1296 1295 + 1245 1246 1297 1296 1246 1247 1298 1297 1247 1248 1299 1298 + 1248 1249 1300 1299 1249 1250 1301 1300 1250 1251 1302 1301 + 1251 1252 1303 1302 1252 1253 1304 1303 1253 1254 1305 1304 + 1254 1255 1306 1305 1255 1256 1307 1306 1256 1257 1308 1307 + 1257 1258 1309 1308 1258 1259 1310 1309 1259 1260 1311 1310 + 1260 1261 1312 1311 1261 1262 1313 1312 1262 1263 1314 1313 + 1263 1264 1315 1314 1264 1265 1316 1315 1265 1266 1317 1316 + 1266 1267 1318 1317 1267 1268 1319 1318 1268 1269 1320 1319 + 1269 1270 1321 1320 1270 1271 1322 1321 1271 1272 1323 1322 + 1272 1273 1324 1323 1273 1274 1325 1324 1275 1276 1327 1326 + 1276 1277 1328 1327 1277 1278 1329 1328 1278 1279 1330 1329 + 1279 1280 1331 1330 1280 1281 1332 1331 1281 1282 1333 1332 + 1282 1283 1334 1333 1283 1284 1335 1334 1284 1285 1336 1335 + 1285 1286 1337 1336 1286 1287 1338 1337 1287 1288 1339 1338 + 1288 1289 1340 1339 1289 1290 1341 1340 1290 1291 1342 1341 + 1291 1292 1343 1342 1292 1293 1344 1343 1293 1294 1345 1344 + 1294 1295 1346 1345 1295 1296 1347 1346 1296 1297 1348 1347 + 1297 1298 1349 1348 1298 1299 1350 1349 1299 1300 1351 1350 + 1300 1301 1352 1351 1301 1302 1353 1352 1302 1303 1354 1353 + 1303 1304 1355 1354 1304 1305 1356 1355 1305 1306 1357 1356 + 1306 1307 1358 1357 1307 1308 1359 1358 1308 1309 1360 1359 + 1309 1310 1361 1360 1310 1311 1362 1361 1311 1312 1363 1362 + 1312 1313 1364 1363 1313 1314 1365 1364 1314 1315 1366 1365 + 1315 1316 1367 1366 1316 1317 1368 1367 1317 1318 1369 1368 + 1318 1319 1370 1369 1319 1320 1371 1370 1320 1321 1372 1371 + 1321 1322 1373 1372 1322 1323 1374 1373 1323 1324 1375 1374 + 1324 1325 1376 1375 1326 1327 1378 1377 1327 1328 1379 1378 + 1328 1329 1380 1379 1329 1330 1381 1380 1330 1331 1382 1381 + 1331 1332 1383 1382 1332 1333 1384 1383 1333 1334 1385 1384 + 1334 1335 1386 1385 1335 1336 1387 1386 1336 1337 1388 1387 + 1337 1338 1389 1388 1338 1339 1390 1389 1339 1340 1391 1390 + 1340 1341 1392 1391 1341 1342 1393 1392 1342 1343 1394 1393 + 1343 1344 1395 1394 1344 1345 1396 1395 1345 1346 1397 1396 + 1346 1347 1398 1397 1347 1348 1399 1398 1348 1349 1400 1399 + 1349 1350 1401 1400 1350 1351 1402 1401 1351 1352 1403 1402 + 1352 1353 1404 1403 1353 1354 1405 1404 1354 1355 1406 1405 + 1355 1356 1407 1406 1356 1357 1408 1407 1357 1358 1409 1408 + 1358 1359 1410 1409 1359 1360 1411 1410 1360 1361 1412 1411 + 1361 1362 1413 1412 1362 1363 1414 1413 1363 1364 1415 1414 + 1364 1365 1416 1415 1365 1366 1417 1416 1366 1367 1418 1417 + 1367 1368 1419 1418 1368 1369 1420 1419 1369 1370 1421 1420 + 1370 1371 1422 1421 1371 1372 1423 1422 1372 1373 1424 1423 + 1373 1374 1425 1424 1374 1375 1426 1425 1375 1376 1427 1426 + 1377 1378 1429 1428 1378 1379 1430 1429 1379 1380 1431 1430 + 1380 1381 1432 1431 1381 1382 1433 1432 1382 1383 1434 1433 + 1383 1384 1435 1434 1384 1385 1436 1435 1385 1386 1437 1436 + 1386 1387 1438 1437 1387 1388 1439 1438 1388 1389 1440 1439 + 1389 1390 1441 1440 1390 1391 1442 1441 1391 1392 1443 1442 + 1392 1393 1444 1443 1393 1394 1445 1444 1394 1395 1446 1445 + 1395 1396 1447 1446 1396 1397 1448 1447 1397 1398 1449 1448 + 1398 1399 1450 1449 1399 1400 1451 1450 1400 1401 1452 1451 + 1401 1402 1453 1452 1402 1403 1454 1453 1403 1404 1455 1454 + 1404 1405 1456 1455 1405 1406 1457 1456 1406 1407 1458 1457 + 1407 1408 1459 1458 1408 1409 1460 1459 1409 1410 1461 1460 + 1410 1411 1462 1461 1411 1412 1463 1462 1412 1413 1464 1463 + 1413 1414 1465 1464 1414 1415 1466 1465 1415 1416 1467 1466 + 1416 1417 1468 1467 1417 1418 1469 1468 1418 1419 1470 1469 + 1419 1420 1471 1470 1420 1421 1472 1471 1421 1422 1473 1472 + 1422 1423 1474 1473 1423 1424 1475 1474 1424 1425 1476 1475 + 1425 1426 1477 1476 1426 1427 1478 1477 1428 1429 1480 1479 + 1429 1430 1481 1480 1430 1431 1482 1481 1431 1432 1483 1482 + 1432 1433 1484 1483 1433 1434 1485 1484 1434 1435 1486 1485 + 1435 1436 1487 1486 1436 1437 1488 1487 1437 1438 1489 1488 + 1438 1439 1490 1489 1439 1440 1491 1490 1440 1441 1492 1491 + 1441 1442 1493 1492 1442 1443 1494 1493 1443 1444 1495 1494 + 1444 1445 1496 1495 1445 1446 1497 1496 1446 1447 1498 1497 + 1447 1448 1499 1498 1448 1449 1500 1499 1449 1450 1501 1500 + 1450 1451 1502 1501 1451 1452 1503 1502 1452 1453 1504 1503 + 1453 1454 1505 1504 1454 1455 1506 1505 1455 1456 1507 1506 + 1456 1457 1508 1507 1457 1458 1509 1508 1458 1459 1510 1509 + 1459 1460 1511 1510 1460 1461 1512 1511 1461 1462 1513 1512 + 1462 1463 1514 1513 1463 1464 1515 1514 1464 1465 1516 1515 + 1465 1466 1517 1516 1466 1467 1518 1517 1467 1468 1519 1518 + 1468 1469 1520 1519 1469 1470 1521 1520 1470 1471 1522 1521 + 1471 1472 1523 1522 1472 1473 1524 1523 1473 1474 1525 1524 + 1474 1475 1526 1525 1475 1476 1527 1526 1476 1477 1528 1527 + 1477 1478 1529 1528 1479 1480 1531 1530 1480 1481 1532 1531 + 1481 1482 1533 1532 1482 1483 1534 1533 1483 1484 1535 1534 + 1484 1485 1536 1535 1485 1486 1537 1536 1486 1487 1538 1537 + 1487 1488 1539 1538 1488 1489 1540 1539 1489 1490 1541 1540 + 1490 1491 1542 1541 1491 1492 1543 1542 1492 1493 1544 1543 + 1493 1494 1545 1544 1494 1495 1546 1545 1495 1496 1547 1546 + 1496 1497 1548 1547 1497 1498 1549 1548 1498 1499 1550 1549 + 1499 1500 1551 1550 1500 1501 1552 1551 1501 1502 1553 1552 + 1502 1503 1554 1553 1503 1504 1555 1554 1504 1505 1556 1555 + 1505 1506 1557 1556 1506 1507 1558 1557 1507 1508 1559 1558 + 1508 1509 1560 1559 1509 1510 1561 1560 1510 1511 1562 1561 + 1511 1512 1563 1562 1512 1513 1564 1563 1513 1514 1565 1564 + 1514 1515 1566 1565 1515 1516 1567 1566 1516 1517 1568 1567 + 1517 1518 1569 1568 1518 1519 1570 1569 1519 1520 1571 1570 + 1520 1521 1572 1571 1521 1522 1573 1572 1522 1523 1574 1573 + 1523 1524 1575 1574 1524 1525 1576 1575 1525 1526 1577 1576 + 1526 1527 1578 1577 1527 1528 1579 1578 1528 1529 1580 1579 + 1530 1531 1582 1581 1531 1532 1583 1582 1532 1533 1584 1583 + 1533 1534 1585 1584 1534 1535 1586 1585 1535 1536 1587 1586 + 1536 1537 1588 1587 1537 1538 1589 1588 1538 1539 1590 1589 + 1539 1540 1591 1590 1540 1541 1592 1591 1541 1542 1593 1592 + 1542 1543 1594 1593 1543 1544 1595 1594 1544 1545 1596 1595 + 1545 1546 1597 1596 1546 1547 1598 1597 1547 1548 1599 1598 + 1548 1549 1600 1599 1549 1550 1601 1600 1550 1551 1602 1601 + 1551 1552 1603 1602 1552 1553 1604 1603 1553 1554 1605 1604 + 1554 1555 1606 1605 1555 1556 1607 1606 1556 1557 1608 1607 + 1557 1558 1609 1608 1558 1559 1610 1609 1559 1560 1611 1610 + 1560 1561 1612 1611 1561 1562 1613 1612 1562 1563 1614 1613 + 1563 1564 1615 1614 1564 1565 1616 1615 1565 1566 1617 1616 + 1566 1567 1618 1617 1567 1568 1619 1618 1568 1569 1620 1619 + 1569 1570 1621 1620 1570 1571 1622 1621 1571 1572 1623 1622 + 1572 1573 1624 1623 1573 1574 1625 1624 1574 1575 1626 1625 + 1575 1576 1627 1626 1576 1577 1628 1627 1577 1578 1629 1628 + 1578 1579 1630 1629 1579 1580 1631 1630 1581 1582 1633 1632 + 1582 1583 1634 1633 1583 1584 1635 1634 1584 1585 1636 1635 + 1585 1586 1637 1636 1586 1587 1638 1637 1587 1588 1639 1638 + 1588 1589 1640 1639 1589 1590 1641 1640 1590 1591 1642 1641 + 1591 1592 1643 1642 1592 1593 1644 1643 1593 1594 1645 1644 + 1594 1595 1646 1645 1595 1596 1647 1646 1596 1597 1648 1647 + 1597 1598 1649 1648 1598 1599 1650 1649 1599 1600 1651 1650 + 1600 1601 1652 1651 1601 1602 1653 1652 1602 1603 1654 1653 + 1603 1604 1655 1654 1604 1605 1656 1655 1605 1606 1657 1656 + 1606 1607 1658 1657 1607 1608 1659 1658 1608 1609 1660 1659 + 1609 1610 1661 1660 1610 1611 1662 1661 1611 1612 1663 1662 + 1612 1613 1664 1663 1613 1614 1665 1664 1614 1615 1666 1665 + 1615 1616 1667 1666 1616 1617 1668 1667 1617 1618 1669 1668 + 1618 1619 1670 1669 1619 1620 1671 1670 1620 1621 1672 1671 + 1621 1622 1673 1672 1622 1623 1674 1673 1623 1624 1675 1674 + 1624 1625 1676 1675 1625 1626 1677 1676 1626 1627 1678 1677 + 1627 1628 1679 1678 1628 1629 1680 1679 1629 1630 1681 1680 + 1630 1631 1682 1681 1632 1633 1684 1683 1633 1634 1685 1684 + 1634 1635 1686 1685 1635 1636 1687 1686 1636 1637 1688 1687 + 1637 1638 1689 1688 1638 1639 1690 1689 1639 1640 1691 1690 + 1640 1641 1692 1691 1641 1642 1693 1692 1642 1643 1694 1693 + 1643 1644 1695 1694 1644 1645 1696 1695 1645 1646 1697 1696 + 1646 1647 1698 1697 1647 1648 1699 1698 1648 1649 1700 1699 + 1649 1650 1701 1700 1650 1651 1702 1701 1651 1652 1703 1702 + 1652 1653 1704 1703 1653 1654 1705 1704 1654 1655 1706 1705 + 1655 1656 1707 1706 1656 1657 1708 1707 1657 1658 1709 1708 + 1658 1659 1710 1709 1659 1660 1711 1710 1660 1661 1712 1711 + 1661 1662 1713 1712 1662 1663 1714 1713 1663 1664 1715 1714 + 1664 1665 1716 1715 1665 1666 1717 1716 1666 1667 1718 1717 + 1667 1668 1719 1718 1668 1669 1720 1719 1669 1670 1721 1720 + 1670 1671 1722 1721 1671 1672 1723 1722 1672 1673 1724 1723 + 1673 1674 1725 1724 1674 1675 1726 1725 1675 1676 1727 1726 + 1676 1677 1728 1727 1677 1678 1729 1728 1678 1679 1730 1729 + 1679 1680 1731 1730 1680 1681 1732 1731 1681 1682 1733 1732 + 1683 1684 1735 1734 1684 1685 1736 1735 1685 1686 1737 1736 + 1686 1687 1738 1737 1687 1688 1739 1738 1688 1689 1740 1739 + 1689 1690 1741 1740 1690 1691 1742 1741 1691 1692 1743 1742 + 1692 1693 1744 1743 1693 1694 1745 1744 1694 1695 1746 1745 + 1695 1696 1747 1746 1696 1697 1748 1747 1697 1698 1749 1748 + 1698 1699 1750 1749 1699 1700 1751 1750 1700 1701 1752 1751 + 1701 1702 1753 1752 1702 1703 1754 1753 1703 1704 1755 1754 + 1704 1705 1756 1755 1705 1706 1757 1756 1706 1707 1758 1757 + 1707 1708 1759 1758 1708 1709 1760 1759 1709 1710 1761 1760 + 1710 1711 1762 1761 1711 1712 1763 1762 1712 1713 1764 1763 + 1713 1714 1765 1764 1714 1715 1766 1765 1715 1716 1767 1766 + 1716 1717 1768 1767 1717 1718 1769 1768 1718 1719 1770 1769 + 1719 1720 1771 1770 1720 1721 1772 1771 1721 1722 1773 1772 + 1722 1723 1774 1773 1723 1724 1775 1774 1724 1725 1776 1775 + 1725 1726 1777 1776 1726 1727 1778 1777 1727 1728 1779 1778 + 1728 1729 1780 1779 1729 1730 1781 1780 1730 1731 1782 1781 + 1731 1732 1783 1782 1732 1733 1784 1783 1734 1735 1786 1785 + 1735 1736 1787 1786 1736 1737 1788 1787 1737 1738 1789 1788 + 1738 1739 1790 1789 1739 1740 1791 1790 1740 1741 1792 1791 + 1741 1742 1793 1792 1742 1743 1794 1793 1743 1744 1795 1794 + 1744 1745 1796 1795 1745 1746 1797 1796 1746 1747 1798 1797 + 1747 1748 1799 1798 1748 1749 1800 1799 1749 1750 1801 1800 + 1750 1751 1802 1801 1751 1752 1803 1802 1752 1753 1804 1803 + 1753 1754 1805 1804 1754 1755 1806 1805 1755 1756 1807 1806 + 1756 1757 1808 1807 1757 1758 1809 1808 1758 1759 1810 1809 + 1759 1760 1811 1810 1760 1761 1812 1811 1761 1762 1813 1812 + 1762 1763 1814 1813 1763 1764 1815 1814 1764 1765 1816 1815 + 1765 1766 1817 1816 1766 1767 1818 1817 1767 1768 1819 1818 + 1768 1769 1820 1819 1769 1770 1821 1820 1770 1771 1822 1821 + 1771 1772 1823 1822 1772 1773 1824 1823 1773 1774 1825 1824 + 1774 1775 1826 1825 1775 1776 1827 1826 1776 1777 1828 1827 + 1777 1778 1829 1828 1778 1779 1830 1829 1779 1780 1831 1830 + 1780 1781 1832 1831 1781 1782 1833 1832 1782 1783 1834 1833 + 1783 1784 1835 1834 1785 1786 1837 1836 1786 1787 1838 1837 + 1787 1788 1839 1838 1788 1789 1840 1839 1789 1790 1841 1840 + 1790 1791 1842 1841 1791 1792 1843 1842 1792 1793 1844 1843 + 1793 1794 1845 1844 1794 1795 1846 1845 1795 1796 1847 1846 + 1796 1797 1848 1847 1797 1798 1849 1848 1798 1799 1850 1849 + 1799 1800 1851 1850 1800 1801 1852 1851 1801 1802 1853 1852 + 1802 1803 1854 1853 1803 1804 1855 1854 1804 1805 1856 1855 + 1805 1806 1857 1856 1806 1807 1858 1857 1807 1808 1859 1858 + 1808 1809 1860 1859 1809 1810 1861 1860 1810 1811 1862 1861 + 1811 1812 1863 1862 1812 1813 1864 1863 1813 1814 1865 1864 + 1814 1815 1866 1865 1815 1816 1867 1866 1816 1817 1868 1867 + 1817 1818 1869 1868 1818 1819 1870 1869 1819 1820 1871 1870 + 1820 1821 1872 1871 1821 1822 1873 1872 1822 1823 1874 1873 + 1823 1824 1875 1874 1824 1825 1876 1875 1825 1826 1877 1876 + 1826 1827 1878 1877 1827 1828 1879 1878 1828 1829 1880 1879 + 1829 1830 1881 1880 1830 1831 1882 1881 1831 1832 1883 1882 + 1832 1833 1884 1883 1833 1834 1885 1884 1834 1835 1886 1885 + 1836 1837 1888 1887 1837 1838 1889 1888 1838 1839 1890 1889 + 1839 1840 1891 1890 1840 1841 1892 1891 1841 1842 1893 1892 + 1842 1843 1894 1893 1843 1844 1895 1894 1844 1845 1896 1895 + 1845 1846 1897 1896 1846 1847 1898 1897 1847 1848 1899 1898 + 1848 1849 1900 1899 1849 1850 1901 1900 1850 1851 1902 1901 + 1851 1852 1903 1902 1852 1853 1904 1903 1853 1854 1905 1904 + 1854 1855 1906 1905 1855 1856 1907 1906 1856 1857 1908 1907 + 1857 1858 1909 1908 1858 1859 1910 1909 1859 1860 1911 1910 + 1860 1861 1912 1911 1861 1862 1913 1912 1862 1863 1914 1913 + 1863 1864 1915 1914 1864 1865 1916 1915 1865 1866 1917 1916 + 1866 1867 1918 1917 1867 1868 1919 1918 1868 1869 1920 1919 + 1869 1870 1921 1920 1870 1871 1922 1921 1871 1872 1923 1922 + 1872 1873 1924 1923 1873 1874 1925 1924 1874 1875 1926 1925 + 1875 1876 1927 1926 1876 1877 1928 1927 1877 1878 1929 1928 + 1878 1879 1930 1929 1879 1880 1931 1930 1880 1881 1932 1931 + 1881 1882 1933 1932 1882 1883 1934 1933 1883 1884 1935 1934 + 1884 1885 1936 1935 1885 1886 1937 1936 1887 1888 1939 1938 + 1888 1889 1940 1939 1889 1890 1941 1940 1890 1891 1942 1941 + 1891 1892 1943 1942 1892 1893 1944 1943 1893 1894 1945 1944 + 1894 1895 1946 1945 1895 1896 1947 1946 1896 1897 1948 1947 + 1897 1898 1949 1948 1898 1899 1950 1949 1899 1900 1951 1950 + 1900 1901 1952 1951 1901 1902 1953 1952 1902 1903 1954 1953 + 1903 1904 1955 1954 1904 1905 1956 1955 1905 1906 1957 1956 + 1906 1907 1958 1957 1907 1908 1959 1958 1908 1909 1960 1959 + 1909 1910 1961 1960 1910 1911 1962 1961 1911 1912 1963 1962 + 1912 1913 1964 1963 1913 1914 1965 1964 1914 1915 1966 1965 + 1915 1916 1967 1966 1916 1917 1968 1967 1917 1918 1969 1968 + 1918 1919 1970 1969 1919 1920 1971 1970 1920 1921 1972 1971 + 1921 1922 1973 1972 1922 1923 1974 1973 1923 1924 1975 1974 + 1924 1925 1976 1975 1925 1926 1977 1976 1926 1927 1978 1977 + 1927 1928 1979 1978 1928 1929 1980 1979 1929 1930 1981 1980 + 1930 1931 1982 1981 1931 1932 1983 1982 1932 1933 1984 1983 + 1933 1934 1985 1984 1934 1935 1986 1985 1935 1936 1987 1986 + 1936 1937 1988 1987 1938 1939 1990 1989 1939 1940 1991 1990 + 1940 1941 1992 1991 1941 1942 1993 1992 1942 1943 1994 1993 + 1943 1944 1995 1994 1944 1945 1996 1995 1945 1946 1997 1996 + 1946 1947 1998 1997 1947 1948 1999 1998 1948 1949 2000 1999 + 1949 1950 2001 2000 1950 1951 2002 2001 1951 1952 2003 2002 + 1952 1953 2004 2003 1953 1954 2005 2004 1954 1955 2006 2005 + 1955 1956 2007 2006 1956 1957 2008 2007 1957 1958 2009 2008 + 1958 1959 2010 2009 1959 1960 2011 2010 1960 1961 2012 2011 + 1961 1962 2013 2012 1962 1963 2014 2013 1963 1964 2015 2014 + 1964 1965 2016 2015 1965 1966 2017 2016 1966 1967 2018 2017 + 1967 1968 2019 2018 1968 1969 2020 2019 1969 1970 2021 2020 + 1970 1971 2022 2021 1971 1972 2023 2022 1972 1973 2024 2023 + 1973 1974 2025 2024 1974 1975 2026 2025 1975 1976 2027 2026 + 1976 1977 2028 2027 1977 1978 2029 2028 1978 1979 2030 2029 + 1979 1980 2031 2030 1980 1981 2032 2031 1981 1982 2033 2032 + 1982 1983 2034 2033 1983 1984 2035 2034 1984 1985 2036 2035 + 1985 1986 2037 2036 1986 1987 2038 2037 1987 1988 2039 2038 + 1989 1990 2041 2040 1990 1991 2042 2041 1991 1992 2043 2042 + 1992 1993 2044 2043 1993 1994 2045 2044 1994 1995 2046 2045 + 1995 1996 2047 2046 1996 1997 2048 2047 1997 1998 2049 2048 + 1998 1999 2050 2049 1999 2000 2051 2050 2000 2001 2052 2051 + 2001 2002 2053 2052 2002 2003 2054 2053 2003 2004 2055 2054 + 2004 2005 2056 2055 2005 2006 2057 2056 2006 2007 2058 2057 + 2007 2008 2059 2058 2008 2009 2060 2059 2009 2010 2061 2060 + 2010 2011 2062 2061 2011 2012 2063 2062 2012 2013 2064 2063 + 2013 2014 2065 2064 2014 2015 2066 2065 2015 2016 2067 2066 + 2016 2017 2068 2067 2017 2018 2069 2068 2018 2019 2070 2069 + 2019 2020 2071 2070 2020 2021 2072 2071 2021 2022 2073 2072 + 2022 2023 2074 2073 2023 2024 2075 2074 2024 2025 2076 2075 + 2025 2026 2077 2076 2026 2027 2078 2077 2027 2028 2079 2078 + 2028 2029 2080 2079 2029 2030 2081 2080 2030 2031 2082 2081 + 2031 2032 2083 2082 2032 2033 2084 2083 2033 2034 2085 2084 + 2034 2035 2086 2085 2035 2036 2087 2086 2036 2037 2088 2087 + 2037 2038 2089 2088 2038 2039 2090 2089 2040 2041 2092 2091 + 2041 2042 2093 2092 2042 2043 2094 2093 2043 2044 2095 2094 + 2044 2045 2096 2095 2045 2046 2097 2096 2046 2047 2098 2097 + 2047 2048 2099 2098 2048 2049 2100 2099 2049 2050 2101 2100 + 2050 2051 2102 2101 2051 2052 2103 2102 2052 2053 2104 2103 + 2053 2054 2105 2104 2054 2055 2106 2105 2055 2056 2107 2106 + 2056 2057 2108 2107 2057 2058 2109 2108 2058 2059 2110 2109 + 2059 2060 2111 2110 2060 2061 2112 2111 2061 2062 2113 2112 + 2062 2063 2114 2113 2063 2064 2115 2114 2064 2065 2116 2115 + 2065 2066 2117 2116 2066 2067 2118 2117 2067 2068 2119 2118 + 2068 2069 2120 2119 2069 2070 2121 2120 2070 2071 2122 2121 + 2071 2072 2123 2122 2072 2073 2124 2123 2073 2074 2125 2124 + 2074 2075 2126 2125 2075 2076 2127 2126 2076 2077 2128 2127 + 2077 2078 2129 2128 2078 2079 2130 2129 2079 2080 2131 2130 + 2080 2081 2132 2131 2081 2082 2133 2132 2082 2083 2134 2133 + 2083 2084 2135 2134 2084 2085 2136 2135 2085 2086 2137 2136 + 2086 2087 2138 2137 2087 2088 2139 2138 2088 2089 2140 2139 + 2089 2090 2141 2140 2091 2092 2143 2142 2092 2093 2144 2143 + 2093 2094 2145 2144 2094 2095 2146 2145 2095 2096 2147 2146 + 2096 2097 2148 2147 2097 2098 2149 2148 2098 2099 2150 2149 + 2099 2100 2151 2150 2100 2101 2152 2151 2101 2102 2153 2152 + 2102 2103 2154 2153 2103 2104 2155 2154 2104 2105 2156 2155 + 2105 2106 2157 2156 2106 2107 2158 2157 2107 2108 2159 2158 + 2108 2109 2160 2159 2109 2110 2161 2160 2110 2111 2162 2161 + 2111 2112 2163 2162 2112 2113 2164 2163 2113 2114 2165 2164 + 2114 2115 2166 2165 2115 2116 2167 2166 2116 2117 2168 2167 + 2117 2118 2169 2168 2118 2119 2170 2169 2119 2120 2171 2170 + 2120 2121 2172 2171 2121 2122 2173 2172 2122 2123 2174 2173 + 2123 2124 2175 2174 2124 2125 2176 2175 2125 2126 2177 2176 + 2126 2127 2178 2177 2127 2128 2179 2178 2128 2129 2180 2179 + 2129 2130 2181 2180 2130 2131 2182 2181 2131 2132 2183 2182 + 2132 2133 2184 2183 2133 2134 2185 2184 2134 2135 2186 2185 + 2135 2136 2187 2186 2136 2137 2188 2187 2137 2138 2189 2188 + 2138 2139 2190 2189 2139 2140 2191 2190 2140 2141 2192 2191 + 2142 2143 2194 2193 2143 2144 2195 2194 2144 2145 2196 2195 + 2145 2146 2197 2196 2146 2147 2198 2197 2147 2148 2199 2198 + 2148 2149 2200 2199 2149 2150 2201 2200 2150 2151 2202 2201 + 2151 2152 2203 2202 2152 2153 2204 2203 2153 2154 2205 2204 + 2154 2155 2206 2205 2155 2156 2207 2206 2156 2157 2208 2207 + 2157 2158 2209 2208 2158 2159 2210 2209 2159 2160 2211 2210 + 2160 2161 2212 2211 2161 2162 2213 2212 2162 2163 2214 2213 + 2163 2164 2215 2214 2164 2165 2216 2215 2165 2166 2217 2216 + 2166 2167 2218 2217 2167 2168 2219 2218 2168 2169 2220 2219 + 2169 2170 2221 2220 2170 2171 2222 2221 2171 2172 2223 2222 + 2172 2173 2224 2223 2173 2174 2225 2224 2174 2175 2226 2225 + 2175 2176 2227 2226 2176 2177 2228 2227 2177 2178 2229 2228 + 2178 2179 2230 2229 2179 2180 2231 2230 2180 2181 2232 2231 + 2181 2182 2233 2232 2182 2183 2234 2233 2183 2184 2235 2234 + 2184 2185 2236 2235 2185 2186 2237 2236 2186 2187 2238 2237 + 2187 2188 2239 2238 2188 2189 2240 2239 2189 2190 2241 2240 + 2190 2191 2242 2241 2191 2192 2243 2242 2193 2194 2245 2244 + 2194 2195 2246 2245 2195 2196 2247 2246 2196 2197 2248 2247 + 2197 2198 2249 2248 2198 2199 2250 2249 2199 2200 2251 2250 + 2200 2201 2252 2251 2201 2202 2253 2252 2202 2203 2254 2253 + 2203 2204 2255 2254 2204 2205 2256 2255 2205 2206 2257 2256 + 2206 2207 2258 2257 2207 2208 2259 2258 2208 2209 2260 2259 + 2209 2210 2261 2260 2210 2211 2262 2261 2211 2212 2263 2262 + 2212 2213 2264 2263 2213 2214 2265 2264 2214 2215 2266 2265 + 2215 2216 2267 2266 2216 2217 2268 2267 2217 2218 2269 2268 + 2218 2219 2270 2269 2219 2220 2271 2270 2220 2221 2272 2271 + 2221 2222 2273 2272 2222 2223 2274 2273 2223 2224 2275 2274 + 2224 2225 2276 2275 2225 2226 2277 2276 2226 2227 2278 2277 + 2227 2228 2279 2278 2228 2229 2280 2279 2229 2230 2281 2280 + 2230 2231 2282 2281 2231 2232 2283 2282 2232 2233 2284 2283 + 2233 2234 2285 2284 2234 2235 2286 2285 2235 2236 2287 2286 + 2236 2237 2288 2287 2237 2238 2289 2288 2238 2239 2290 2289 + 2239 2240 2291 2290 2240 2241 2292 2291 2241 2242 2293 2292 + 2242 2243 2294 2293 2244 2245 2296 2295 2245 2246 2297 2296 + 2246 2247 2298 2297 2247 2248 2299 2298 2248 2249 2300 2299 + 2249 2250 2301 2300 2250 2251 2302 2301 2251 2252 2303 2302 + 2252 2253 2304 2303 2253 2254 2305 2304 2254 2255 2306 2305 + 2255 2256 2307 2306 2256 2257 2308 2307 2257 2258 2309 2308 + 2258 2259 2310 2309 2259 2260 2311 2310 2260 2261 2312 2311 + 2261 2262 2313 2312 2262 2263 2314 2313 2263 2264 2315 2314 + 2264 2265 2316 2315 2265 2266 2317 2316 2266 2267 2318 2317 + 2267 2268 2319 2318 2268 2269 2320 2319 2269 2270 2321 2320 + 2270 2271 2322 2321 2271 2272 2323 2322 2272 2273 2324 2323 + 2273 2274 2325 2324 2274 2275 2326 2325 2275 2276 2327 2326 + 2276 2277 2328 2327 2277 2278 2329 2328 2278 2279 2330 2329 + 2279 2280 2331 2330 2280 2281 2332 2331 2281 2282 2333 2332 + 2282 2283 2334 2333 2283 2284 2335 2334 2284 2285 2336 2335 + 2285 2286 2337 2336 2286 2287 2338 2337 2287 2288 2339 2338 + 2288 2289 2340 2339 2289 2290 2341 2340 2290 2291 2342 2341 + 2291 2292 2343 2342 2292 2293 2344 2343 2293 2294 2345 2344 + 2295 2296 2347 2346 2296 2297 2348 2347 2297 2298 2349 2348 + 2298 2299 2350 2349 2299 2300 2351 2350 2300 2301 2352 2351 + 2301 2302 2353 2352 2302 2303 2354 2353 2303 2304 2355 2354 + 2304 2305 2356 2355 2305 2306 2357 2356 2306 2307 2358 2357 + 2307 2308 2359 2358 2308 2309 2360 2359 2309 2310 2361 2360 + 2310 2311 2362 2361 2311 2312 2363 2362 2312 2313 2364 2363 + 2313 2314 2365 2364 2314 2315 2366 2365 2315 2316 2367 2366 + 2316 2317 2368 2367 2317 2318 2369 2368 2318 2319 2370 2369 + 2319 2320 2371 2370 2320 2321 2372 2371 2321 2322 2373 2372 + 2322 2323 2374 2373 2323 2324 2375 2374 2324 2325 2376 2375 + 2325 2326 2377 2376 2326 2327 2378 2377 2327 2328 2379 2378 + 2328 2329 2380 2379 2329 2330 2381 2380 2330 2331 2382 2381 + 2331 2332 2383 2382 2332 2333 2384 2383 2333 2334 2385 2384 + 2334 2335 2386 2385 2335 2336 2387 2386 2336 2337 2388 2387 + 2337 2338 2389 2388 2338 2339 2390 2389 2339 2340 2391 2390 + 2340 2341 2392 2391 2341 2342 2393 2392 2342 2343 2394 2393 + 2343 2344 2395 2394 2344 2345 2396 2395 2346 2347 2398 2397 + 2347 2348 2399 2398 2348 2349 2400 2399 2349 2350 2401 2400 + 2350 2351 2402 2401 2351 2352 2403 2402 2352 2353 2404 2403 + 2353 2354 2405 2404 2354 2355 2406 2405 2355 2356 2407 2406 + 2356 2357 2408 2407 2357 2358 2409 2408 2358 2359 2410 2409 + 2359 2360 2411 2410 2360 2361 2412 2411 2361 2362 2413 2412 + 2362 2363 2414 2413 2363 2364 2415 2414 2364 2365 2416 2415 + 2365 2366 2417 2416 2366 2367 2418 2417 2367 2368 2419 2418 + 2368 2369 2420 2419 2369 2370 2421 2420 2370 2371 2422 2421 + 2371 2372 2423 2422 2372 2373 2424 2423 2373 2374 2425 2424 + 2374 2375 2426 2425 2375 2376 2427 2426 2376 2377 2428 2427 + 2377 2378 2429 2428 2378 2379 2430 2429 2379 2380 2431 2430 + 2380 2381 2432 2431 2381 2382 2433 2432 2382 2383 2434 2433 + 2383 2384 2435 2434 2384 2385 2436 2435 2385 2386 2437 2436 + 2386 2387 2438 2437 2387 2388 2439 2438 2388 2389 2440 2439 + 2389 2390 2441 2440 2390 2391 2442 2441 2391 2392 2443 2442 + 2392 2393 2444 2443 2393 2394 2445 2444 2394 2395 2446 2445 + 2395 2396 2447 2446 2397 2398 2449 2448 2398 2399 2450 2449 + 2399 2400 2451 2450 2400 2401 2452 2451 2401 2402 2453 2452 + 2402 2403 2454 2453 2403 2404 2455 2454 2404 2405 2456 2455 + 2405 2406 2457 2456 2406 2407 2458 2457 2407 2408 2459 2458 + 2408 2409 2460 2459 2409 2410 2461 2460 2410 2411 2462 2461 + 2411 2412 2463 2462 2412 2413 2464 2463 2413 2414 2465 2464 + 2414 2415 2466 2465 2415 2416 2467 2466 2416 2417 2468 2467 + 2417 2418 2469 2468 2418 2419 2470 2469 2419 2420 2471 2470 + 2420 2421 2472 2471 2421 2422 2473 2472 2422 2423 2474 2473 + 2423 2424 2475 2474 2424 2425 2476 2475 2425 2426 2477 2476 + 2426 2427 2478 2477 2427 2428 2479 2478 2428 2429 2480 2479 + 2429 2430 2481 2480 2430 2431 2482 2481 2431 2432 2483 2482 + 2432 2433 2484 2483 2433 2434 2485 2484 2434 2435 2486 2485 + 2435 2436 2487 2486 2436 2437 2488 2487 2437 2438 2489 2488 + 2438 2439 2490 2489 2439 2440 2491 2490 2440 2441 2492 2491 + 2441 2442 2493 2492 2442 2443 2494 2493 2443 2444 2495 2494 + 2444 2445 2496 2495 2445 2446 2497 2496 2446 2447 2498 2497 + 2448 2449 2500 2499 2449 2450 2501 2500 2450 2451 2502 2501 + 2451 2452 2503 2502 2452 2453 2504 2503 2453 2454 2505 2504 + 2454 2455 2506 2505 2455 2456 2507 2506 2456 2457 2508 2507 + 2457 2458 2509 2508 2458 2459 2510 2509 2459 2460 2511 2510 + 2460 2461 2512 2511 2461 2462 2513 2512 2462 2463 2514 2513 + 2463 2464 2515 2514 2464 2465 2516 2515 2465 2466 2517 2516 + 2466 2467 2518 2517 2467 2468 2519 2518 2468 2469 2520 2519 + 2469 2470 2521 2520 2470 2471 2522 2521 2471 2472 2523 2522 + 2472 2473 2524 2523 2473 2474 2525 2524 2474 2475 2526 2525 + 2475 2476 2527 2526 2476 2477 2528 2527 2477 2478 2529 2528 + 2478 2479 2530 2529 2479 2480 2531 2530 2480 2481 2532 2531 + 2481 2482 2533 2532 2482 2483 2534 2533 2483 2484 2535 2534 + 2484 2485 2536 2535 2485 2486 2537 2536 2486 2487 2538 2537 + 2487 2488 2539 2538 2488 2489 2540 2539 2489 2490 2541 2540 + 2490 2491 2542 2541 2491 2492 2543 2542 2492 2493 2544 2543 + 2493 2494 2545 2544 2494 2495 2546 2545 2495 2496 2547 2546 + 2496 2497 2548 2547 2497 2498 2549 2548 2499 2500 2551 2550 + 2500 2501 2552 2551 2501 2502 2553 2552 2502 2503 2554 2553 + 2503 2504 2555 2554 2504 2505 2556 2555 2505 2506 2557 2556 + 2506 2507 2558 2557 2507 2508 2559 2558 2508 2509 2560 2559 + 2509 2510 2561 2560 2510 2511 2562 2561 2511 2512 2563 2562 + 2512 2513 2564 2563 2513 2514 2565 2564 2514 2515 2566 2565 + 2515 2516 2567 2566 2516 2517 2568 2567 2517 2518 2569 2568 + 2518 2519 2570 2569 2519 2520 2571 2570 2520 2521 2572 2571 + 2521 2522 2573 2572 2522 2523 2574 2573 2523 2524 2575 2574 + 2524 2525 2576 2575 2525 2526 2577 2576 2526 2527 2578 2577 + 2527 2528 2579 2578 2528 2529 2580 2579 2529 2530 2581 2580 + 2530 2531 2582 2581 2531 2532 2583 2582 2532 2533 2584 2583 + 2533 2534 2585 2584 2534 2535 2586 2585 2535 2536 2587 2586 + 2536 2537 2588 2587 2537 2538 2589 2588 2538 2539 2590 2589 + 2539 2540 2591 2590 2540 2541 2592 2591 2541 2542 2593 2592 + 2542 2543 2594 2593 2543 2544 2595 2594 2544 2545 2596 2595 + 2545 2546 2597 2596 2546 2547 2598 2597 2547 2548 2599 2598 + 2548 2549 2600 2599 + </DataArray> + <DataArray type="Int32" Name="offsets" NumberOfComponents="1" format="ascii"> + 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 2412 2416 2420 2424 2428 2432 2436 2440 2444 2448 + 2452 2456 2460 2464 2468 2472 2476 2480 2484 2488 2492 2496 + 2500 2504 2508 2512 2516 2520 2524 2528 2532 2536 2540 2544 + 2548 2552 2556 2560 2564 2568 2572 2576 2580 2584 2588 2592 + 2596 2600 2604 2608 2612 2616 2620 2624 2628 2632 2636 2640 + 2644 2648 2652 2656 2660 2664 2668 2672 2676 2680 2684 2688 + 2692 2696 2700 2704 2708 2712 2716 2720 2724 2728 2732 2736 + 2740 2744 2748 2752 2756 2760 2764 2768 2772 2776 2780 2784 + 2788 2792 2796 2800 2804 2808 2812 2816 2820 2824 2828 2832 + 2836 2840 2844 2848 2852 2856 2860 2864 2868 2872 2876 2880 + 2884 2888 2892 2896 2900 2904 2908 2912 2916 2920 2924 2928 + 2932 2936 2940 2944 2948 2952 2956 2960 2964 2968 2972 2976 + 2980 2984 2988 2992 2996 3000 3004 3008 3012 3016 3020 3024 + 3028 3032 3036 3040 3044 3048 3052 3056 3060 3064 3068 3072 + 3076 3080 3084 3088 3092 3096 3100 3104 3108 3112 3116 3120 + 3124 3128 3132 3136 3140 3144 3148 3152 3156 3160 3164 3168 + 3172 3176 3180 3184 3188 3192 3196 3200 3204 3208 3212 3216 + 3220 3224 3228 3232 3236 3240 3244 3248 3252 3256 3260 3264 + 3268 3272 3276 3280 3284 3288 3292 3296 3300 3304 3308 3312 + 3316 3320 3324 3328 3332 3336 3340 3344 3348 3352 3356 3360 + 3364 3368 3372 3376 3380 3384 3388 3392 3396 3400 3404 3408 + 3412 3416 3420 3424 3428 3432 3436 3440 3444 3448 3452 3456 + 3460 3464 3468 3472 3476 3480 3484 3488 3492 3496 3500 3504 + 3508 3512 3516 3520 3524 3528 3532 3536 3540 3544 3548 3552 + 3556 3560 3564 3568 3572 3576 3580 3584 3588 3592 3596 3600 + 3604 3608 3612 3616 3620 3624 3628 3632 3636 3640 3644 3648 + 3652 3656 3660 3664 3668 3672 3676 3680 3684 3688 3692 3696 + 3700 3704 3708 3712 3716 3720 3724 3728 3732 3736 3740 3744 + 3748 3752 3756 3760 3764 3768 3772 3776 3780 3784 3788 3792 + 3796 3800 3804 3808 3812 3816 3820 3824 3828 3832 3836 3840 + 3844 3848 3852 3856 3860 3864 3868 3872 3876 3880 3884 3888 + 3892 3896 3900 3904 3908 3912 3916 3920 3924 3928 3932 3936 + 3940 3944 3948 3952 3956 3960 3964 3968 3972 3976 3980 3984 + 3988 3992 3996 4000 4004 4008 4012 4016 4020 4024 4028 4032 + 4036 4040 4044 4048 4052 4056 4060 4064 4068 4072 4076 4080 + 4084 4088 4092 4096 4100 4104 4108 4112 4116 4120 4124 4128 + 4132 4136 4140 4144 4148 4152 4156 4160 4164 4168 4172 4176 + 4180 4184 4188 4192 4196 4200 4204 4208 4212 4216 4220 4224 + 4228 4232 4236 4240 4244 4248 4252 4256 4260 4264 4268 4272 + 4276 4280 4284 4288 4292 4296 4300 4304 4308 4312 4316 4320 + 4324 4328 4332 4336 4340 4344 4348 4352 4356 4360 4364 4368 + 4372 4376 4380 4384 4388 4392 4396 4400 4404 4408 4412 4416 + 4420 4424 4428 4432 4436 4440 4444 4448 4452 4456 4460 4464 + 4468 4472 4476 4480 4484 4488 4492 4496 4500 4504 4508 4512 + 4516 4520 4524 4528 4532 4536 4540 4544 4548 4552 4556 4560 + 4564 4568 4572 4576 4580 4584 4588 4592 4596 4600 4604 4608 + 4612 4616 4620 4624 4628 4632 4636 4640 4644 4648 4652 4656 + 4660 4664 4668 4672 4676 4680 4684 4688 4692 4696 4700 4704 + 4708 4712 4716 4720 4724 4728 4732 4736 4740 4744 4748 4752 + 4756 4760 4764 4768 4772 4776 4780 4784 4788 4792 4796 4800 + 4804 4808 4812 4816 4820 4824 4828 4832 4836 4840 4844 4848 + 4852 4856 4860 4864 4868 4872 4876 4880 4884 4888 4892 4896 + 4900 4904 4908 4912 4916 4920 4924 4928 4932 4936 4940 4944 + 4948 4952 4956 4960 4964 4968 4972 4976 4980 4984 4988 4992 + 4996 5000 5004 5008 5012 5016 5020 5024 5028 5032 5036 5040 + 5044 5048 5052 5056 5060 5064 5068 5072 5076 5080 5084 5088 + 5092 5096 5100 5104 5108 5112 5116 5120 5124 5128 5132 5136 + 5140 5144 5148 5152 5156 5160 5164 5168 5172 5176 5180 5184 + 5188 5192 5196 5200 5204 5208 5212 5216 5220 5224 5228 5232 + 5236 5240 5244 5248 5252 5256 5260 5264 5268 5272 5276 5280 + 5284 5288 5292 5296 5300 5304 5308 5312 5316 5320 5324 5328 + 5332 5336 5340 5344 5348 5352 5356 5360 5364 5368 5372 5376 + 5380 5384 5388 5392 5396 5400 5404 5408 5412 5416 5420 5424 + 5428 5432 5436 5440 5444 5448 5452 5456 5460 5464 5468 5472 + 5476 5480 5484 5488 5492 5496 5500 5504 5508 5512 5516 5520 + 5524 5528 5532 5536 5540 5544 5548 5552 5556 5560 5564 5568 + 5572 5576 5580 5584 5588 5592 5596 5600 5604 5608 5612 5616 + 5620 5624 5628 5632 5636 5640 5644 5648 5652 5656 5660 5664 + 5668 5672 5676 5680 5684 5688 5692 5696 5700 5704 5708 5712 + 5716 5720 5724 5728 5732 5736 5740 5744 5748 5752 5756 5760 + 5764 5768 5772 5776 5780 5784 5788 5792 5796 5800 5804 5808 + 5812 5816 5820 5824 5828 5832 5836 5840 5844 5848 5852 5856 + 5860 5864 5868 5872 5876 5880 5884 5888 5892 5896 5900 5904 + 5908 5912 5916 5920 5924 5928 5932 5936 5940 5944 5948 5952 + 5956 5960 5964 5968 5972 5976 5980 5984 5988 5992 5996 6000 + 6004 6008 6012 6016 6020 6024 6028 6032 6036 6040 6044 6048 + 6052 6056 6060 6064 6068 6072 6076 6080 6084 6088 6092 6096 + 6100 6104 6108 6112 6116 6120 6124 6128 6132 6136 6140 6144 + 6148 6152 6156 6160 6164 6168 6172 6176 6180 6184 6188 6192 + 6196 6200 6204 6208 6212 6216 6220 6224 6228 6232 6236 6240 + 6244 6248 6252 6256 6260 6264 6268 6272 6276 6280 6284 6288 + 6292 6296 6300 6304 6308 6312 6316 6320 6324 6328 6332 6336 + 6340 6344 6348 6352 6356 6360 6364 6368 6372 6376 6380 6384 + 6388 6392 6396 6400 6404 6408 6412 6416 6420 6424 6428 6432 + 6436 6440 6444 6448 6452 6456 6460 6464 6468 6472 6476 6480 + 6484 6488 6492 6496 6500 6504 6508 6512 6516 6520 6524 6528 + 6532 6536 6540 6544 6548 6552 6556 6560 6564 6568 6572 6576 + 6580 6584 6588 6592 6596 6600 6604 6608 6612 6616 6620 6624 + 6628 6632 6636 6640 6644 6648 6652 6656 6660 6664 6668 6672 + 6676 6680 6684 6688 6692 6696 6700 6704 6708 6712 6716 6720 + 6724 6728 6732 6736 6740 6744 6748 6752 6756 6760 6764 6768 + 6772 6776 6780 6784 6788 6792 6796 6800 6804 6808 6812 6816 + 6820 6824 6828 6832 6836 6840 6844 6848 6852 6856 6860 6864 + 6868 6872 6876 6880 6884 6888 6892 6896 6900 6904 6908 6912 + 6916 6920 6924 6928 6932 6936 6940 6944 6948 6952 6956 6960 + 6964 6968 6972 6976 6980 6984 6988 6992 6996 7000 7004 7008 + 7012 7016 7020 7024 7028 7032 7036 7040 7044 7048 7052 7056 + 7060 7064 7068 7072 7076 7080 7084 7088 7092 7096 7100 7104 + 7108 7112 7116 7120 7124 7128 7132 7136 7140 7144 7148 7152 + 7156 7160 7164 7168 7172 7176 7180 7184 7188 7192 7196 7200 + 7204 7208 7212 7216 7220 7224 7228 7232 7236 7240 7244 7248 + 7252 7256 7260 7264 7268 7272 7276 7280 7284 7288 7292 7296 + 7300 7304 7308 7312 7316 7320 7324 7328 7332 7336 7340 7344 + 7348 7352 7356 7360 7364 7368 7372 7376 7380 7384 7388 7392 + 7396 7400 7404 7408 7412 7416 7420 7424 7428 7432 7436 7440 + 7444 7448 7452 7456 7460 7464 7468 7472 7476 7480 7484 7488 + 7492 7496 7500 7504 7508 7512 7516 7520 7524 7528 7532 7536 + 7540 7544 7548 7552 7556 7560 7564 7568 7572 7576 7580 7584 + 7588 7592 7596 7600 7604 7608 7612 7616 7620 7624 7628 7632 + 7636 7640 7644 7648 7652 7656 7660 7664 7668 7672 7676 7680 + 7684 7688 7692 7696 7700 7704 7708 7712 7716 7720 7724 7728 + 7732 7736 7740 7744 7748 7752 7756 7760 7764 7768 7772 7776 + 7780 7784 7788 7792 7796 7800 7804 7808 7812 7816 7820 7824 + 7828 7832 7836 7840 7844 7848 7852 7856 7860 7864 7868 7872 + 7876 7880 7884 7888 7892 7896 7900 7904 7908 7912 7916 7920 + 7924 7928 7932 7936 7940 7944 7948 7952 7956 7960 7964 7968 + 7972 7976 7980 7984 7988 7992 7996 8000 8004 8008 8012 8016 + 8020 8024 8028 8032 8036 8040 8044 8048 8052 8056 8060 8064 + 8068 8072 8076 8080 8084 8088 8092 8096 8100 8104 8108 8112 + 8116 8120 8124 8128 8132 8136 8140 8144 8148 8152 8156 8160 + 8164 8168 8172 8176 8180 8184 8188 8192 8196 8200 8204 8208 + 8212 8216 8220 8224 8228 8232 8236 8240 8244 8248 8252 8256 + 8260 8264 8268 8272 8276 8280 8284 8288 8292 8296 8300 8304 + 8308 8312 8316 8320 8324 8328 8332 8336 8340 8344 8348 8352 + 8356 8360 8364 8368 8372 8376 8380 8384 8388 8392 8396 8400 + 8404 8408 8412 8416 8420 8424 8428 8432 8436 8440 8444 8448 + 8452 8456 8460 8464 8468 8472 8476 8480 8484 8488 8492 8496 + 8500 8504 8508 8512 8516 8520 8524 8528 8532 8536 8540 8544 + 8548 8552 8556 8560 8564 8568 8572 8576 8580 8584 8588 8592 + 8596 8600 8604 8608 8612 8616 8620 8624 8628 8632 8636 8640 + 8644 8648 8652 8656 8660 8664 8668 8672 8676 8680 8684 8688 + 8692 8696 8700 8704 8708 8712 8716 8720 8724 8728 8732 8736 + 8740 8744 8748 8752 8756 8760 8764 8768 8772 8776 8780 8784 + 8788 8792 8796 8800 8804 8808 8812 8816 8820 8824 8828 8832 + 8836 8840 8844 8848 8852 8856 8860 8864 8868 8872 8876 8880 + 8884 8888 8892 8896 8900 8904 8908 8912 8916 8920 8924 8928 + 8932 8936 8940 8944 8948 8952 8956 8960 8964 8968 8972 8976 + 8980 8984 8988 8992 8996 9000 9004 9008 9012 9016 9020 9024 + 9028 9032 9036 9040 9044 9048 9052 9056 9060 9064 9068 9072 + 9076 9080 9084 9088 9092 9096 9100 9104 9108 9112 9116 9120 + 9124 9128 9132 9136 9140 9144 9148 9152 9156 9160 9164 9168 + 9172 9176 9180 9184 9188 9192 9196 9200 9204 9208 9212 9216 + 9220 9224 9228 9232 9236 9240 9244 9248 9252 9256 9260 9264 + 9268 9272 9276 9280 9284 9288 9292 9296 9300 9304 9308 9312 + 9316 9320 9324 9328 9332 9336 9340 9344 9348 9352 9356 9360 + 9364 9368 9372 9376 9380 9384 9388 9392 9396 9400 9404 9408 + 9412 9416 9420 9424 9428 9432 9436 9440 9444 9448 9452 9456 + 9460 9464 9468 9472 9476 9480 9484 9488 9492 9496 9500 9504 + 9508 9512 9516 9520 9524 9528 9532 9536 9540 9544 9548 9552 + 9556 9560 9564 9568 9572 9576 9580 9584 9588 9592 9596 9600 + 9604 9608 9612 9616 9620 9624 9628 9632 9636 9640 9644 9648 + 9652 9656 9660 9664 9668 9672 9676 9680 9684 9688 9692 9696 + 9700 9704 9708 9712 9716 9720 9724 9728 9732 9736 9740 9744 + 9748 9752 9756 9760 9764 9768 9772 9776 9780 9784 9788 9792 + 9796 9800 9804 9808 9812 9816 9820 9824 9828 9832 9836 9840 + 9844 9848 9852 9856 9860 9864 9868 9872 9876 9880 9884 9888 + 9892 9896 9900 9904 9908 9912 9916 9920 9924 9928 9932 9936 + 9940 9944 9948 9952 9956 9960 9964 9968 9972 9976 9980 9984 + 9988 9992 9996 10000 + </DataArray> + <DataArray type="UInt8" Name="types" NumberOfComponents="1" format="ascii"> + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 9 9 9 9 9 9 9 9 + 9 9 9 9 + </DataArray> + </Cells> + </Piece> + </UnstructuredGrid> +</VTKFile>