diff --git a/Common/DefaultOptions.h b/Common/DefaultOptions.h index fbdd0ea38fbf91cd175e957aadd3affbec605624..45a3d3c456445ef75ebc07274468c01e91f24922 100644 --- a/Common/DefaultOptions.h +++ b/Common/DefaultOptions.h @@ -1091,7 +1091,7 @@ StringXNumber MeshOptions_Number[] = { { F|O, "MeshOnlyVisible" , opt_mesh_mesh_only_visible, 0. , "Mesh only visible entities (experimental: use with caution!)" }, { F|O, "MetisAlgorithm" , opt_mesh_partition_metis_algorithm, 1. , - "METIS partitioning algorithm (1=Recursive, 2=K-way)" }, + "METIS partitioning algorithm (1=Recursive, 2=K-way, 3=Nodal weight)" }, { F|O, "MetisEdgeMatching" , opt_mesh_partition_metis_edge_matching, 3. , "(Adv. METIS): Determines the matching type (1=Random, 2=Heavy-Edge, " "3=Sorted Heavy-Edge)" }, diff --git a/Fltk/partitionDialog.cpp b/Fltk/partitionDialog.cpp index ce9b72c3b3926c2f98a0770eb5a4c7a50c13bc59..cde182056be60861fa16fa25602c8905863f31c6 100644 --- a/Fltk/partitionDialog.cpp +++ b/Fltk/partitionDialog.cpp @@ -417,6 +417,7 @@ void partition_dialog() static Fl_Menu_Item metisAlgMenu[] = { {"Recursive", 0, 0, 0}, {"K-way", 0, 0, 0}, + {"Nodal weight", 0, 0, 0}, {0} }; diff --git a/Geo/GFace.h b/Geo/GFace.h index e0b2b6af23d886af725a78bd5bfb434fd9b2dae4..f0b4555691a075ba8b235ebb49ab19ece0f14f2e 100644 --- a/Geo/GFace.h +++ b/Geo/GFace.h @@ -124,7 +124,8 @@ class GFace : public GEntity int poincareMesh(); int genusMesh() { return (poincareMesh() + edgeLoops.size() - 2) / 2; } virtual int genusGeom(); - virtual bool checkTopology(){ return true; } + virtual bool checkTopology() const { return true; } + virtual bool checkAspectRatio() const { return true; } // return the point on the face corresponding to the given parameter virtual GPoint point(double par1, double par2) const = 0; @@ -259,7 +260,7 @@ class GFace : public GEntity typedef enum {PENDING, DONE, FAILED} meshGenerationStatus; struct { - meshGenerationStatus status; + mutable meshGenerationStatus status; double worst_element_shape, best_element_shape, average_element_shape; double smallest_edge_length, longest_edge_length, efficiency_index; int nbEdge, nbTriangle; diff --git a/Geo/GFaceCompound.cpp b/Geo/GFaceCompound.cpp index 4677c1a4e0dc16ea116bbc944227636504d41d4d..843236bfdc8441cde37b6622058b75e70167d734 100644 --- a/Geo/GFaceCompound.cpp +++ b/Geo/GFaceCompound.cpp @@ -29,13 +29,13 @@ #include "Context.h" #include "discreteFace.h" -#if !defined(HAVE_NO_MESH) -#include "meshGFace.h" -#include "meshGFaceOptimize.h" -#include "meshGEdge.h" -#include "meshPartitionOptions.h" -#include "meshPartition.h" -#endif +// #if !defined(HAVE_NO_MESH) +// #include "meshGFace.h" +// #include "meshGFaceOptimize.h" +// #include "meshGEdge.h" +// #include "meshPartitionOptions.h" +// #include "meshPartition.h" +// #endif static void fixEdgeToValue(GEdge *ed, double value, dofManager<double, double> &myAssembler) { @@ -201,6 +201,9 @@ bool GFaceCompound::trivial() const return false; } +//check if the discrete harmonic map is correct +//by checking that all the mapped triangles have +//the same normal orientation bool GFaceCompound::checkOrientation() const { @@ -360,8 +363,9 @@ void GFaceCompound::parametrize() const //----------------- //compute_distance(); - buildOct(); checkOrientation(); + + buildOct(); computeNormals(); } } @@ -375,7 +379,8 @@ void GFaceCompound::getBoundingEdges() std::set<GEdge*> _unique; getUniqueEdges(_unique); - std::set<GEdge*>::iterator itf = _unique.begin(); + + l_edges.clear(); if(_U0.size()){ //in case the bounding edges are explicitely given @@ -395,6 +400,7 @@ void GFaceCompound::getBoundingEdges() } else{ //in case the bounding edges are NOT explicitely given + std::set<GEdge*>::iterator itf = _unique.begin(); for( ; itf != _unique.end(); ++itf){ l_edges.push_back(*itf); (*itf)->addFace(this); @@ -403,7 +409,7 @@ void GFaceCompound::getBoundingEdges() while(!_unique.empty()) computeALoop(_unique,_U1); } - return; + return; } @@ -430,11 +436,6 @@ void GFaceCompound::getUniqueEdges(std::set<GEdge*> &_unique) } } - std::set<GEdge*>::iterator itf = _unique.begin(); - for( ; itf != _unique.end(); ++itf){ - l_edges.push_back(*itf); - (*itf)->addFace(this); - } } void GFaceCompound::computeALoop(std::set<GEdge*> &_unique, std::list<GEdge*> &loop) { @@ -520,6 +521,9 @@ GFaceCompound::GFaceCompound(GModel *m, int tag, std::list<GFace*> &compound, _lsys = new linearSystemFull<double>; #endif } + nbSplit = 0; + _checkedAR = false; + _paramOK = false; for(std::list<GFace*>::iterator it = _compound.begin(); it != _compound.end(); ++it){ if(!(*it)){ @@ -801,16 +805,7 @@ void GFaceCompound::parametrize(iterationStep step) const Msg::Debug("System solved"); - it = _compound.begin(); - std::set<MVertex *> allNodes; - for( ; it != _compound.end() ; ++it){ - for(unsigned int i = 0; i < (*it)->triangles.size(); ++i){ - MTriangle *t = (*it)->triangles[i]; - for(int j = 0; j < 3; j++){ - allNodes.insert(t->getVertex(j)); - } - } - } + if(allNodes.empty()) buildAllNodes(); for(std::set<MVertex *>::iterator itv = allNodes.begin(); itv !=allNodes.end() ; ++itv){ MVertex *v = *itv; @@ -924,7 +919,7 @@ void GFaceCompound::parametrize_conformal() const void GFaceCompound::compute_distance() const { - SBoundingBox3d bbox = GModel::current()->bounds(); + SBoundingBox3d bbox = model()->bounds(); double L = norm(SVector3(bbox.max(), bbox.min())); double mu = L/28; simpleFunction<double> DIFF(mu * mu), MONE(1.0); @@ -1305,10 +1300,8 @@ void GFaceCompound::buildOct() const Octree_Arrange(oct); } //Verify topological conditions for computing the harmonic map -bool GFaceCompound::checkTopology() +bool GFaceCompound::checkTopology() const { -#if !defined(HAVE_NO_MESH) && (defined(HAVE_CHACO) || defined(HAVE_METIS)) - bool correctTopo = true; int Nb = _interior_loops.size(); @@ -1316,103 +1309,77 @@ bool GFaceCompound::checkTopology() if( G != 0 || Nb < 1) correctTopo = false; if (!correctTopo){ - Msg::Info("--> Wrong topology: Genus=%d and N boundary=%d", G, Nb); + nbSplit = std::max(G+1, 2); + } + else + Msg::Info("Correct topology: Genus=%d and N boundary=%d", G, Nb); - //Partition the mesh and createTopology fror new faces - //----------------------------------------------------- - meshPartitionOptions options; - int N = std::max(G+1, 2); - options = CTX::instance()->partitionOptions; - options.num_partitions = N; - options.partitioner = 2; //METIS - options.algorithm = 1 ; - int ier = PartitionMesh(GModel::current(), options); - int numv = GModel::current()->maxVertexNum() + 1; - int nume = GModel::current()->maxEdgeNum() + 1; - int numf = GModel::current()->maxFaceNum() + 1; - CreateTopologyFromPartition(GModel::current(), this, N); - GModel::current()->createTopologyFromMesh(); - - //Remesh new faces (Compound Lines and Compound Surfaces) - //----------------------------------------------------- - - discreteFace *gdf = new discreteFace(GModel::current(), numf+2*N); - GModel::current()->add(gdf); - //printf("*** Remesh face %d in new discreteFace =%d\n", this->tag(), gdf->tag()); - - int numEdges = GModel::current()->maxEdgeNum() - nume + 1; - //printf("*** Created %d discretEdges \n", numEdges); - for (int i=0; i < numEdges; i++){ - std::vector<GEdge*>e_compound; - GEdge *pe = GModel::current()->getEdgeByTag(nume+i);//partition edge - int num_gec = GModel::current()->maxEdgeNum() + 1; - e_compound.push_back(pe); - printf("*** Remeshing discreteEdge %d with CompoundLine %d\n", pe->tag(), num_gec); - GEdge *gec = new GEdgeCompound(GModel::current(), num_gec, e_compound); - - meshGEdge mge; - mge(gec);//meshing 1D + return correctTopo; +} - GModel::current()->remove(pe); - //GModel::current()->add(gec); - } +bool GFaceCompound::checkAspectRatio() const +{ - int numVert = GModel::current()->maxVertexNum() - numv + 1; - printf("*** Created %d discreteVert \n", numVert); - for (int i=0; i < numEdges; i++){ - GVertex *pv = GModel::current()->getVertexByTag(numv+i);//partition vertex - GModel::current()->remove(pv); - } + parametrize(); - std::list<GEdge*> b[4]; - std::set<MVertex*> all_vertices; - for (int i=0; i < N; i++){ - std::list<GFace*>f_compound; - GFace *pf = GModel::current()->getFaceByTag(numf+i);//partition face - int num_gfc = numf + N + i ; - f_compound.push_back(pf); - - printf("*** Remeshing discreteFace %d with CompoundSurface %d\n", pf->tag(), num_gfc); - GFace *gfc = new GFaceCompound(GModel::current(), num_gfc, f_compound, - b[0], b[1], b[2], b[3]); - meshGFace mgf; - mgf(gfc);//meshing 2D - - for (int j=0; j < gfc->triangles.size(); j++){ - MTriangle *t = gfc->triangles[j]; - MVertex *v1 = t->getVertex(0); - MVertex *v2 = t->getVertex(1); - MVertex *v3 = t->getVertex(2); - gdf->triangles.push_back(new MTriangle(v1, v2, v3)); - all_vertices.insert(v1); - all_vertices.insert(v2); - all_vertices.insert(v3); - } - - GModel::current()->remove(pf); - //GModel::current()->add(gfc); - } + if (!_checkedAR){ - //Put new mesh in a new discreteFace - //----------------------------------------------------- - for(std::set<MVertex*>::iterator it = all_vertices.begin(); it != all_vertices.end(); ++it){ - gdf->mesh_vertices.push_back(*it); + bool paramOK = true; + if(allNodes.empty()) buildAllNodes(); + + double areaMax; + std::list<GFace*>::const_iterator it = _compound.begin(); + for( ; it != _compound.end() ; ++it){ + for(unsigned int i = 0; i < (*it)->triangles.size(); ++i){ + MTriangle *t = (*it)->triangles[i]; + std::map<MVertex*,SPoint3>::const_iterator it0 = coordinates.find(t->getVertex(0)); + std::map<MVertex*,SPoint3>::const_iterator it1 = coordinates.find(t->getVertex(1)); + std::map<MVertex*,SPoint3>::const_iterator it2 = coordinates.find(t->getVertex(2)); + double p0[3] = {t->getVertex(0)->x(), t->getVertex(0)->y(), t->getVertex(0)->z()}; + double p1[3] = {t->getVertex(1)->x(), t->getVertex(1)->y(), t->getVertex(1)->z()}; + double p2[3] = {t->getVertex(2)->x(), t->getVertex(2)->y(), t->getVertex(2)->z()}; + double a_3D = fabs(triangle_area(p0, p1, p2)); + double q0[3] = {it0->second.x(), it0->second.y(), 0.0}; + double q1[3] = {it1->second.x(), it1->second.y(), 0.0}; + double q2[3] = {it2->second.x(), it2->second.y(), 0.0}; + double a_2D = fabs(triangle_area(q0, q1, q2)); + areaMax = std::max(areaMax,1./a_2D); + } + } + + if (areaMax > 1.e12) { + nbSplit = 2; + printf("--> Geometrical aspect ratio too high (1/area_2D=%g)\n", areaMax); + printf("--> Partition geometry in N=%d parts\n", nbSplit); + paramOK = false; + } + else { + Msg::Info("Geometrical aspect ratio (1/area_2D=%g)", areaMax); + paramOK = true; } + + _checkedAR = true; + _paramOK = paramOK; + } - printf("*** Mesh of surface %d done by assembly remeshed faces\n", this->tag()); - gdf->setTag(this->tag()); - meshStatistics.status = GFace::DONE; + return _paramOK; - //CreateOutputFile(CTX::instance()->outputFileName, CTX::instance()->mesh.format); - //Msg::Exit(1); +} +void GFaceCompound::buildAllNodes() const +{ + + std::list<GFace*>::const_iterator it = _compound.begin(); + for( ; it != _compound.end() ; ++it){ + for(unsigned int i = 0; i < (*it)->triangles.size(); ++i){ + MTriangle *t = (*it)->triangles[i]; + for(int j = 0; j < 3; j++){ + allNodes.insert(t->getVertex(j)); + } + } } - - return correctTopo; -#else - return false; -#endif + } int GFaceCompound::genusGeom() const diff --git a/Geo/GFaceCompound.h b/Geo/GFaceCompound.h index 8d431236988e73527afa9e672fe42caf722c5c2a..d675d23ee1005db4733183e9bcbb14583bb27b64 100644 --- a/Geo/GFaceCompound.h +++ b/Geo/GFaceCompound.h @@ -56,11 +56,13 @@ class GFaceCompound : public GFace { mutable int nbT; mutable GFaceCompoundTriangle *_gfct; mutable Octree *oct; + mutable std::set<MVertex*> allNodes; mutable v2t_cont adjv; mutable bool mapv2Tri; mutable std::map<MVertex*, SPoint3> coordinates; mutable std::map<MVertex*, SVector3> _normals; void buildOct() const ; + void buildAllNodes() const; void parametrize() const ; void parametrize_conformal() const ; void compute_distance() const ; @@ -68,6 +70,7 @@ class GFaceCompound : public GFace { bool checkOrientation() const; void one2OneMap() const; bool checkCavity(std::vector<MElement*> &vTri) const; + bool checkAspectRatio() const; void computeNormals () const; void getBoundingEdges(); void getUniqueEdges(std::set<GEdge*> & _unique); @@ -96,8 +99,11 @@ class GFaceCompound : public GFace { virtual SPoint2 getCoordinates(MVertex *v) const; virtual double curvatureMax(const SPoint2 ¶m) const; virtual int genusGeom () const; - virtual bool checkTopology(); - virtual std::list<GFace*> getCompounds() {return _compound;}; + virtual bool checkTopology() const; + virtual std::list<GFace*> getCompounds() const {return _compound;}; + mutable int nbSplit; + mutable bool _checkedAR; + mutable bool _paramOK; private: typeOfIsomorphism _type; typeOfMapping _mapping; diff --git a/Geo/GModel.cpp b/Geo/GModel.cpp index d9318efffd4b77d6484f384e3732d048e804d329..35db3174756c182ba9e00897e9a8706a36210154 100644 --- a/Geo/GModel.cpp +++ b/Geo/GModel.cpp @@ -806,7 +806,7 @@ template<class T> static void _associateEntityWithElementVertices(GEntity *ge, std::vector<T*> &elements) { for(unsigned int i = 0; i < elements.size(); i++){ - for(int j = 0; j < elements[i]->getNumVertices(); j++){ + for(int j = 0; j < elements[i]->getNumVertices(); j++){ if (!elements[i]->getVertex(j)->onWhat() || elements[i]->getVertex(j)->onWhat()->dim() > ge->dim()){ elements[i]->getVertex(j)->setEntity(ge); @@ -1028,39 +1028,37 @@ int GModel::removeDuplicateMeshVertices(double tolerance) return diff; } + void GModel::createTopologyFromMesh() { - std::vector<GEntity*> entities; - getEntities(entities); + // for each discreteRegion, create topology + std::vector<discreteRegion*> discreteRegions; + for(riter it = firstRegion(); it != lastRegion(); it++) + if((*it)->geomType() == GEntity::DiscreteVolume) + discreteRegions.push_back((discreteRegion*) *it); + for (std::vector<discreteRegion*>::iterator it = discreteRegions.begin(); + it != discreteRegions.end(); it++) + (*it)->setBoundFaces(); - std::vector<discreteEdge*> discreteEdges; - for(eiter it = firstEdge(); it != lastEdge(); it++) - if((*it)->geomType() == GEntity::DiscreteCurve) - discreteEdges.push_back((discreteEdge*) *it); - - std::vector<discreteFace*> discreteFaces; + //for each discreteFace, createTopology + std::vector<discreteFace*> discreteFaces; for(fiter it = firstFace(); it != lastFace(); it++) if((*it)->geomType() == GEntity::DiscreteSurface) discreteFaces.push_back((discreteFace*) *it); - - std::vector<discreteRegion*> discreteRegions; - for(riter it = firstRegion(); it != lastRegion(); it++) - if((*it)->geomType() == GEntity::DiscreteVolume) - discreteRegions.push_back((discreteRegion*) *it); - - Msg::Debug("Creating topology from mesh:"); - Msg::Debug("%d discrete edges", discreteEdges.size()); - Msg::Debug("%d discrete faces", discreteFaces.size()); - Msg::Debug("%d discrete regions", discreteRegions.size()); + createTopologyFromFaces(discreteFaces); - // for each discreteRegion, create topology - for (std::vector<discreteRegion*>::iterator it = discreteRegions.begin(); it != discreteRegions.end(); it++) - (*it)->setBoundFaces(); +} + +void GModel::createTopologyFromFaces(std::vector<discreteFace*> &discreteFaces) +{ - // for each discreteFace, create topology and if needed create discreteEdges + std::vector<discreteEdge*> discreteEdges; + for(eiter it = firstEdge(); it != lastEdge(); it++) + if((*it)->geomType() == GEntity::DiscreteCurve) + discreteEdges.push_back((discreteEdge*) *it); int initSizeEdges = discreteEdges.size(); // find boundary edges of each face and put them in a map_edges that @@ -1077,6 +1075,7 @@ void GModel::createTopologyFromMesh() std::map<int, std::vector<int> > face2Edges; while (!map_edges.empty()){ + std::vector<MEdge> myEdges; std::vector<int> tagFaces = map_edges.begin()->second; myEdges.push_back(map_edges.begin()->first); @@ -1097,8 +1096,8 @@ void GModel::createTopologyFromMesh() // the candidate discrete Edge does contain any of those; if not, // create discreteEdges and create a map face2Edges that associate // for each face the boundary discrete Edges + std::vector<int> tagEdges; if (initSizeEdges != 0){ - std::vector<int> tagEdges; if (myEdges.size() == 1){ for (std::vector<discreteEdge*>::iterator it = discreteEdges.begin(); it != discreteEdges.end(); it++){ @@ -1135,10 +1134,11 @@ void GModel::createTopologyFromMesh() allEdges.insert(allEdges.begin(), tagEdges.begin(), tagEdges.end()); it->second = allEdges; } - face2Edges.insert(std::make_pair(*itFace, tagEdges)); + if (!tagEdges.empty()) + face2Edges.insert(std::make_pair(*itFace, tagEdges)); } } - else{ + if (tagEdges.empty()){ // for each actual GEdge int num = maxEdgeNum()+1; while (!myEdges.empty()) { @@ -1234,6 +1234,7 @@ void GModel::createTopologyFromMesh() (*it)->parametrize(); } + } GModel *GModel::buildCutGModel(gLevelset *ls) diff --git a/Geo/GModel.h b/Geo/GModel.h index 5812fa461bfc030221880760b0ab5cc06b8d5664..5604637ad5ace8a90f6846ad6cbd6834807d2c8a 100644 --- a/Geo/GModel.h +++ b/Geo/GModel.h @@ -17,6 +17,7 @@ #include "GRegion.h" #include "SPoint3.h" #include "SBoundingBox3d.h" +#include "discreteFace.h" class Octree; class FM_Internals; @@ -26,6 +27,7 @@ class smooth_normals; class FieldManager; class CGNSOptions; class gLevelset; +class discreteFace; // A geometric model. The model is a "not yet" non-manifold B-Rep. class GModel @@ -309,6 +311,7 @@ class GModel // create topology from mesh void createTopologyFromMesh(); + void createTopologyFromFaces(std::vector<discreteFace*> &pFaces); // compute distance function void computeDistanceFunction(); diff --git a/Geo/MVertex.cpp b/Geo/MVertex.cpp index c65479574bff059ea000ccc4113f49815da81e08..7ee041dedc8a9876446ee270c8c10e7b52b0b436 100644 --- a/Geo/MVertex.cpp +++ b/Geo/MVertex.cpp @@ -327,6 +327,11 @@ bool reparamMeshEdgeOnFace(MVertex *v1, MVertex *v2, GFace *gf, bool reparamMeshVertexOnFace(const MVertex *v, const GFace *gf, SPoint2 ¶m) { + + if (gf->geomType() == GEntity::CompoundSurface){ + if(!gf->checkAspectRatio()) return false; + } + if (gf->geomType() == GEntity::CompoundSurface && v->onWhat()->dim() < 2){ GFaceCompound *gfc = (GFaceCompound*) gf; diff --git a/Mesh/meshGFace.cpp b/Mesh/meshGFace.cpp index 6d93676c53e2ec3d15b4ee926e4d726ab35b4a28..dd5b46863d5b27796f88c1242e532dbf2308af5a 100644 --- a/Mesh/meshGFace.cpp +++ b/Mesh/meshGFace.cpp @@ -30,6 +30,9 @@ #include "Field.h" #include "OS.h" #include "HighOrder.h" +#include "meshGEdge.h" +#include "meshPartitionOptions.h" +#include "meshPartition.h" void fourthPoint(double *p1, double *p2, double *p3, double *p4) { @@ -253,7 +256,10 @@ static bool meshGenerator(GFace *gf, int RECUR_ITER, // replace edges by their compounds if(gf->geomType() == GEntity::CompoundSurface){ bool correct = gf->checkTopology(); - if (!correct) return true; + if (!correct){ + partitionAndRemesh((GFaceCompound*) gf); + return true; + } std::set<GEdge*> mySet; std::list<GEdge*>::iterator it = edges.begin(); while(it != edges.end()){ @@ -327,7 +333,12 @@ static bool meshGenerator(GFace *gf, int RECUR_ITER, MVertex *here = *it; GEntity *ge = here->onWhat(); SPoint2 param; - reparamMeshVertexOnFace(here, gf, param); + bool paramOK = true; + paramOK = reparamMeshVertexOnFace(here, gf, param); + if(gf->geomType() == GEntity::CompoundSurface && !paramOK ){ + partitionAndRemesh((GFaceCompound*)gf); + return true; + } BDS_Point *pp = m->add_point(count, param[0], param[1], gf); m->add_geom(ge->tag(), ge->dim()); BDS_GeomEntity *g = m->get_geom(ge->tag(), ge->dim()); @@ -680,6 +691,9 @@ static bool meshGenerator(GFace *gf, int RECUR_ITER, return true; } + + + // this function buils a list of vertices (BDS) that are consecutive // in one given edge loop. We take care of periodic surfaces. In the // case of periodicty, some curves are present 2 times in the wire @@ -1293,6 +1307,122 @@ void meshGFace::operator() (GFace *gf) gf->geomType(), gf->triangles.size(), gf->mesh_vertices.size()); } +void partitionAndRemesh(GFaceCompound *gf) +{ + +#if !defined(HAVE_NO_MESH) && (defined(HAVE_CHACO) || defined(HAVE_METIS)) + + //Partition the mesh and createTopology for new faces + //----------------------------------------------------- + int N = gf->nbSplit; + meshPartitionOptions options; + options = CTX::instance()->partitionOptions; + options.num_partitions = N; + options.partitioner = 2; //METIS + options.algorithm = 1 ; + int ier = PartitionMesh(gf->model(), options); + int numv = gf->model()->maxVertexNum() + 1; + int nume = gf->model()->maxEdgeNum() + 1; + int numf = gf->model()->maxFaceNum() + 1; + std::vector<discreteFace*> pFaces; + createPartitionFaces(gf->model(), gf, N, pFaces); + gf->model()->createTopologyFromMesh(); //Faces(pFaces); + //gf->model()->createTopologyFromFaces(pFaces); + + //CreateOutputFile(CTX::instance()->outputFileName, CTX::instance()->mesh.format); + //Msg::Exit(1); + + //Remesh new faces (Compound Lines and Compound Surfaces) + //----------------------------------------------------- + + int numEdges = gf->model()->maxEdgeNum() - nume + 1; + printf("*** Created %d discretEdges \n", numEdges); + for (int i=0; i < numEdges; i++){ + std::vector<GEdge*>e_compound; + GEdge *pe = gf->model()->getEdgeByTag(nume+i);//partition edge + int num_gec = gf->model()->maxEdgeNum() + 1; + e_compound.push_back(pe); + printf("*** Remeshing discreteEdge %d with CompoundLine %d\n", pe->tag(), num_gec); + GEdge *gec = new GEdgeCompound(gf->model(), num_gec, e_compound); + + meshGEdge mge; + mge(gec);//meshing 1D + + gf->model()->remove(pe); + } + + int numVert = gf->model()->maxVertexNum() - numv + 1; + printf("*** Created %d discreteVert \n", numVert); + for (int i=0; i < numEdges; i++){ + GVertex *pv = gf->model()->getVertexByTag(numv+i);//partition vertex + gf->model()->remove(pv); + } + + std::list<GEdge*> b[4]; + std::set<MVertex*> allNod; + + for (int i=0; i < N; i++){ + std::list<GFace*> f_compound; + GFace *pf = gf->model()->getFaceByTag(numf+i);//partition face + //discreteFace *pf = pFaces[i];//partition face + int num_gfc = numf + N + i ; + f_compound.push_back(pf); + + printf("*** Remeshing discreteFace %d with CompoundSurface %d\n", pf->tag(), num_gfc); + GFace *gfc = new GFaceCompound(gf->model(), num_gfc, f_compound,b[0], b[1], b[2], b[3]); + meshGFace mgf; + mgf(gfc);//meshing 2D + + for(unsigned int j = 0; j < gfc->triangles.size(); ++j){ + MTriangle *t = gfc->triangles[j]; + std::vector<MVertex *> v(3); + for(int k = 0; k < 3; k++){ + v[k] = t->getVertex(k); + allNod.insert(v[k]); + } + gf->triangles.push_back(new MTriangle(v[0], v[1], v[2])); + } + + gf->model()->remove(pf); + } + + //Put new mesh in a new discreteFace + //----------------------------------------------------- + for(std::set<MVertex*>::iterator it = allNod.begin(); it != allNod.end(); ++it){ + gf->mesh_vertices.push_back(*it); + } + + //Remove mesh_vertices that belong to l_edges + //----------------------------------------------------- + std::list<GEdge*> l_edges = gf->edges(); + for( std::list<GEdge*>::iterator it = l_edges.begin(); it != l_edges.end(); it++){ + printf("boundary edge of face %d =%d size=%d\n", gf->tag(),(*it)->tag(), l_edges.size()); + std::vector<MVertex*> edge_vertices = (*it)->mesh_vertices; + std::vector<MVertex*>::const_iterator itv = edge_vertices.begin(); + for(; itv != edge_vertices.end(); itv++){ + std::vector<MVertex*>::iterator itve = std::find(gf->mesh_vertices.begin(), gf->mesh_vertices.end(), *itv); + if (itve != gf->mesh_vertices.end()) gf->mesh_vertices.erase(itve); + } + MVertex *vB = (*it)->getBeginVertex()->mesh_vertices[0]; + std::vector<MVertex*>::iterator itvB = std::find(gf->mesh_vertices.begin(), gf->mesh_vertices.end(), vB); + if (itvB != gf->mesh_vertices.end()) gf->mesh_vertices.erase(itvB); + MVertex *vE = (*it)->getEndVertex()->mesh_vertices[0]; + std::vector<MVertex*>::iterator itvE = std::find(gf->mesh_vertices.begin(), gf->mesh_vertices.end(), vE); + if (itvE != gf->mesh_vertices.end()) gf->mesh_vertices.erase(itvE); + } + + printf("*** Mesh of surface %d done by assembly remeshed faces\n", gf->tag()); + gf->meshStatistics.status = GFace::DONE; + + + +#else + return; +#endif + +} + + template<class T> static bool shouldRevert(MEdge &reference, std::vector<T*> &elements) { @@ -1369,3 +1499,5 @@ void orientMeshGFace::operator()(GFace *gf) } } } + + diff --git a/Mesh/meshGFace.h b/Mesh/meshGFace.h index 980321ff210f60982c8603d70d9312d9b27c4875..1d7a09d36e88d88d0cd2cce630cac43202015fc7 100644 --- a/Mesh/meshGFace.h +++ b/Mesh/meshGFace.h @@ -8,9 +8,11 @@ #include <vector> #include <set> +#include "GFaceCompound.h" class GFace; class MVertex; +class GFaceCompound; // Create the mesh of the face class meshGFace { @@ -43,5 +45,6 @@ void findTransfiniteCorners(GFace *gf, std::vector<MVertex*> &corners); int MeshTransfiniteSurface(GFace *gf); int MeshExtrudedSurface(GFace *gf, std::set<std::pair<MVertex*, MVertex*> > *constrainedEdges=0); +void partitionAndRemesh(GFaceCompound *gf); #endif diff --git a/Mesh/meshPartition.cpp b/Mesh/meshPartition.cpp index afba861b7bd8e996e4221cb3782273ef3ba1553b..f5d599c5463f1413f5d8ae0b257091ca37b992bd 100644 --- a/Mesh/meshPartition.cpp +++ b/Mesh/meshPartition.cpp @@ -255,13 +255,21 @@ int PartitionGraph(Graph &graph, meshPartitionOptions &options) &graph.adjncy[graph.section[iSec]], NULL, NULL, &wgtflag, &numflag, &options.num_partitions, metisOptions, &edgeCut, &graph.partition[graph.section[iSec]]); -// printf("METIS with weights\n"); -// wgtflag = 2; -// METIS_PartGraphKway -// (&n, &graph.xadj[graph.section[iSec]], -// &graph.adjncy[graph.section[iSec]], &graph.vwgts[graph.section[iSec]], NULL, &wgtflag, &numflag, -// &options.num_partitions, metisOptions, &edgeCut, -// &graph.partition[graph.section[iSec]]); + break; + case 3: // Nodal weight + printf("METIS with weights\n"); + metisOptions[0] = 1; + metisOptions[1] = options.edge_matching; + metisOptions[2] = 1; + metisOptions[3] = 1; + metisOptions[4] = 0; + wgtflag = 2; + graph.fillWeights(options.nodalWeights); + METIS_PartGraphKway + (&n, &graph.xadj[graph.section[iSec]], + &graph.adjncy[graph.section[iSec]], &graph.vwgts[graph.section[iSec]], NULL, &wgtflag, &numflag, + &options.num_partitions, metisOptions, &edgeCut, + &graph.partition[graph.section[iSec]]); break; } } @@ -1000,20 +1008,22 @@ int CreatePartitionBoundaries(GModel *model) return 1; } -void CreateTopologyFromPartition(GModel *model, GFaceCompound *gf, int N) +void createPartitionFaces(GModel *model, GFaceCompound *gf, int N, + std::vector<discreteFace*> &discrFaces) { printf("---> CreateTopologyFromPartition for Compound Face %d \n", gf->tag()); + std::vector<discreteFace*> discreteFaces;//delete this + // Compound is partitioned in N discrete faces //-------------------------------------------- - std::vector<discreteFace*> discreteFaces; std::vector<std::set<MVertex*> > allNodes; int numMax = model->maxFaceNum() + 1; for( int i =0; i < N; i++){ //printf("*** Created discreteFace %d \n", numMax+i); discreteFace *face = new discreteFace(model, numMax+i); discreteFaces.push_back(face); - model->add(face); + model->add(face);//delete this std::set<MVertex*> mySet; allNodes.push_back(mySet); } @@ -1027,24 +1037,18 @@ void CreateTopologyFromPartition(GModel *model, GFaceCompound *gf, int N) int part = e->getPartition(); for(int j = 0; j < 3; j++){ MVertex *v0 = e->getVertex(j); - if (v0->onWhat()->dim() == 2) allNodes[part-1].insert(v0); + allNodes[part-1].insert(v0); } discreteFaces[part-1]->triangles.push_back(new MTriangle(e->getVertex(0),e->getVertex(1),e->getVertex(2))); } } - for( int i =0; i < N; i++){ - GFace *face = model->getFaceByTag(numMax+i); - for (std::set<MVertex*>::iterator it = allNodes[i].begin(); it != allNodes[i].end(); it++){ - face->mesh_vertices.push_back(*it); - } + for( int i =0; i < N; i++){ + for (std::set<MVertex*>::iterator it = allNodes[i].begin(); it != allNodes[i].end(); it++){ + discreteFaces[i]->mesh_vertices.push_back(*it); + } } - //remove the discrete face that is not topologically correct - //for(it = _compound.begin() ; it != _compound.end() ; ++it){ - // model->remove(*it); - //} - return; } diff --git a/Mesh/meshPartition.h b/Mesh/meshPartition.h index 2b8728f6b4cc6320a194c4b452d99fce2fe6c932..0e3c860854085ff897d41ab6f0890c2675a89a94 100644 --- a/Mesh/meshPartition.h +++ b/Mesh/meshPartition.h @@ -29,6 +29,7 @@ int PartitionGraph(Graph &graph, meshPartitionOptions &options); int PartitionMesh(GModel *const model, meshPartitionOptions &options); int CreatePartitionBoundaries (GModel *model); void splitBoundaryEdges(GModel *model, std::set<partitionEdge*, Less_partitionEdge> &newEdges); -void CreateTopologyFromPartition(GModel *model, GFaceCompound *gf, int num_parts); +void createPartitionFaces(GModel *model, GFaceCompound * gf, int num_parts, + std::vector<discreteFace*> &pFaces); #endif diff --git a/Mesh/meshPartitionObjects.h b/Mesh/meshPartitionObjects.h index 309ed488c59c12816da4a1ef57c018af16136541..c0a934c9f0934ef2ddd1b6172f75a8b60aed7a44 100644 --- a/Mesh/meshPartitionObjects.h +++ b/Mesh/meshPartitionObjects.h @@ -147,6 +147,15 @@ class Graph // Translated vertex numbers start from 1 c2w[grVertMapIt->second.index] = i + 1; } + void fillWeights(std::vector<int> wgts) + { + int num = 0; + for(std::vector<int>::iterator it = wgts.begin(); it != wgts.end(); it++){ + vwgts[num]= 1.0; //*it; + num++; + } + } + void markSection() { section.push_back(numGrVert); } // Returns the next index for a graph vertex int getNextIndex() { return cIndex++; } diff --git a/Mesh/meshPartitionOptions.h b/Mesh/meshPartitionOptions.h index e1e2eb8ce7c880e570604b4b02c817636c4b0213..4488a8baa5387c4bd8525a8715bc11e102987e1b 100644 --- a/Mesh/meshPartitionOptions.h +++ b/Mesh/meshPartitionOptions.h @@ -57,6 +57,7 @@ struct meshPartitionOptions int algorithm; // 1 - Recursive // 2 - K-way + // 3 - Nodal weight int edge_matching; // 1 - Random matching // 2 - Heavy-edge matching // 3 - Sorted heavy-edge matching @@ -66,6 +67,9 @@ struct meshPartitionOptions // minimization of connectivity // along sub-domains) +//--NODAL WEIGHT + std::vector<int> nodalWeights; + //--Constructor meshPartitionOptions() diff --git a/benchmarks/step/capot.brep b/benchmarks/step/capot.brep new file mode 100644 index 0000000000000000000000000000000000000000..1c46c12143ca82e8456694ebd22e61fc5a118749 --- /dev/null +++ b/benchmarks/step/capot.brep @@ -0,0 +1,1532 @@ +DBRep_DrawableShape + +CASCADE Topology V1, (c) Matra-Datavision +Locations 0 +Curve2ds 80 +8 0 1 +1 1 0 -1 0 +8 0 1 +1 0 0 1 0 +7 0 0 1 2 2 1 1 1 0 + 0 2 0.75338360000000004 2 +8 0 0.75338360000000004 +1 0 0.75338360000000004 0 -1 +8 0 1 +1 0 1 1 0 +8 0 1 +7 0 0 3 4 2 0.083330000000000001 0.083330000000000001 0.36110999999999999 0.083330000000000001 0.63888999999999996 0.083330000000000001 0.91666999999999998 0.083330000000000001 + 0 4 1 4 +8 0 1 +1 0 1 0 -1 +8 0 1 +1 1 0 -1 0 +8 0 1 +1 0 0 1 0 +7 0 0 1 2 2 1 0.13923269999999999 1 0 + 0 2 1 2 +8 0 1 +1 0 1 0 -1 +7 0 0 1 2 2 1 0.27862979999999998 1 0.13923269999999999 + 0 2 1 2 +8 0 1 +1 0 1 0 -1 +7 0 0 1 2 2 1 1 1 0.27862979999999998 + 0 2 1 2 +8 0 1 +1 0 1 0 -1 +8 0 1 +1 0 1 1 0 +8 0 1 +1 0 0 1 0 +7 0 0 1 2 2 0 0.75338360000000004 0 1 + 0 2 1 2 +8 0 1 +7 0 0 3 4 2 0.91666999999999998 0.083330000000000001 0.91666999999999998 0.36110999999999999 0.91666999999999998 0.63888999999999996 0.91666999999999998 0.91666999999999998 + 0 4 1 4 +8 0 1 +1 1 1 0 -1 +8 0 1 +1 0 1 0 -1 +8 0 1 +1 1 1 -1 0 +8 0 1 +1 0 0 0 1 +8 0 1 +7 0 0 3 4 2 0.91666999999999998 0.083330000000000001 0.91666999999999998 0.36110999999999999 0.91666999999999998 0.63888999999999996 0.91666999999999998 0.91666999999999998 + 0 4 1 4 +8 0 1 +1 1 0 -1 0 +8 0 1 +1 1 1 -1 0 +8 0 1 +1 1 0 0 1 +8 0 1 +1 0 1 1 0 +8 0 1 +1 0 0 1 0 +8 0 1 +1 1 0 -1 0 +8 0 1 +1 1 1 -1 0 +8 0 1 +1 1 0 0 1 +8 0 1 +1 1 0 -1 0 +8 0 1 +1 0 0 1 0 +8 0 1 +1 1 0 0 1 +8 0 1 +1 1 0 0 1 +8 0 1 +1 1 1 -1 0 +8 0 1 +1 1 0 0 1 +8 0 1 +1 0 1 1 0 +8 0 1 +7 0 0 3 4 2 0.083330000000000001 0.083330000000000001 0.36110999999999999 0.083330000000000001 0.63888999999999996 0.083330000000000001 0.91666999999999998 0.083330000000000001 + 0 4 1 4 +7 0 0 1 2 2 0 0 0 1 + 0 2 0.75338360000000004 2 +8 0 0.75338360000000004 +1 1 0 0 1 +7 0 0 1 2 2 1 1 1 0.75338360000000004 + 0 2 1 2 +8 0 1 +7 0 0 3 4 2 0.083330000000000001 0.91666999999999998 0.083330000000000001 0.63888999999999996 0.083330000000000001 0.36110999999999999 0.083330000000000001 0.083330000000000001 + 0 4 1 4 +8 0 1 +1 0 1 1 0 +8 0 1 +1 0 0 1 0 +7 0 0 1 2 2 0 0.27862969999999998 0 1 + 0 2 1 2 +8 0 1 +1 1 0 0 1 +7 0 0 1 2 2 0 0.13923269999999999 0 0.27862969999999998 + 0 2 1 2 +8 0 1 +1 1 0 0 1 +7 0 0 1 2 2 0 0 0 0.13923269999999999 + 0 2 1 2 +8 0 1 +1 1 0 0 1 +8 0 1 +1 1 1 0 -1 +8 0 1 +7 0 0 3 4 2 0.083330000000000001 0.91666999999999998 0.083330000000000001 0.63888999999999996 0.083330000000000001 0.36110999999999999 0.083330000000000001 0.083330000000000001 + 0 4 1 4 +8 0 1 +1 1 1 -1 0 +8 0 1 +1 0 0 0 1 +8 0 1 +1 1 0 0 1 +8 0 1 +1 1 0 -1 0 +8 0 1 +1 1 1 -1 0 +8 0 1 +1 0 1 1 0 +8 0 1 +1 0 0 1 0 +8 0 1 +1 0 1 0 -1 +8 0 1 +1 1 0 -1 0 +8 0 1 +1 1 1 -1 0 +8 0 1 +1 0 1 0 -1 +8 0 1 +1 0 1 0 -1 +8 0 1 +1 1 1 -1 0 +8 0 1 +1 0 1 0 -1 +8 0 1 +7 0 0 3 4 2 0.083339999999999997 0.76395000000000002 0.083309999999999995 0.53707000000000005 0.083330000000000001 0.31019999999999998 0.083330000000000001 0.083330000000000001 + 0 4 1 4 +8 0 1 +6 0 7 0.16929 0.91686999999999996 0.27605000000000002 0.91652999999999996 0.38281999999999999 0.91690000000000005 0.48959000000000003 0.91642000000000001 0.59636 0.91681000000000001 0.70313000000000003 0.91662999999999994 0.80989999999999995 0.91666999999999998 0.91666999999999998 0.91666999999999998 +8 0 1 +7 0 0 3 4 2 0.16918 0.083330000000000001 0.41833999999999999 0.083330000000000001 0.66749999999999998 0.083330000000000001 0.91666999999999998 0.083330000000000001 + 0 4 1 4 +8 0 1 +7 0 0 3 4 2 0.16929 0.91686999999999996 0.14190333333333 0.865203333333327 0.113673333333348 0.81393666666669096 0.083339999999999997 0.76395000000000002 + 0 4 1 4 +8 0 1 +7 0 0 3 4 2 0.91666999999999998 0.91666999999999998 0.71450999999999998 0.91666999999999998 0.51234999999999997 0.91666000000000003 0.31019999999999998 0.91668000000000005 + 0 4 1 4 +8 0 1 +7 0 0 6 7 2 0.31019999999999998 0.91668000000000005 0.2681 0.78127000000000002 0.22692999999999999 0.64595000000000002 0.19697999999999999 0.50795000000000001 0.18056 0.36647000000000002 0.1709 0.22395000000000001 0.16918 0.083330000000000001 + 0 7 1 7 +8 0 1 +7 0 0 3 4 2 0.91666000000000003 0.76395000000000002 0.88632666666670301 0.81393666666660602 0.85809666666665496 0.86520333333335497 0.83070999999999995 0.91686999999999996 + 0 4 1 4 +8 0 1 +6 0 7 0.083330000000000001 0.91666999999999998 0.19009999999999999 0.91666999999999998 0.29687000000000002 0.91662999999999994 0.40364 0.91681000000000001 0.51041000000000003 0.91642000000000001 0.61717999999999995 0.91690000000000005 0.72394999999999998 0.91652999999999996 0.83070999999999995 0.91686999999999996 +8 0 1 +7 0 0 3 4 2 0.083330000000000001 0.083330000000000001 0.33250000000000002 0.083330000000000001 0.58165999999999995 0.083330000000000001 0.83082 0.083330000000000001 + 0 4 1 4 +8 0 1 +7 0 0 3 4 2 0.91666999999999998 0.083330000000000001 0.91666999999999998 0.31019999999999998 0.91669 0.53707000000000005 0.91666000000000003 0.76395000000000002 + 0 4 1 4 +8 0 1 +7 0 0 6 7 2 0.83082 0.083330000000000001 0.82909999999999995 0.22395000000000001 0.81943999999999995 0.36647000000000002 0.80301999999999996 0.50795000000000001 0.77307000000000003 0.64595000000000002 0.7319 0.78127000000000002 0.68979999999999997 0.91668000000000005 + 0 7 1 7 +8 0 1 +7 0 0 3 4 2 0.68979999999999997 0.91668000000000005 0.48764999999999997 0.91666000000000003 0.28549000000000002 0.91666999999999998 0.083330000000000196 0.91666999999999998 + 0 4 1 4 +Curves 51 +7 0 0 3 4 2 -20 0 734.11000000000001 21.129999999999999 0 739.36000000000001 67.209999999999994 0 745.80999999999995 118.23 0 753.48000000000002 + 0 4 1 4 +7 0 0 5 6 2 -20 -599.99945861262199 712.36456465342906 -19.999999999999901 -500.80654938171301 721.75497570075902 -20.000000000000099 -375.60598605900702 727.42637073701906 -20 -250.40396509951199 731.27206575625303 -20 -125.204820484 734.11000000000104 -20 -2.79829720328807e-14 734.11000000000001 + 0 6 0.75338360000000004 6 +7 0 0 3 4 2 206.96036331089499 -599.99845281650903 745.28021589208504 124.359804166879 -599.99874308774304 732.06339440172997 48.699442098378199 -599.99905313204204 722.203348587812 -20.000827302011601 -599.99937167416897 712.36991335126697 + 0 4 1 4 +7 0 0 4 5 2 206.96000000000001 -600 745.27999999999997 153.41 -472.80000000000001 748.38 126.895 -305.05000000000001 751.71333333333405 118.23 -134.77500000000001 753.48000000000002 118.23 5.5511151231257802e-14 753.48000000000002 + 0 5 1 5 +7 0 0 4 5 2 -600 0 624.90999999999997 -465.44999999999999 0 659.59749999999997 -310.85000000000002 0 691.53083333333404 -155.82499999999999 0 716.78499999999997 -20 0 734.11000000000001 + 0 5 1 5 +7 0 0 3 4 2 -600 -100 623.79999999999995 -600 -66.6666666666666 624.48333333333301 -600 -33.3333333333334 624.90999999999997 -600 0 624.90999999999997 + 0 4 1 4 +7 0 0 3 4 2 -600 -200 620.97000000000003 -600 -166.73333333333301 622.136666666667 -600 -133.36666666666699 623.10000000000002 -600 -100 623.79999999999995 + 0 4 1 4 +7 0 0 5 6 2 -600 -643.12 581.65999999999997 -599.99999999999795 -593.69999999999902 596.02999999999804 -600.00000000000296 -505.17000000000201 605.52000000000305 -599.99999999999704 -405.74999999999898 612.00999999999794 -600.00000000000102 -303.30000000000098 617.33000000000095 -600 -200 620.97000000000003 + 0 6 1 6 +7 0 0 4 5 2 -20 -723.76999999999998 692.28999999999996 -154.5625 -714.75750000000005 673.67750000000001 -311.99166666666702 -697.39916666666704 649.28750000000105 -468.41250000000002 -673.07000000000005 619.43499999999995 -600 -643.12 581.65999999999997 + 0 5 1 5 +7 0 0 4 5 2 -20.000827302011601 -599.99937167416897 712.36991335126697 -20.000992138787002 -640.58695547687296 708.51990836671405 -20.001242430267599 -676.52232321912697 704.01737364257303 -20.001503914974599 -705.57014043492097 698.67729502232305 -20.001758800270402 -723.77018963598596 692.28962313930197 + 0 5 1 5 +7 0 0 4 5 2 -600 -684.64999999999998 555.24000000000001 -600 -679.10000000000002 562.16499999999996 -600 -672.53916666666703 569.79583333333403 -600 -660.5575 576.59749999999997 -600 -643.12 581.65999999999997 + 0 5 1 5 +7 0 0 5 6 2 -600 -684.64999999999998 555.24000000000001 -487.479999999999 -722.01999999999805 577.08999999999799 -370.550000000002 -742.63000000000204 598.66000000000099 -236.80999999999901 -761.65999999999894 616.5 -131.18000000000001 -775.30999999999995 628.17999999999995 -20 -782.64999999999998 639.34000000000003 + 0 6 1 6 +7 0 0 4 5 2 -20.001754029624301 -723.76944809681197 692.28989327223201 -20.001716185603399 -753.03239070140296 682.01478998048299 -20.001693782679801 -769.30999911178299 669.38562271677995 -20.001690112224001 -778.38748081048595 652.92713180686098 -20.001676634013201 -782.64996675253099 639.33963975876895 + 0 5 1 5 +7 0 0 5 6 2 -808.76999999999998 -200 519.08000000000004 -782.97999999999797 -199.99999999999901 557.73999999999796 -732.59000000000196 -200.00000000000099 583.63000000000295 -679.02999999999895 -200 598.86999999999705 -626.38999999999999 -200 613.86000000000104 -600 -200 620.97000000000003 + 0 6 1 6 +7 0 0 4 5 2 -808.76999999999998 -200 519.08000000000004 -789.00750000000005 -316.4375 529.86749999999995 -760.85000000000002 -431.08749999999998 533.36916666666696 -729.61749999999995 -535.95000000000005 535.60000000000002 -676.88 -623 542.54999999999995 + 0 5 1 5 +7 0 0 4 5 2 -600 -643.12 581.65999999999997 -616.60000000000002 -639.34500000000003 576.89750000000004 -630.97750000000099 -636.05999999999995 573.10083333333296 -648.76750000000004 -632.07500000000005 564.27499999999998 -676.88 -623 542.54999999999995 + 0 5 1 5 +7 0 0 5 6 2 -844.00999999999999 -100 484.64999999999998 -810.63999999999805 -99.999999999999702 542.15999999999804 -764.04000000000406 -100 577.07000000000301 -706.61999999999603 -99.999999999999901 593.87999999999795 -650.00000000000205 -100 610.73000000000104 -600 -100 623.79999999999995 + 0 6 1 6 +7 0 0 4 5 2 -844.00999999999999 -100 484.64999999999998 -831.99749999999995 -128.47499999999999 499.83749999999998 -825.35666666666702 -143.66249999999999 509.63999999999999 -815.20749999999998 -162.01249999999999 515.5675 -808.76999999999998 -200 519.08000000000004 + 0 5 1 5 +7 0 0 5 6 2 -853.70000000000005 0 473.89999999999998 -816.93999999999801 0 536.63999999999805 -773.21000000000197 0 575.70000000000402 -713.73999999999899 0 593.66999999999598 -653.75999999999999 0 611.05000000000098 -600 0 624.90999999999997 + 0 6 1 6 +7 0 0 4 5 2 -853.70000000000005 0 473.89999999999998 -853.70000000000005 -50.149999999999999 473.89999999999998 -851.62583333333396 -72.116666666666703 473.33333333333297 -851.17250000000001 -83.025000000000006 475.60000000000002 -844.00999999999999 -100 484.64999999999998 + 0 5 1 5 +7 0 0 3 4 2 -676.88 -623 542.54999999999995 -663.56333333333305 -644.98333333333301 544.29999999999995 -649.39333333333298 -658.71666666666704 546.506666666667 -636.00999999999999 -667.79999999999995 548.74000000000001 + 0 4 1 4 +7 0 0 3 4 2 -636.00999999999999 -667.79999999999995 548.74000000000001 -622.64333333333298 -676.88333333333298 550.99000000000001 -610.06666666666695 -681.29999999999995 553.27333333333297 -600 -684.64999999999998 555.24000000000001 + 0 4 1 4 +7 0 0 4 5 2 118.23 0 753.48000000000002 118.23 134.77500000000001 753.48000000000002 126.895 305.05000000000001 751.71333333333303 153.41 472.80000000000001 748.38 206.96000000000001 600 745.27999999999997 + 0 5 1 5 +7 0 0 3 4 2 -20.000827302011501 599.99937167416897 712.36991335126697 48.699442098378199 599.99905313204204 722.203348587812 124.359804166879 599.99874308774395 732.06339440172997 206.96036331089499 599.99845281651005 745.28021589208504 + 0 4 1 4 +7 0 0 5 6 2 -20 0 734.11000000000001 -19.999999999999901 125.204820484 734.10999999999797 -20.000000000000099 250.40396509951299 731.27206575625905 -19.999999999999801 375.605986059006 727.42637073701405 -20 500.80654938171398 721.754975700763 -20 599.99945861262199 712.36456465342906 + 0 6 0.75338360000000004 6 +7 0 0 4 5 2 -20.001758800272 723.77018963598596 692.28962313930106 -20.001503914974698 705.57014043492097 698.67729502232203 -20.0012424302674 676.52232321912697 704.01737364257303 -20.000992138787101 640.58695547687296 708.51990836671405 -20.000827302011601 599.99937167416897 712.36991335126697 + 0 5 1 5 +7 0 0 4 5 2 -600 643.12 581.65999999999997 -468.41250000000002 673.07000000000005 619.43499999999995 -311.99166666666702 697.39916666666704 649.28750000000105 -154.5625 714.75750000000005 673.67750000000001 -20 723.76999999999998 692.28999999999996 + 0 5 1 5 +7 0 0 5 6 2 -600 200 620.97000000000003 -599.99999999999795 303.29999999999899 617.32999999999799 -600.00000000000296 405.75000000000102 612.01000000000295 -599.99999999999704 505.16999999999899 605.51999999999805 -600.00000000000102 593.70000000000005 596.030000000001 -600 643.12 581.65999999999997 + 0 6 1 6 +7 0 0 3 4 2 -600 100 623.79999999999995 -600 133.36666666666699 623.10000000000002 -600 166.73333333333301 622.136666666667 -600 200 620.97000000000003 + 0 4 1 4 +7 0 0 3 4 2 -600 0 624.90999999999997 -600 33.3333333333333 624.90999999999997 -600 66.6666666666666 624.48333333333403 -600 100 623.79999999999995 + 0 4 1 4 +7 0 0 4 5 2 -20.001676634013702 782.64996675253099 639.33963975876895 -20.001690112224299 778.38748081048504 652.92713180686098 -20.001693782679599 769.30999911178299 669.38562271677995 -20.001716185603598 753.03239070140296 682.01478998048401 -20.0017540296245 723.76944809681197 692.28989327223201 + 0 5 1 5 +7 0 0 5 6 2 -19.999999999999901 782.64999999999998 639.34000000000003 -131.17999999999901 775.30999999999699 628.17999999999904 -236.810000000001 761.66000000000497 616.50000000000205 -370.54999999999899 742.62999999999602 598.65999999999894 -487.48000000000098 722.020000000001 577.09000000000003 -600 684.64999999999998 555.24000000000001 + 0 6 1 6 +7 0 0 4 5 2 -600 643.12 581.65999999999997 -600 660.5575 576.59749999999997 -600 672.53916666666703 569.79583333333403 -600 679.10000000000002 562.16499999999996 -600 684.64999999999998 555.24000000000001 + 0 5 1 5 +7 0 0 5 6 2 -600 200 620.97000000000003 -626.38999999999703 199.99999999999901 613.85999999999899 -679.03000000000497 200.00000000000099 598.87000000000205 -732.58999999999605 200 583.62999999999897 -782.98000000000195 200 557.74000000000103 -808.76999999999998 200 519.08000000000004 + 0 6 1 6 +7 0 0 4 5 2 -676.88 623 542.54999999999995 -648.76750000000004 632.07500000000005 564.27499999999998 -630.97749999999996 636.05999999999995 573.10083333333296 -616.60000000000002 639.34500000000003 576.89750000000004 -600 643.12 581.65999999999997 + 0 5 1 5 +7 0 0 4 5 2 -676.88 623 542.54999999999995 -729.61749999999995 535.95000000000005 535.60000000000002 -760.85000000000002 431.08749999999998 533.36916666666605 -789.00750000000005 316.4375 529.86749999999995 -808.76999999999998 200 519.08000000000004 + 0 5 1 5 +7 0 0 5 6 2 -600 100 623.79999999999995 -649.99999999999795 99.999999999999702 610.72999999999797 -706.62000000000205 100 593.88000000000295 -764.03999999999803 99.999999999999801 577.069999999998 -810.63999999999999 100 542.15999999999997 -844.00999999999999 100 484.64999999999998 + 0 6 1 6 +7 0 0 4 5 2 -808.76999999999998 200 519.08000000000004 -815.20749999999998 162.01249999999999 515.5675 -825.35666666666702 143.66249999999999 509.63999999999999 -831.99749999999995 128.47499999999999 499.83749999999998 -844.00999999999999 100 484.64999999999998 + 0 5 1 5 +7 0 0 4 5 2 -844.00999999999999 100 484.64999999999998 -851.17250000000001 83.025000000000006 475.60000000000002 -851.62583333333396 72.116666666666703 473.33333333333297 -853.70000000000005 50.149999999999999 473.89999999999998 -853.70000000000005 0 473.89999999999998 + 0 5 1 5 +7 0 0 3 4 2 -600 684.64999999999998 555.24000000000001 -610.06666666666604 681.29999999999995 553.27333333333297 -622.64333333333298 676.88333333333401 550.99000000000001 -636.00999999999999 667.79999999999995 548.74000000000001 + 0 4 1 4 +7 0 0 3 4 2 -636.00999999999999 667.79999999999995 548.74000000000001 -649.39333333333298 658.71666666666601 546.50666666666598 -663.56333333333305 644.98333333333301 544.29999999999995 -676.88 623 542.54999999999995 + 0 4 1 4 +7 0 0 3 4 2 387.49236417506103 -726.76926265008694 756.72148224697901 323.97052003799701 -725.845952294874 741.64624353385705 250.75070255004499 -703.99676850652997 742.74828537986605 206.96036331089499 -599.99845281650903 745.28021589208504 + 0 4 1 4 +7 0 0 5 6 2 387.411153329027 -727.92683197258896 756.56059626225999 308.26118847105897 -732.56492183942396 736.11909598749799 202.55356203772499 -734.44189870614002 722.55680114366396 130.67826239563499 -732.43361895684097 711.85454711084697 58.666337677883099 -729.03496675967904 703.17067773364295 -20.001754029624301 -723.76944809681197 692.28989327223201 + 0 6 1 6 +7 0 0 3 4 2 387.40982795223698 -727.92994668502797 756.55945934533497 387.44874479719601 -727.258844778906 756.74036421487006 387.47267197384298 -727.08136632505204 756.69949264773402 387.49236417506103 -726.76926265008694 756.72148224697901 + 0 4 1 4 +7 0 0 5 6 2 -20.001676634013101 -782.64996675253099 639.33963975876895 40.985842885826997 -786.68183228283499 645.46745988634302 106.544359623663 -790.44886395150604 651.30421652113898 180.782178743521 -793.54236874473304 657.16572478618195 253.279324359085 -795.79801926868504 662.08571599799802 324.99936467440199 -797.16922590126603 666.29935884536906 + 0 6 1 6 +7 0 0 5 6 2 324.99936467440102 -797.16922590126603 666.29935884536906 349.98758116985698 -790.99325573825195 689.78203270974802 373.84649899161502 -781.61248973557599 715.52056939598401 382.750335854924 -768.09421317840599 739.34771785520195 386.22774216671201 -748.04214870021303 751.33013268591401 387.411153329027 -727.92683197258896 756.56059626225999 + 0 6 1 6 +7 0 0 3 4 2 387.49236417506103 726.76926265008694 756.72148224697901 387.47267197384298 727.08136632505102 756.69949264773402 387.44874479719601 727.25884477890702 756.74036421487006 387.40982795223698 727.92994668502797 756.55945934533497 + 0 4 1 4 +7 0 0 5 6 2 -20.0017540296246 723.76944809681197 692.28989327223201 58.666337677882403 729.03496675967699 703.17067773364101 130.67826239563701 732.43361895684598 711.85454711085299 202.55356203772399 734.44189870613604 722.55680114365896 308.26118847105897 732.56492183942601 736.11909598750196 387.411153329027 727.92683197258896 756.56059626225999 + 0 6 1 6 +7 0 0 3 4 2 206.96036331089499 599.99845281651005 745.28021589208504 250.750702550044 703.99676850652997 742.74828537986605 323.97052003799701 725.845952294874 741.64624353385705 387.49236417506103 726.76926265008694 756.72148224697901 + 0 4 1 4 +7 0 0 5 6 2 387.411153329027 727.92683197258896 756.56059626225999 386.22774216671098 748.04214870020996 751.33013268591105 382.75033585492599 768.09421317841202 739.347717855209 373.84649899161298 781.61248973556997 715.52056939597696 349.987581169858 790.99325573825502 689.78203270975098 324.99936467440199 797.16922590126603 666.29935884536906 + 0 6 1 6 +7 0 0 5 6 2 324.99936467440199 797.16922590126705 666.29935884536906 253.279324359084 795.79801926868095 662.08571599799598 180.782178743522 793.542368744741 657.165724786184 106.544359623662 790.44886395149899 651.30421652113796 40.985842885827203 786.68183228283897 645.46745988634405 -20.001676634013702 782.64996675253099 639.33963975876895 + 0 6 1 6 +Polygon3D 0 +PolygonOnTriangulations 80 +4 1 3 4 2 +p 6.39181415648434 1 0 0.444444444444444 0.722222222222222 1 +4 1 3 4 2 +p 6.39181415648434 1 0 0.444444444444444 0.722222222222222 1 +4 5 6 7 1 +p 6.39181415648434 1 0 0.251821996353195 0.502602798176597 0.7533836 +4 19 22 23 2 +p 6.39181415648434 1 0 0.251821996353195 0.502602798176597 0.7533836 +4 2 11 12 10 +p 1.78923153076899 1 0 0.444444444444444 0.722222222222222 1 +4 8 9 10 5 +p 6.39181415648434 1 0 0.444444444444444 0.722222222222222 1 +5 8 11 12 13 2 +p 6.39181415648434 1 0 0.228932989018926 0.534176974377493 0.767088487188747 1 +4 1 3 4 2 +p 6.39181415648434 1 0 0.333333333333333 0.666666666666667 1 +4 1 3 4 2 +p 6.39181415648434 1 0 0.333333333333333 0.666666666666667 1 +4 15 23 24 2 +p 1.03423922018169 1 0 0.444444444444444 0.722222222222222 1 +4 5 6 7 1 +p 6.39181415648434 1 0 0.444444444444444 0.722222222222222 1 +4 14 21 22 2 +p 1.01131993814033 1 0 0.444444444444444 0.722222222222222 1 +4 8 9 10 5 +p 6.39181415648434 1 0 0.444444444444444 0.722222222222222 1 +5 11 12 13 14 8 +p 6.39181415648434 1 0 0.178106728493375 0.415582366484542 0.707791183242271 1 +5 12 18 19 20 2 +p 6.39181415648434 1 0 0.178106728493375 0.415582366484542 0.707791183242271 1 +5 15 16 17 18 11 +p 6.39181415648434 1 0 0.298322443731606 0.596644887463212 0.798322443731606 1 +5 1 3 4 5 2 +p 6.39181415648434 1 0 0.298322443731606 0.596644887463212 0.798322443731606 1 +4 10 14 15 13 +p 1.78923153076899 1 0 0.444444444444444 0.722222222222222 1 +4 19 20 21 15 +p 6.39181415648434 1 0 0.444444444444444 0.722222222222222 1 +7 13 17 18 19 20 21 1 +p 0.336501101503064 1 0 0.222222222222222 0.422222222222222 0.60119619833643 0.769544177835583 0.884772088917792 1 +7 6 7 8 9 10 11 2 +p 6.39181415648434 1 0 0.222222222222222 0.422222222222222 0.60119619833643 0.769544177835583 0.884772088917792 1 +4 6 13 14 12 +p 6.39181415648434 1 0 0.271866556504496 0.635933278252248 1 +7 2 7 8 9 10 11 6 +p 1.73801618587084 1 0 0.217252442700581 0.393226921288052 0.556166253313487 0.719105585338923 0.859552792669461 1 +7 1 15 16 17 18 19 12 +p 6.39181415648434 1 0 0.217252442700581 0.393226921288052 0.556166253313487 0.719105585338923 0.859552792669461 1 +8 10 15 16 17 18 19 20 14 +p 1.01131993814033 1 0 0.0771138995297593 0.154227799059519 0.257046331765864 0.376583010062821 0.519491321465524 0.759745660732762 1 +8 1 3 4 5 6 7 8 2 +p 6.39181415648434 1 0 0.0771138995297593 0.154227799059519 0.257046331765864 0.376583010062821 0.519491321465524 0.759745660732762 1 +4 1 10 11 9 +p 6.39181415648434 1 0 0.444444444444444 0.722222222222222 1 +7 1 3 4 5 6 7 2 +p 0.336501101503064 1 0 0.3 0.483372536081864 0.647163271069615 0.799178991702561 0.89958949585128 1 +7 12 13 14 15 16 17 9 +p 6.39181415648434 1 0 0.3 0.483372536081864 0.647163271069615 0.799178991702561 0.89958949585128 1 +9 1 3 4 5 6 7 8 9 2 +p 1.01131993814033 1 0 0.0847953001880911 0.169590600376182 0.266512424275811 0.369350008606044 0.482727053017508 0.614363947610021 0.80718197380501 1 +9 10 16 17 18 19 20 21 22 15 +p 1.03423922018169 1 0 0.0847953001880911 0.169590600376182 0.266512424275811 0.369350008606044 0.482727053017508 0.614363947610021 0.80718197380501 1 +5 1 11 12 13 10 +p 1.01131993814033 1 0 0.444444444444444 0.666666666666667 0.833333333333333 1 +9 1 3 4 5 6 7 8 9 2 +p 1.03423922018169 1 0 0.0965197781360276 0.193039556272055 0.29208665768364 0.394393627623531 0.505133464486122 0.631866282618834 0.815933141309417 1 +9 1 3 4 5 6 7 8 9 2 +p 1.03369028461599 1 0 0.0965197781360276 0.193039556272055 0.29208665768364 0.394393627623531 0.505133464486122 0.631866282618834 0.815933141309417 1 +6 1 11 12 13 14 10 +p 1.03423922018169 1 0 0.4 0.625080132826299 0.775080132826299 0.887540066413149 1 +6 2 9 10 11 12 8 +p 0.336501101503064 1 0 0.210030317112914 0.420060634225827 0.640253673813347 0.820126836906674 1 +5 8 14 15 16 13 +p 0.336501101503064 1 0 0.254998596398007 0.557509124049699 0.778754562024849 1 +5 2 6 7 8 5 +p 6.39181415648434 1 0 0.4 0.661295136934184 0.830647568467092 1 +4 9 13 14 12 +p 1.65513347565736 1 0 0.444444444444444 0.722222222222222 1 +4 9 10 11 5 +p 6.39181415648434 1 0 0.444444444444444 0.722222222222222 1 +4 1 12 13 9 +p 6.39181415648434 1 0 0.334837155555555 0.544110377777778 0.7533836 +4 2 6 7 5 +p 6.39181415648434 1 0 0.334837155555555 0.544110377777778 0.7533836 +4 5 10 11 9 +p 1.65513347565736 1 0 0.333333333333333 0.666666666666667 1 +4 8 9 10 5 +p 6.39181415648434 1 0 0.333333333333333 0.666666666666667 1 +4 1 3 4 2 +p 6.39181415648434 1 0 0.381610935490252 0.690805467745126 1 +4 11 12 13 8 +p 6.39181415648434 1 0 0.381610935490252 0.690805467745126 1 +6 14 15 16 17 18 11 +p 6.39181415648434 1 0 0.444444444444444 0.666666666666667 0.805105083095377 0.902552541547688 1 +6 1 10 11 12 13 9 +p 6.39181415648434 1 0 0.444444444444444 0.666666666666667 0.805105083095377 0.902552541547688 1 +4 1 11 12 10 +p 1.00123533541022 1 0 0.444444444444444 0.722222222222222 1 +4 19 20 21 14 +p 6.39181415648434 1 0 0.444444444444444 0.722222222222222 1 +4 2 11 12 10 +p 1.03369028461599 1 0 0.444444444444444 0.722222222222222 1 +4 1 22 23 19 +p 6.39181415648434 1 0 0.444444444444444 0.722222222222222 1 +8 11 15 16 17 18 19 20 14 +p 1.74322968980655 1 0 0.166666666666667 0.333333333333333 0.483333333333333 0.618333333333333 0.753333333333333 0.876666666666666 1 +8 5 6 7 8 9 10 11 2 +p 6.39181415648434 1 0 0.166666666666667 0.333333333333333 0.483333333333333 0.618333333333333 0.753333333333333 0.876666666666666 1 +4 5 13 14 12 +p 6.39181415648434 1 0 0.444444444444444 0.722222222222222 1 +7 2 9 10 11 12 13 8 +p 0.334575943219359 1 0 0.168245098486514 0.336490196973029 0.521399882325375 0.714508733836577 0.857254366918289 1 +7 1 15 16 17 18 19 12 +p 6.39181415648434 1 0 0.168245098486514 0.336490196973029 0.521399882325375 0.714508733836577 0.857254366918289 1 +8 10 14 15 16 17 18 19 13 +p 1.00123533541022 1 0 0.222222222222222 0.444444444444444 0.603845113250847 0.735917847296382 0.844035552197791 0.922017776098895 1 +8 1 3 4 5 6 7 8 2 +p 6.39181415648434 1 0 0.222222222222222 0.444444444444444 0.603845113250847 0.735917847296382 0.844035552197791 0.922017776098895 1 +7 1 3 4 5 6 7 2 +p 0.334575943219359 1 0 0.15007693011773 0.30015386023546 0.466755908727092 0.642741771698651 0.821370885849326 1 +7 14 15 16 17 18 19 9 +p 6.39181415648434 1 0 0.15007693011773 0.30015386023546 0.466755908727092 0.642741771698651 0.821370885849326 1 +5 14 20 21 22 2 +p 6.39181415648434 1 0 0.247958680797708 0.578570255194653 0.789285127597326 1 +9 1 3 4 5 6 7 8 9 2 +p 1.00123533541022 1 0 0.286005636150626 0.452924882698659 0.570819483988416 0.680061793191657 0.776511825829161 0.865860485902998 0.932930242951499 1 +9 10 14 15 16 17 18 19 20 13 +p 1.03369028461599 1 0 0.286005636150626 0.452924882698659 0.570819483988416 0.680061793191657 0.776511825829161 0.865860485902998 0.932930242951499 1 +5 13 20 21 22 2 +p 1.00123533541022 1 0 0.203432809016699 0.406865618033397 0.703432809016699 1 +6 13 21 22 23 24 1 +p 1.03369028461599 1 0 0.160523909161114 0.304995427406117 0.469213829250455 0.734606914625227 1 +5 8 15 16 17 14 +p 0.334575943219359 1 0 0.444444444444444 0.666666666666667 0.833333333333333 1 +6 14 18 19 20 21 1 +p 0.334575943219359 1 0 0.229227592485992 0.458455184971985 0.660366209806428 0.830183104903214 1 +9 1 3 4 5 6 7 8 9 2 +p 1.78923153076899 1 0 0.187351016365644 0.339105339621815 0.465567275668624 0.579383018110753 0.693198760552881 0.80701450299501 0.903507251497505 1 +5 16 17 18 19 13 +p 1.78923153076899 1 0 0.190242808830466 0.443899887271086 0.721949943635543 1 +5 1 3 4 5 2 +p 1.73801618587084 1 0 0.190242808830466 0.443899887271086 0.721949943635543 1 +4 16 20 21 1 +p 1.78923153076899 1 0 0.444444444444444 0.722222222222222 1 +4 6 13 14 12 +p 1.73801618587084 1 0 0.444444444444444 0.722222222222222 1 +10 12 15 16 17 18 19 20 21 22 1 +p 1.73801618587084 1 0 0.186574055695196 0.354490705820873 0.490503192422671 0.600673306570128 0.699826409302839 0.79897951203555 0.898132614768261 0.94906630738413 1 +4 1 3 4 2 +p 1.65513347565736 1 0 0.444444444444444 0.722222222222222 1 +5 5 6 7 8 2 +p 1.65513347565736 1 0 0.4 0.664479831363873 0.832239915681936 1 +5 14 21 22 23 1 +p 1.74322968980655 1 0 0.4 0.664479831363873 0.832239915681936 1 +9 12 15 16 17 18 19 20 21 1 +p 1.65513347565736 1 0 0.123077236081459 0.246154472162918 0.369231708244376 0.492308944325835 0.615386180407294 0.738463416488753 0.869231708244376 1 +10 1 3 4 5 6 7 8 9 10 2 +p 1.74322968980655 1 0 0.112317463146885 0.213403179979081 0.304380325128058 0.395357470277035 0.486334615426012 0.606197172025193 0.742662889748659 0.871331444874329 1 +4 2 12 13 11 +p 1.74322968980655 1 0 0.444444444444444 0.722222222222222 1 +Surfaces 18 +8 0 0 3 5 118.23 0 753.48000000000002 118.23 -107.81999999999999 753.48000000000002 123.43000000000001 -236.94 752.38999999999999 137.5 -372.14999999999998 750.40999999999997 164.12 -498.24000000000001 747.75999999999999 206.96000000000001 -600 745.27999999999997 +67.209999999999994 0 745.80999999999995 67.209999999999994 -113.62 745.80999999999995 69.870000000000005 -241.43000000000001 743.70000000000005 78.849999999999994 -373.30000000000001 740.88 96.189999999999998 -499.10000000000002 737.07000000000005 124.34999999999999 -600 732.05999999999995 +21.129999999999999 0 739.36000000000001 21.129999999999999 -119.44 739.36000000000001 22.109999999999999 -245.88 736.89999999999998 26.390000000000001 -374.49000000000001 733.62 34.880000000000003 -499.83999999999997 729.23000000000002 48.700000000000003 -600 722.20000000000005 +-20 0 734.11000000000001 -20 -125.2 734.11000000000001 -20 -250.40000000000001 731.26999999999998 -20 -375.61000000000001 727.41999999999996 -20 -500.81 721.75 -20 -600 712.37 + +8 0 0 3 5 -20 0 734.11000000000001 -20 125.2 734.11000000000001 -20 250.40000000000001 731.26999999999998 -20 375.61000000000001 727.41999999999996 -20 500.81 721.75 -20 600 712.37 +21.129999999999999 0 739.36000000000001 21.129999999999999 119.44 739.36000000000001 22.109999999999999 245.88 736.89999999999998 26.390000000000001 374.49000000000001 733.62 34.880000000000003 499.83999999999997 729.23000000000002 48.700000000000003 600 722.20000000000005 +67.209999999999994 0 745.80999999999995 67.209999999999994 113.62 745.80999999999995 69.870000000000005 241.43000000000001 743.70000000000005 78.849999999999994 373.30000000000001 740.88 96.189999999999998 499.10000000000002 737.07000000000005 124.34999999999999 600 732.05999999999995 +118.23 0 753.48000000000002 118.23 107.81999999999999 753.48000000000002 123.43000000000001 236.94 752.38999999999999 137.5 372.14999999999998 750.40999999999997 164.12 498.24000000000001 747.75999999999999 206.96000000000001 600 745.27999999999997 + +8 0 0 5 5 -20 0 734.11000000000001 -20 -166.19 734.11000000000001 -20 -332.37 729.11000000000001 -20 -498.56 723.38999999999999 -20 -664.74000000000001 713.00999999999999 -20 -723.76999999999998 692.28999999999996 +-128.66 0 720.25 -128.66 -163.46000000000001 720.25 -128.25 -326.92000000000002 715.25999999999999 -128.05000000000001 -490.38999999999999 708.59000000000003 -127.84999999999999 -653.85000000000002 698.59000000000003 -127.65000000000001 -716.55999999999995 677.39999999999998 +-248.84 0 701.55999999999995 -248.84 -159.74000000000001 701.55999999999995 -248.91 -319.48000000000002 697.82000000000005 -248.94999999999999 -479.22000000000003 691.08000000000004 -248.97999999999999 -638.96000000000004 681.13 -249.02000000000001 -704.34000000000003 658.94000000000005 +-372.69 0 678.83000000000004 -372.69 -155.12 678.83000000000004 -373.44 -310.25 674.04999999999995 -373.81 -465.37 667.83000000000004 -374.19 -620.49000000000001 658.53999999999996 -374.56 -687.66999999999996 637.45000000000005 +-492.36000000000001 0 652.65999999999997 -492.36000000000001 -149.72 652.65999999999997 -493.31 -299.44999999999999 648.08000000000004 -493.77999999999997 -449.17000000000002 641.25999999999999 -494.25999999999999 -598.89999999999998 631.99000000000001 -494.73000000000002 -667.08000000000004 611.88 +-600 0 624.90999999999997 -600 -143.65000000000001 624.90999999999997 -600 -287.30000000000001 618.30999999999995 -600 -430.94999999999999 612.11000000000001 -600 -574.61000000000001 601.58000000000004 -600 -643.12 581.65999999999997 + +8 0 0 5 5 216.04239999999999 -555.46090000000004 750.38589999999999 250.47399999999999 -672.74609999999996 747.43920000000003 308.41199999999998 -726.00689999999997 747.57050000000004 376.92630000000003 -734.93430000000001 745.5367 450.2276 -729.89819999999997 764.42219999999998 464.89600000000002 -716.47239999999999 795.94569999999999 +157.79429999999999 -561.60910000000001 740.13279999999997 187.2963 -661.75040000000001 738.67809999999997 237.90459999999999 -712.21140000000003 733.30250000000001 297.3879 -733.90499999999997 738.13329999999996 336.79390000000001 -722.86109999999996 741.05730000000005 457.74950000000001 -733.52059999999994 749.26829999999995 +107.5467 -567.24639999999999 732.57420000000002 121.00579999999999 -651.63340000000005 728.48299999999995 147.2098 -700.51419999999996 724.34209999999996 178.89400000000001 -723.67449999999997 723.3306 213.3066 -737.27120000000002 724.76819999999998 227.7073 -737.78909999999996 728.07669999999996 +54.520319999999998 -573.33199999999999 725.17899999999997 65.185230000000004 -641.14549999999997 720.63750000000005 84.500510000000006 -685.62450000000001 719.52319999999997 107.0924 -712.26139999999998 715.85699999999997 128.559 -731.26679999999999 711.18179999999995 149.66480000000001 -736.21519999999998 711.71849999999995 +5.46326 -579.60249999999996 718.04049999999995 11.275919999999999 -630.30380000000002 714.36659999999995 19.692710000000002 -670.41309999999999 710.71169999999995 29.538399999999999 -701.37099999999998 708.07680000000005 38.922960000000003 -721.12929999999994 703.18320000000006 49.067439999999998 -735.0616 701.2056 +-38.75338 -586.23379999999997 710.89269999999999 -42.388300000000001 -619.08699999999999 707.53899999999999 -48.024940000000001 -653.33920000000001 703.08159999999998 -54.626130000000003 -685.57240000000002 697.31110000000001 -60.938409999999998 -712.47940000000006 691.42139999999995 -67.44341 -727.71759999999995 682.29639999999995 + +8 0 0 5 5 -600 0 624.90999999999997 -600 143.65000000000001 624.90999999999997 -600 287.30000000000001 618.30999999999995 -600 430.94999999999999 612.11000000000001 -600 574.61000000000001 601.58000000000004 -600 643.12 581.65999999999997 +-492.36000000000001 0 652.65999999999997 -492.36000000000001 149.72 652.65999999999997 -493.31 299.44999999999999 648.08000000000004 -493.77999999999997 449.17000000000002 641.25999999999999 -494.25999999999999 598.89999999999998 631.99000000000001 -494.73000000000002 667.08000000000004 611.88 +-372.69 0 678.83000000000004 -372.69 155.12 678.83000000000004 -373.44 310.25 674.04999999999995 -373.81 465.37 667.83000000000004 -374.19 620.49000000000001 658.53999999999996 -374.56 687.66999999999996 637.45000000000005 +-248.84 0 701.55999999999995 -248.84 159.74000000000001 701.55999999999995 -248.91 319.48000000000002 697.82000000000005 -248.94999999999999 479.22000000000003 691.08000000000004 -248.97999999999999 638.96000000000004 681.13 -249.02000000000001 704.34000000000003 658.94000000000005 +-128.66 0 720.25 -128.66 163.46000000000001 720.25 -128.25 326.92000000000002 715.25999999999999 -128.05000000000001 490.38999999999999 708.59000000000003 -127.84999999999999 653.85000000000002 698.59000000000003 -127.65000000000001 716.55999999999995 677.39999999999998 +-20 0 734.11000000000001 -20 166.19 734.11000000000001 -20 332.37 729.11000000000001 -20 498.56 723.38999999999999 -20 664.74000000000001 713.00999999999999 -20 723.76999999999998 692.28999999999996 + +8 0 0 5 5 -600 0 624.90999999999997 -600 -20 624.90999999999997 -600 -40 624.77999999999997 -600 -60 624.53999999999996 -600 -80 624.21000000000004 -600 -100 623.79999999999995 +-653.75999999999999 0 611.04999999999995 -653.75999999999999 -24.039999999999999 611.04999999999995 -653.67999999999995 -44.700000000000003 610.86000000000001 -653.13 -63.329999999999998 610.73000000000002 -652.10000000000002 -81.359999999999999 610.69000000000005 -650 -100 610.73000000000002 +-713.74000000000001 0 593.66999999999996 -713.74000000000001 -28.050000000000001 593.66999999999996 -713.00999999999999 -49.329999999999998 593.66999999999996 -711.83000000000004 -66.590000000000003 593.66999999999996 -710.02999999999997 -82.569999999999993 593.49000000000001 -706.62 -100 593.88 +-773.21000000000004 0 575.70000000000005 -773.21000000000004 -32.07 575.70000000000005 -771.88999999999999 -54 575.70000000000005 -770.37 -69.890000000000001 575.70000000000005 -768.88999999999999 -83.900000000000006 576.30999999999995 -764.03999999999996 -100 577.07000000000005 +-816.94000000000005 0 536.63999999999999 -816.94000000000005 -36.090000000000003 536.63999999999999 -818.88999999999999 -58.659999999999997 536.63999999999999 -817.84000000000003 -73.180000000000007 536.63999999999999 -815.79999999999995 -85 538.25 -810.63999999999999 -100 542.15999999999997 +-853.70000000000005 0 473.89999999999998 -853.70000000000005 -40.119999999999997 473.89999999999998 -852.50999999999999 -63.329999999999998 473.89999999999998 -851.38999999999999 -76.480000000000004 473.89999999999998 -849.74000000000001 -86.420000000000002 477.41000000000003 -844.00999999999999 -100 484.64999999999998 + +8 0 0 5 5 -600 -100 623.79999999999995 -600 -120.02 623.38 -600 -140.03999999999999 622.88 -600 -160.05000000000001 622.30999999999995 -600 -180.03999999999999 621.66999999999996 -600 -200 620.97000000000003 +-650 -100 610.73000000000002 -644.72000000000003 -120.59999999999999 611.59000000000003 -639.85000000000002 -139.56 612.36000000000001 -635.48000000000002 -158.25 612.90999999999997 -631.32000000000005 -177.99000000000001 613.35000000000002 -626.38999999999999 -200 613.86000000000001 +-706.62 -100 593.88 -699.67999999999995 -121.12 595.14999999999998 -692.80999999999995 -139.06 597.09000000000003 -686.46000000000004 -156.43000000000001 598.23000000000002 -681.61000000000001 -175.81999999999999 599.19000000000005 -679.02999999999997 -200 598.87 +-764.03999999999996 -100 577.07000000000005 -756.08000000000004 -121.68000000000001 579.09000000000003 -749.76999999999998 -138.56999999999999 580.75 -743.38 -154.62 582.5 -735.98000000000002 -173.55000000000001 583.41999999999996 -732.59000000000003 -200 583.63 +-810.63999999999999 -100 542.15999999999997 -802.70000000000005 -122.23 548.01999999999998 -794.61000000000001 -138.08000000000001 552.37 -788.13999999999999 -152.81 555.50999999999999 -788.20000000000005 -172.44999999999999 556.67999999999995 -782.98000000000002 -200 557.74000000000001 +-844.00999999999999 -100 484.64999999999998 -834.39999999999998 -122.78 496.80000000000001 -827.73000000000002 -137.59 505.72000000000003 -821.58000000000004 -151 512.00999999999999 -813.91999999999996 -169.61000000000001 516.26999999999998 -808.76999999999998 -200 519.08000000000004 + +8 0 0 5 5 -600 -200 620.97000000000003 -600 -303.30000000000001 617.33000000000004 -600 -405.75 612.00999999999999 -600 -505.17000000000002 605.51999999999998 -600 -593.70000000000005 596.02999999999997 -600 -643.12 581.65999999999997 +-626.38999999999999 -200 613.86000000000001 -625.75 -301.44 610.22000000000003 -624.55999999999995 -402.18000000000001 605.15999999999997 -622.38 -498.83999999999997 599.16999999999996 -619.44000000000005 -588.11000000000001 590.74000000000001 -613.27999999999997 -640.10000000000002 577.85000000000002 +-679.02999999999997 -200 598.87 -669.73000000000002 -299.69999999999999 596.54999999999995 -662.21000000000004 -398.47000000000003 593.08000000000004 -653.14999999999998 -493.69999999999999 589.39999999999998 -641.25 -579.40999999999997 582.97000000000003 -625.20000000000005 -637.38999999999999 574.42999999999995 +-732.59000000000003 -200 583.63 -719.5 -297.88999999999999 583.90999999999997 -704.57000000000005 -394.80000000000001 582.04999999999995 -687.34000000000003 -487.93000000000001 578.89999999999998 -665.84000000000003 -572.21000000000004 574.55999999999995 -638.12 -634.45000000000005 569.75999999999999 +-782.98000000000002 -200 557.74000000000001 -764.84000000000003 -295.82999999999998 562.20000000000005 -744.45000000000005 -390.63 562.80999999999995 -721.98000000000002 -481.39999999999998 562.03999999999996 -692.84000000000003 -564.00999999999999 560.63999999999999 -654.38999999999999 -630.25999999999999 559.92999999999995 +-808.76999999999998 -200 519.08000000000004 -792.96000000000004 -293.14999999999998 527.71000000000004 -772.09000000000003 -385.23000000000002 531.97000000000003 -748.38 -473.02999999999997 534.25999999999999 -719.07000000000005 -553.36000000000001 536.99000000000001 -676.88 -623 542.54999999999995 + +8 0 0 5 5 -20 -723.76999999999998 692.28999999999996 -20 -747.17999999999995 684.07000000000005 -20 -762.47000000000003 674.72000000000003 -20 -773.26999999999998 662.51999999999998 -20 -779.24000000000001 650.21000000000004 -20 -782.64999999999998 639.34000000000003 +-127.65000000000001 -716.55999999999995 677.39999999999998 -128.34 -738.71000000000004 669.77999999999997 -129.03 -753.76999999999998 660.67999999999995 -129.81999999999999 -764.75999999999999 649.91999999999996 -130.47 -770.84000000000003 638.39999999999998 -131.18000000000001 -775.30999999999995 628.17999999999995 +-249.02000000000001 -704.34000000000003 658.94000000000005 -246.63999999999999 -724.60000000000002 652.52999999999997 -244.13 -739.41999999999996 645.42999999999995 -241.69 -750.87 635.41999999999996 -239.25 -757.17999999999995 625.74000000000001 -236.81 -761.65999999999997 616.5 +-374.56 -687.66999999999996 637.45000000000005 -373.75 -706.74000000000001 631.75999999999999 -372.95999999999998 -719.90999999999997 624.82000000000005 -372.16000000000003 -731.16999999999996 615.70000000000005 -371.35000000000002 -737.88999999999999 606.88 -370.55000000000001 -742.63 598.65999999999997 +-494.73000000000002 -667.08000000000004 611.88 -493.52999999999997 -685.20000000000005 606.98000000000002 -491.82999999999998 -698.71000000000004 600.00999999999999 -490.38 -708.65999999999997 592.45000000000005 -488.93000000000001 -715.65999999999997 584.69000000000005 -487.48000000000002 -722.01999999999998 577.09000000000003 +-600 -643.12 581.65999999999997 -600 -657.07000000000005 577.61000000000001 -600 -667.91999999999996 572.5 -600 -674.99000000000001 566.75999999999999 -600 -680.21000000000004 560.77999999999997 -600 -684.64999999999998 555.24000000000001 + +8 0 0 5 5 -600 -643.12 581.65999999999997 -600 -657.07000000000005 577.61000000000001 -600 -667.91999999999996 572.5 -600 -674.99000000000001 566.75999999999999 -600 -680.21000000000004 560.77999999999997 -600 -684.64999999999998 555.24000000000001 +-613.27999999999997 -640.10000000000002 577.85000000000002 -612.42999999999995 -654.14999999999998 574.07000000000005 -610.55999999999995 -665.12 569.70000000000005 -609.01999999999998 -672.38999999999999 564.50999999999999 -607.49000000000001 -677.96000000000004 558.97000000000003 -606.03999999999996 -682.63999999999999 554.05999999999995 +-625.20000000000005 -637.38999999999999 574.42999999999995 -623.39999999999998 -651.04999999999995 571.95000000000005 -620.29999999999995 -661.86000000000001 566.48000000000002 -617.75999999999999 -669.55999999999995 561.84000000000003 -615.25 -675.45000000000005 557.09000000000003 -612.84000000000003 -680.30999999999995 552.78999999999996 +-638.12 -634.45000000000005 569.75999999999999 -634.25999999999999 -647.73000000000002 567.47000000000003 -631.01999999999998 -658.45000000000005 563.29999999999995 -627.34000000000003 -666.30999999999995 559.42999999999995 -623.70000000000005 -672.38 555.48000000000002 -620.21000000000004 -677.29999999999995 551.45000000000005 +-654.38999999999999 -630.25999999999999 559.92999999999995 -649.15999999999997 -643.42999999999995 557.59000000000003 -643.91999999999996 -653.87 556.53999999999996 -638.5 -661.94000000000005 554.45000000000005 -633.14999999999998 -668.23000000000002 552.35000000000002 -627.99000000000001 -673.25 550.09000000000003 +-676.88 -623 542.54999999999995 -668.88999999999999 -636.19000000000005 543.60000000000002 -660.63999999999999 -646.89999999999998 544.78999999999996 -652.29999999999995 -655.5 546.05999999999995 -644.03999999999996 -662.35000000000002 547.39999999999998 -636.00999999999999 -667.79999999999995 548.74000000000001 + +8 0 0 5 5 451.24579999999997 -712.1825 781.28009999999995 459.91370000000001 -732.61609999999996 790.81920000000002 471.5034 -766.05920000000003 778.90560000000005 487.13670000000002 -784.62649999999996 737.76990000000001 503.55489999999998 -790.39419999999996 699.06759999999997 518.96500000000003 -803.33770000000004 659.68079999999998 +419.34719999999999 -720.01160000000004 751.72619999999995 401.06849999999997 -745.67790000000002 737.08519999999999 394.03480000000002 -764.78719999999998 731.8356 388.37450000000001 -783.88620000000003 718.22230000000002 384.61529999999999 -794.88509999999997 685.77589999999998 379.22340000000003 -802.53340000000003 657.62300000000005 +215.1009 -725.97810000000004 730.80999999999995 227.57239999999999 -753.86329999999998 720.87040000000002 242.1585 -767.17570000000001 713.60720000000003 258.92329999999998 -783.51409999999998 705.63589999999999 276.1961 -795.12540000000001 678.59770000000003 292.88060000000002 -799.90030000000002 655.90880000000004 +141.9717 -722.08199999999999 714.97889999999995 138.9151 -750.17970000000003 706.78499999999997 138.01859999999999 -769.97789999999998 703.94820000000004 138.2946 -780.74620000000004 685.14490000000001 138.989 -788.88120000000004 665.21569999999997 139.27010000000001 -796.43179999999995 646.86770000000001 +46.081569999999999 -716.6146 705.58389999999997 43.098750000000003 -748.6499 698.48099999999999 40.832329999999999 -762.56230000000005 684.67570000000001 39.033830000000002 -780.30280000000005 672.66110000000003 37.344169999999998 -787.31849999999997 653.95759999999996 35.529299999999999 -787.06269999999995 639.12099999999998 +-65.342479999999995 -707.74810000000002 690.26760000000002 -63.821559999999998 -740.50620000000004 679.62509999999997 -62.824530000000003 -761.5308 670.50760000000002 -62.153959999999998 -772.75789999999995 653.72370000000001 -61.571919999999999 -777.4941 641.0172 -60.893810000000002 -781.64469999999994 630.53470000000004 + +8 0 0 5 5 -853.70000000000005 0 473.89999999999998 -853.70000000000005 40.119999999999997 473.89999999999998 -852.50999999999999 63.329999999999998 473.89999999999998 -851.38999999999999 76.480000000000004 473.89999999999998 -849.74000000000001 86.420000000000002 477.41000000000003 -844.00999999999999 100 484.64999999999998 +-816.94000000000005 0 536.63999999999999 -816.94000000000005 36.090000000000003 536.63999999999999 -818.88999999999999 58.659999999999997 536.63999999999999 -817.84000000000003 73.180000000000007 536.63999999999999 -815.79999999999995 85 538.25 -810.63999999999999 100 542.15999999999997 +-773.21000000000004 0 575.70000000000005 -773.21000000000004 32.07 575.70000000000005 -771.88999999999999 54 575.70000000000005 -770.37 69.890000000000001 575.70000000000005 -768.88999999999999 83.900000000000006 576.30999999999995 -764.03999999999996 100 577.07000000000005 +-713.74000000000001 0 593.66999999999996 -713.74000000000001 28.050000000000001 593.66999999999996 -713.00999999999999 49.329999999999998 593.66999999999996 -711.83000000000004 66.590000000000003 593.66999999999996 -710.02999999999997 82.569999999999993 593.49000000000001 -706.62 100 593.88 +-653.75999999999999 0 611.04999999999995 -653.75999999999999 24.039999999999999 611.04999999999995 -653.67999999999995 44.700000000000003 610.86000000000001 -653.13 63.329999999999998 610.73000000000002 -652.10000000000002 81.359999999999999 610.69000000000005 -650 100 610.73000000000002 +-600 0 624.90999999999997 -600 20 624.90999999999997 -600 40 624.77999999999997 -600 60 624.53999999999996 -600 80 624.21000000000004 -600 100 623.79999999999995 + +8 0 0 5 5 -38.75338 586.23379999999997 710.89269999999999 -42.388300000000001 619.08699999999999 707.53899999999999 -48.024940000000001 653.33920000000001 703.08159999999998 -54.626130000000003 685.57240000000002 697.31110000000001 -60.938409999999998 712.47940000000006 691.42139999999995 -67.44341 727.71759999999995 682.29639999999995 +5.46326 579.60249999999996 718.04049999999995 11.275919999999999 630.30380000000002 714.36659999999995 19.692710000000002 670.41309999999999 710.71169999999995 29.538399999999999 701.37099999999998 708.07680000000005 38.922960000000003 721.12929999999994 703.18320000000006 49.067439999999998 735.0616 701.2056 +54.520319999999998 573.33199999999999 725.17899999999997 65.185230000000004 641.14549999999997 720.63750000000005 84.500510000000006 685.62450000000001 719.52319999999997 107.0924 712.26139999999998 715.85699999999997 128.559 731.26679999999999 711.18179999999995 149.66480000000001 736.21519999999998 711.71849999999995 +107.5467 567.24639999999999 732.57420000000002 121.00579999999999 651.63340000000005 728.48299999999995 147.2098 700.51419999999996 724.34209999999996 178.89400000000001 723.67449999999997 723.3306 213.3066 737.27120000000002 724.76819999999998 227.7073 737.78909999999996 728.07669999999996 +157.79429999999999 561.60910000000001 740.13279999999997 187.2963 661.75040000000001 738.67809999999997 237.90459999999999 712.21140000000003 733.30250000000001 297.3879 733.90499999999997 738.13329999999996 336.79390000000001 722.86109999999996 741.05730000000005 457.74950000000001 733.52059999999994 749.26829999999995 +216.04239999999999 555.46090000000004 750.38589999999999 250.47399999999999 672.74609999999996 747.43920000000003 308.41199999999998 726.00689999999997 747.57050000000004 376.92630000000003 734.93430000000001 745.5367 450.2276 729.89819999999997 764.42219999999998 464.89600000000002 716.47239999999999 795.94569999999999 + +8 0 0 5 5 -600 643.12 581.65999999999997 -600 657.07000000000005 577.61000000000001 -600 667.91999999999996 572.5 -600 674.99000000000001 566.75999999999999 -600 680.21000000000004 560.77999999999997 -600 684.64999999999998 555.24000000000001 +-494.73000000000002 667.08000000000004 611.88 -493.52999999999997 685.20000000000005 606.98000000000002 -491.82999999999998 698.71000000000004 600.00999999999999 -490.38 708.65999999999997 592.45000000000005 -488.93000000000001 715.65999999999997 584.69000000000005 -487.48000000000002 722.01999999999998 577.09000000000003 +-374.56 687.66999999999996 637.45000000000005 -373.75 706.74000000000001 631.75999999999999 -372.95999999999998 719.90999999999997 624.82000000000005 -372.16000000000003 731.16999999999996 615.70000000000005 -371.35000000000002 737.88999999999999 606.88 -370.55000000000001 742.63 598.65999999999997 +-249.02000000000001 704.34000000000003 658.94000000000005 -246.63999999999999 724.60000000000002 652.52999999999997 -244.13 739.41999999999996 645.42999999999995 -241.69 750.87 635.41999999999996 -239.25 757.17999999999995 625.74000000000001 -236.81 761.65999999999997 616.5 +-127.65000000000001 716.55999999999995 677.39999999999998 -128.34 738.71000000000004 669.77999999999997 -129.03 753.76999999999998 660.67999999999995 -129.81999999999999 764.75999999999999 649.91999999999996 -130.47 770.84000000000003 638.39999999999998 -131.18000000000001 775.30999999999995 628.17999999999995 +-20 723.76999999999998 692.28999999999996 -20 747.17999999999995 684.07000000000005 -20 762.47000000000003 674.72000000000003 -20 773.26999999999998 662.51999999999998 -20 779.24000000000001 650.21000000000004 -20 782.64999999999998 639.34000000000003 + +8 0 0 5 5 -808.76999999999998 200 519.08000000000004 -792.96000000000004 293.14999999999998 527.71000000000004 -772.09000000000003 385.23000000000002 531.97000000000003 -748.38 473.02999999999997 534.25999999999999 -719.07000000000005 553.36000000000001 536.99000000000001 -676.88 623 542.54999999999995 +-782.98000000000002 200 557.74000000000001 -764.84000000000003 295.82999999999998 562.20000000000005 -744.45000000000005 390.63 562.80999999999995 -721.98000000000002 481.39999999999998 562.03999999999996 -692.84000000000003 564.00999999999999 560.63999999999999 -654.38999999999999 630.25999999999999 559.92999999999995 +-732.59000000000003 200 583.63 -719.5 297.88999999999999 583.90999999999997 -704.57000000000005 394.80000000000001 582.04999999999995 -687.34000000000003 487.93000000000001 578.89999999999998 -665.84000000000003 572.21000000000004 574.55999999999995 -638.12 634.45000000000005 569.75999999999999 +-679.02999999999997 200 598.87 -669.73000000000002 299.69999999999999 596.54999999999995 -662.21000000000004 398.47000000000003 593.08000000000004 -653.14999999999998 493.69999999999999 589.39999999999998 -641.25 579.40999999999997 582.97000000000003 -625.20000000000005 637.38999999999999 574.42999999999995 +-626.38999999999999 200 613.86000000000001 -625.75 301.44 610.22000000000003 -624.55999999999995 402.18000000000001 605.15999999999997 -622.38 498.83999999999997 599.16999999999996 -619.44000000000005 588.11000000000001 590.74000000000001 -613.27999999999997 640.10000000000002 577.85000000000002 +-600 200 620.97000000000003 -600 303.30000000000001 617.33000000000004 -600 405.75 612.00999999999999 -600 505.17000000000002 605.51999999999998 -600 593.70000000000005 596.02999999999997 -600 643.12 581.65999999999997 + +8 0 0 5 5 -844.00999999999999 100 484.64999999999998 -834.39999999999998 122.78 496.80000000000001 -827.73000000000002 137.59 505.72000000000003 -821.58000000000004 151 512.00999999999999 -813.91999999999996 169.61000000000001 516.26999999999998 -808.76999999999998 200 519.08000000000004 +-810.63999999999999 100 542.15999999999997 -802.70000000000005 122.23 548.01999999999998 -794.61000000000001 138.08000000000001 552.37 -788.13999999999999 152.81 555.50999999999999 -788.20000000000005 172.44999999999999 556.67999999999995 -782.98000000000002 200 557.74000000000001 +-764.03999999999996 100 577.07000000000005 -756.08000000000004 121.68000000000001 579.09000000000003 -749.76999999999998 138.56999999999999 580.75 -743.38 154.62 582.5 -735.98000000000002 173.55000000000001 583.41999999999996 -732.59000000000003 200 583.63 +-706.62 100 593.88 -699.67999999999995 121.12 595.14999999999998 -692.80999999999995 139.06 597.09000000000003 -686.46000000000004 156.43000000000001 598.23000000000002 -681.61000000000001 175.81999999999999 599.19000000000005 -679.02999999999997 200 598.87 +-650 100 610.73000000000002 -644.72000000000003 120.59999999999999 611.59000000000003 -639.85000000000002 139.56 612.36000000000001 -635.48000000000002 158.25 612.90999999999997 -631.32000000000005 177.99000000000001 613.35000000000002 -626.38999999999999 200 613.86000000000001 +-600 100 623.79999999999995 -600 120.02 623.38 -600 140.03999999999999 622.88 -600 160.05000000000001 622.30999999999995 -600 180.03999999999999 621.66999999999996 -600 200 620.97000000000003 + +8 0 0 5 5 -65.342479999999995 707.74810000000002 690.26760000000002 -63.821559999999998 740.50620000000004 679.62509999999997 -62.824530000000003 761.5308 670.50760000000002 -62.153959999999998 772.75789999999995 653.72370000000001 -61.571919999999999 777.4941 641.0172 -60.893810000000002 781.64469999999994 630.53470000000004 +46.081569999999999 716.6146 705.58389999999997 43.098750000000003 748.6499 698.48099999999999 40.832329999999999 762.56230000000005 684.67570000000001 39.033830000000002 780.30280000000005 672.66110000000003 37.344169999999998 787.31849999999997 653.95759999999996 35.529299999999999 787.06269999999995 639.12099999999998 +141.9717 722.08199999999999 714.97889999999995 138.9151 750.17970000000003 706.78499999999997 138.01859999999999 769.97789999999998 703.94820000000004 138.2946 780.74620000000004 685.14490000000001 138.989 788.88120000000004 665.21569999999997 139.27010000000001 796.43179999999995 646.86770000000001 +215.1009 725.97810000000004 730.80999999999995 227.57239999999999 753.86329999999998 720.87040000000002 242.1585 767.17570000000001 713.60720000000003 258.92329999999998 783.51409999999998 705.63589999999999 276.1961 795.12540000000001 678.59770000000003 292.88060000000002 799.90030000000002 655.90880000000004 +419.34719999999999 720.01160000000004 751.72619999999995 401.06849999999997 745.67790000000002 737.08519999999999 394.03480000000002 764.78719999999998 731.8356 388.37450000000001 783.88620000000003 718.22230000000002 384.61529999999999 794.88509999999997 685.77589999999998 379.22340000000003 802.53340000000003 657.62300000000005 +451.24579999999997 712.1825 781.28009999999995 459.91370000000001 732.61609999999996 790.81920000000002 471.5034 766.05920000000003 778.90560000000005 487.13670000000002 784.62649999999996 737.76990000000001 503.55489999999998 790.39419999999996 699.06759999999997 518.96500000000003 803.33770000000004 659.68079999999998 + +8 0 0 5 5 -676.88 623 542.54999999999995 -668.88999999999999 636.19000000000005 543.60000000000002 -660.63999999999999 646.89999999999998 544.78999999999996 -652.29999999999995 655.5 546.05999999999995 -644.03999999999996 662.35000000000002 547.39999999999998 -636.00999999999999 667.79999999999995 548.74000000000001 +-654.38999999999999 630.25999999999999 559.92999999999995 -649.15999999999997 643.42999999999995 557.59000000000003 -643.91999999999996 653.87 556.53999999999996 -638.5 661.94000000000005 554.45000000000005 -633.14999999999998 668.23000000000002 552.35000000000002 -627.99000000000001 673.25 550.09000000000003 +-638.12 634.45000000000005 569.75999999999999 -634.25999999999999 647.73000000000002 567.47000000000003 -631.01999999999998 658.45000000000005 563.29999999999995 -627.34000000000003 666.30999999999995 559.42999999999995 -623.70000000000005 672.38 555.48000000000002 -620.21000000000004 677.29999999999995 551.45000000000005 +-625.20000000000005 637.38999999999999 574.42999999999995 -623.39999999999998 651.04999999999995 571.95000000000005 -620.29999999999995 661.86000000000001 566.48000000000002 -617.75999999999999 669.55999999999995 561.84000000000003 -615.25 675.45000000000005 557.09000000000003 -612.84000000000003 680.30999999999995 552.78999999999996 +-613.27999999999997 640.10000000000002 577.85000000000002 -612.42999999999995 654.14999999999998 574.07000000000005 -610.55999999999995 665.12 569.70000000000005 -609.01999999999998 672.38999999999999 564.50999999999999 -607.49000000000001 677.96000000000004 558.97000000000003 -606.03999999999996 682.63999999999999 554.05999999999995 +-600 643.12 581.65999999999997 -600 657.07000000000005 577.61000000000001 -600 667.91999999999996 572.5 -600 674.99000000000001 566.75999999999999 -600 680.21000000000004 560.77999999999997 -600 684.64999999999998 555.24000000000001 + +Triangulations 18 +13 11 1 0.989461030649634 +-20 0 734.11 118.23 0 753.48 37.7724554183813 0 741.822866941015 76.8570661865569 0 747.370312071331 -20.0002757673372 -599.999610095597 712.368159334899 -20 -413.361203635038 724.536772539524 -20 -208.276167971417 731.484350585576 206.960181655448 -599.999226408255 745.280107946042 100.940740494112 -599.998850572323 729.354627465824 38.8601033287788 -599.999108431154 720.641979566364 165.983207656109 -472.592430123891 748.110149610256 133.225025700899 -281.970111705386 751.336094204444 121.514549066549 -135.195599183786 752.919790066349 1 0 0 0 0.555555555555556 0 0.277777777777778 0 1 1 1 0.665745317056019 1 0.33287265852801 0 1 0.444444444444444 1 0.722222222222222 1 0 0.771067010981074 0 0.465823025622507 0 0.232911512811253 2 4 13 12 13 7 6 11 12 9 8 11 4 3 13 3 1 7 6 12 7 9 11 10 6 5 10 6 10 11 7 13 3 +13 11 1 0.934714805901852 +-20 0 734.11 118.23 0 753.48 37.7724554183813 0 741.822866941015 76.8570661865569 0 747.370312071331 206.960181655448 599.999226408255 745.280107946042 128.89976 239.9856 751.87616 151.590719348361 405.665432256544 749.38183992884 175.158483149975 507.594339225168 747.386467686184 -20.0002757673372 599.999610095597 712.368159334899 75.7222845935669 599.998952976953 725.789289737669 139.733517556626 599.998699044636 734.971852394602 -20 277.776028326418 729.621588098145 -20 447.006864379201 722.908380829331 0 0 1 0 0.444444444444444 0 0.722222222222222 0 1 1 1 0.4 1 0.661295136934184 1 0.830647568467092 0 1 0.444444444444444 1 0.722222222222222 1 0 0.444444444444444 0 0.722222222222222 1 3 12 7 13 12 13 10 9 8 10 13 12 3 6 4 2 6 7 12 6 10 8 11 13 7 8 8 5 11 6 3 4 +83 141 1 1.3323186577896 +-600 0 624.91 -20 0 734.11 -410.140740740741 0 668.775432098766 -210.992592592593 0 705.942098765432 -600 -99.9999905997116 623.799345110611 -600 -55.5555555555556 624.544087791495 -600 -27.7777777777778 624.814878257887 -600 -199.999967554145 620.968654478712 -600 -155.593964334705 622.399794238683 -600 -127.803412208505 623.156995884774 -600 -643.12 581.66 -600 -588.197944293069 593.014490687452 -600 -490.283495748555 604.404928337226 -600 -349.417818683123 614.264139307273 -20.0008782074737 -723.7699094332 692.289879102883 -190.247255390148 -708.704811885537 667.006311545885 -369.707720522957 -685.600010566781 635.445520724896 -488.56844520659 -665.864908539194 610.276174592657 -20.0002757673372 -599.999610095597 712.368159334899 -20.0011977500397 -665.789062990324 704.686143952504 -20.001474400736 -698.85505323507 698.919898756191 -20 -413.361203635038 724.536772539524 -20 -208.276167971417 731.484350585576 -190.246781621126 -31.1846017845538 709.276481527067 -210.993308175932 -31.0518004448719 705.863772653243 -368.500369344562 -29.9213144238926 677.167717613653 -410.148562400352 -29.5833634935323 668.717409110594 -487.215705691619 -28.9081335211216 652.031403160333 -190.246701273246 -62.3689581636718 709.081399027872 -210.995297004605 -62.1033775702607 705.670004804567 -368.519379024587 -59.842541473248 676.969899624985 -410.170244717394 -59.1666594579689 668.51403744963 -487.237031701117 -57.8162008844596 651.811595219437 -190.246510193912 -112.259547487073 708.521010327037 -211.000590272325 -111.781597274146 705.11278708404 -368.569776807534 -107.712736683533 676.402561940753 -410.227723200705 -106.496285736741 667.932739921324 -487.293561293093 -104.065638396419 651.188859288452 -190.246372134596 -143.468729923552 708.02430979689 -211.004928965159 -142.858008405597 704.618443105689 -368.610926841954 -137.6586555092 675.90065179301 -410.274650851189 -136.104170983184 667.420094711947 -487.339710914522 -132.998005494318 650.644141315938 -190.246232517396 -174.661054230405 707.420722706726 -211.009860533126 -173.917758812565 704.017333231486 -368.657552621367 -167.589390577184 675.291822245653 -410.327819694066 -165.697263957733 666.799765606009 -487.391995383857 -161.916310451844 649.989143844339 -190.246114778161 -202.11034256001 706.803124085309 -211.014582592015 -201.25056003323 703.401941236015 -368.702062682927 -193.929890086613 674.670021272185 -410.378572966072 -191.7409377701 666.16764025924 -487.441901999488 -187.366701715363 649.325496661039 -190.246025507717 -224.498242939793 706.240139395983 -211.018639264704 -223.543641147856 702.840743500596 -368.740200942562 -215.414949604799 674.104178194997 -410.422058604161 -212.98422220592 665.593470452951 -487.484660515018 -208.126667055668 648.725519114037 -190.245684288573 -401.317008587207 699.80233720112 -211.053549379132 -399.630856574442 696.416087853628 -369.064882153719 -385.240756100164 667.687870279004 -410.792201263416 -380.929737526137 659.129993829481 -487.848568167626 -372.307017452426 642.091297010365 -190.245964573835 -548.15934934658 690.640454803417 -211.083303635762 -545.944347290094 687.265765239207 -369.337030361255 -526.900503698825 658.661999975138 -411.102395708125 -521.160360843428 650.116394242245 -488.153504435524 -509.646042823959 633.031436510385 -190.246112260286 -583.77252670665 687.46560871879 -211.090820325706 -581.458365888924 684.09394346109 -369.405163277238 -561.487835706603 655.547172407943 -411.180045035788 -555.450004751136 647.016877131937 -488.229832533103 -543.321222115028 629.943637760051 -190.246507602082 -649.118730678504 679.675897532214 -211.105942980854 -646.692789792716 676.308789651297 -369.541370483765 -625.508804282993 647.911103427172 -411.335251113997 -619.042626535854 639.432589133085 -488.382373865754 -605.995543064729 622.427659852048 -190.246834469097 -682.623760229321 673.796559055762 -211.115295356633 -680.21219837494 670.429562912619 -369.624816058687 -658.903523214 642.144679703517 -411.430302568253 -652.338143436592 633.715091537236 -488.475759286594 -639.033890624104 616.792157228678 1 0 0 0 0.666666666666667 0 0.333333333333333 0 1 0.1392327 1 0.0773515 1 0.03867575 1 0.2786298 1 0.216675533333333 1 0.177954116666667 1 1 1 0.871519113645388 1 0.700211265172573 1 0.489420532586287 0 1 0.298322443731606 1 0.596644887463212 1 0.798322443731606 1 0 0.7533836 0 0.862990888888889 0 0.931495444444444 0 0.501561603646805 0 0.250780801823403 0.298322443731606 0.03867575 0.333333333333333 0.03867575 0.596644887463212 0.03867575 0.666666666666667 0.03867575 0.798322443731606 0.03867575 0.298322443731606 0.0773515 0.333333333333333 0.0773515 0.596644887463212 0.0773515 0.666666666666667 0.0773515 0.798322443731606 0.0773515 0.298322443731606 0.1392327 0.333333333333333 0.1392327 0.596644887463212 0.1392327 0.666666666666667 0.1392327 0.798322443731606 0.1392327 0.298322443731606 0.177954116666667 0.333333333333333 0.177954116666667 0.596644887463212 0.177954116666667 0.666666666666667 0.177954116666667 0.798322443731606 0.177954116666667 0.298322443731606 0.216675533333333 0.333333333333333 0.216675533333333 0.596644887463212 0.216675533333333 0.666666666666667 0.216675533333333 0.798322443731606 0.216675533333333 0.298322443731606 0.250780801823403 0.333333333333333 0.250780801823403 0.596644887463212 0.250780801823403 0.666666666666667 0.250780801823403 0.798322443731606 0.250780801823403 0.298322443731606 0.2786298 0.333333333333333 0.2786298 0.596644887463212 0.2786298 0.666666666666667 0.2786298 0.798322443731606 0.2786298 0.298322443731606 0.501561603646805 0.333333333333333 0.501561603646805 0.596644887463212 0.501561603646805 0.666666666666667 0.501561603646805 0.798322443731606 0.501561603646805 0.298322443731606 0.700211265172573 0.333333333333333 0.700211265172573 0.596644887463212 0.700211265172573 0.666666666666667 0.700211265172573 0.798322443731606 0.700211265172573 0.298322443731606 0.7533836 0.333333333333333 0.7533836 0.596644887463212 0.7533836 0.666666666666667 0.7533836 0.798322443731606 0.7533836 0.298322443731606 0.862990888888889 0.333333333333333 0.862990888888889 0.596644887463212 0.862990888888889 0.666666666666667 0.862990888888889 0.798322443731606 0.862990888888889 0.298322443731606 0.931495444444444 0.333333333333333 0.931495444444444 0.596644887463212 0.931495444444444 0.666666666666667 0.931495444444444 0.798322443731606 0.931495444444444 2 24 29 24 2 4 24 25 29 25 24 4 25 4 26 34 29 30 2 29 34 23 34 39 34 23 2 39 44 23 40 44 39 45 49 44 44 49 23 39 34 35 23 49 54 29 25 30 30 35 34 35 30 31 26 31 30 31 26 27 36 31 32 31 36 35 30 25 26 35 36 41 40 45 44 45 40 41 45 46 50 46 45 41 46 41 42 50 46 51 40 35 41 45 50 49 36 37 41 35 40 39 4 3 26 49 50 55 19 22 64 54 59 22 59 54 55 64 59 60 59 64 22 22 23 54 19 64 69 21 20 74 15 21 79 74 20 69 74 69 70 79 21 74 20 19 69 64 65 69 65 64 60 60 55 56 51 56 55 56 51 52 61 56 57 56 61 60 54 49 55 60 61 65 16 79 80 69 65 70 74 70 75 79 16 15 75 79 74 71 75 70 76 80 75 75 80 79 70 65 66 17 16 80 65 61 66 60 59 55 50 51 55 46 47 51 32 31 27 27 3 28 32 28 33 28 32 27 33 28 7 32 33 37 3 1 28 37 36 32 47 46 42 38 42 37 57 56 52 48 52 47 53 57 52 62 61 57 47 42 43 52 51 47 37 33 38 42 41 37 7 6 33 7 28 1 6 38 33 6 5 38 38 5 10 43 48 47 48 43 10 53 48 9 48 53 52 58 53 8 9 48 10 8 53 9 43 38 10 53 58 57 38 43 42 57 58 63 66 71 70 71 66 67 62 67 66 67 62 63 72 67 68 67 72 71 61 62 66 71 72 77 76 81 80 81 76 77 81 82 17 82 81 77 82 77 78 17 82 18 76 71 77 81 17 80 72 73 77 71 76 75 63 68 67 68 63 13 14 63 58 14 13 63 62 57 63 68 13 73 73 78 77 78 73 12 83 78 12 78 83 82 83 11 18 11 83 12 73 13 12 83 18 82 68 73 72 8 14 58 27 26 3 +106 189 1 0.847847139018219 +387.492364175061 -726.769262650087 756.721482246979 206.960181655448 -599.999226408255 745.280107946042 351.02581555249 -723.644183417093 749.854905311419 321.050751251479 -716.223639782259 746.390927015237 296.413567758168 -705.694217034094 744.697081326117 274.925445785453 -692.183614358202 743.941645850236 254.445546398192 -674.289557560316 743.779470346417 235.320000057108 -651.47045157625 744.080095984819 220.423601043017 -627.864072702304 744.600467021292 -20.0002757673372 -599.999610095597 712.368159334899 100.940740494112 -599.998850572323 729.354627465824 38.8601033287788 -599.999108431154 720.641979566364 -20.0008782074737 -723.7699094332 692.289879102883 -20.0011977500397 -665.789062990324 704.686143952504 -20.001474400736 -698.85505323507 698.919898756191 387.410490640632 -727.928389328809 756.560027803797 306.081167106133 -731.283996407786 739.348544178273 196.01017524507 -732.386098012818 721.734404521329 86.2399591540638 -729.671109457405 706.534640278785 387.45377848301 -727.272506854483 756.694231525227 387.4747431786 -727.011651349676 756.711608005193 212.659501979985 -627.438597464568 743.406581346237 205.165741536301 -627.027895934472 742.258065776248 193.613321143276 -626.392783594146 740.511753579076 150.019865082281 -623.942319122948 734.154149126923 107.794485786387 -621.429501447891 728.274392744135 94.0815426125177 -620.574917296891 726.408225575266 42.2898211696478 -617.153928191005 719.469748073157 35.7935175540145 -616.702495910477 718.605099374432 227.116739603698 -650.74989506858 742.856871654625 219.17573811666 -650.053222182936 741.667786939699 206.898517944548 -648.973022280645 739.860267099925 160.400524042195 -644.772296026735 733.300528920853 115.437078867591 -640.414511371068 727.282570141265 100.886056130265 -638.922636000898 725.382787602808 46.1056832609308 -632.911146042775 718.341332866522 39.2397547756104 -632.113845077909 717.463750626281 245.678480992945 -673.370597078173 742.494502065658 237.165309740804 -672.47999276674 741.245731991836 223.96341605819 -671.09406032123 739.348411289127 173.768545176051 -665.642447527084 732.488013813806 125.305001346925 -659.88689768391 726.248868043122 109.676211087042 -657.896139907525 724.290415700844 51.0275999489311 -649.791760277421 717.052722464007 43.6820208504068 -648.708552075345 716.149889550282 265.555568376247 -691.205525328323 742.556912866462 256.432031134078 -690.255266296553 741.229583006258 242.245856275313 -688.770665703676 739.213635035297 188.122185008793 -682.848636343745 731.945270776665 135.924624693008 -676.448241360317 725.384288826443 119.140285838303 -674.202574756848 723.336122907891 56.3222754986826 -664.928344041429 715.797294570802 48.4585382006829 -663.675695279218 714.857515622551 288.244167164509 -705.751630284048 743.254251082807 278.435466670621 -704.862599878266 741.806788497486 263.141766180615 -703.467601889786 739.610411106212 204.572050316426 -697.793527685663 731.720842435796 148.11619610882 -691.434229073856 724.658043010757 130.007992590096 -689.151455115417 722.467861616967 62.3967261543598 -679.506731656296 714.46192108628 53.9367052861903 -678.182951842661 713.467830329299 310.387873681916 -715.470197223842 744.658995328577 299.942036482121 -714.735670119682 743.047906873178 283.604950796843 -713.578075918165 740.609064595843 220.749347296905 -708.740397395127 731.904320265862 160.115690943083 -703.015823965588 724.192519638377 140.702252396792 -700.890544406159 721.819446913568 68.3626794972354 -691.614907180448 713.224451347351 59.3154053148008 -690.313775102355 712.164563794395 339.684382031442 -723.207158489624 747.788921412894 328.502470257464 -722.781034669792 745.862843647356 310.906136011829 -722.101979029927 742.965503045456 242.510916684679 -719.022067289786 732.779947102465 176.243512433231 -714.789306445394 723.937069286322 155.057903505775 -713.085222345305 721.250378568112 76.3305124860709 -705.103452450308 711.662665299726 66.4957321771512 -703.934154093001 710.494557969712 353.545527741265 -725.260594620855 749.845638933806 342.089102530779 -725.01365988631 747.72122842549 323.97932035795 -724.611844337489 744.538899198641 253.042441385998 -722.552859121305 733.462551882062 184.028588511602 -719.210295225117 723.966086453813 161.972851300633 -717.766430674123 721.101178732758 80.1392384133835 -710.634622323637 710.95418099196 69.9261112315659 -709.558546588037 709.725433797659 375.779683480531 -726.858340122717 754.029245929937 364.044180367821 -726.939476320699 751.50669528692 345.2894635065 -727.038725285112 747.757618756588 270.43703701758 -726.78716256814 734.9552456565 196.832054407869 -725.018783416704 724.237349052908 173.310699883585 -724.043098383591 721.044602270108 86.3180800520046 -718.496420001294 709.871557420877 75.4871198956565 -717.601097402832 708.530806807257 375.69887902836 -727.284768630189 753.93588156664 356.727847430345 -727.673260519967 749.828144731202 279.924278745171 -728.424913266117 735.956136005909 203.774527799167 -727.514913586342 724.505231660184 179.434129385103 -726.798071956178 721.11860942631 89.6093385100742 -722.159269651371 709.338305487594 78.4464899602586 -721.371224246521 707.930360249469 368.372716077408 -727.964946328133 752.183362113364 289.717606875848 -729.733111253994 737.121341442077 210.901908662038 -729.669552508377 724.872086121393 185.697961065228 -729.210577245284 721.276430444165 92.9335007742692 -725.505220601363 708.839516502502 81.4328377042816 -724.830805100491 707.357871489401 0.08334 0.76395 0.08333 0.08333 0.0833279431422903 0.636432391472026 0.0833239997658137 0.533144401467274 0.083323547964801 0.447071782945036 0.0833245939303411 0.369606868193507 0.0833263738595983 0.292142280362908 0.0833282685164286 0.214677930990931 0.0833295042390382 0.149003938542579 0.91667 0.08333 0.453703333333333 0.08333 0.685186666666667 0.08333 0.91667 0.91667 0.91667 0.453703333333333 0.91667 0.685186666666667 0.16929 0.91687 0.311467855775015 0.916701325098003 0.50104650121155 0.916666086505851 0.708858169658644 0.916670080945639 0.132164074074078 0.848295404663929 0.108157901234574 0.805882990397815 0.108157901234574 0.149003938542579 0.132164074074078 0.149003938542579 0.16929 0.149003938542579 0.311467855775015 0.149003938542579 0.453703333333333 0.149003938542579 0.50104650121155 0.149003938542579 0.685186666666667 0.149003938542579 0.708858169658644 0.149003938542579 0.108157901234574 0.214677930990931 0.132164074074078 0.214677930990931 0.16929 0.214677930990931 0.311467855775015 0.214677930990931 0.453703333333333 0.214677930990931 0.50104650121155 0.214677930990931 0.685186666666667 0.214677930990931 0.708858169658644 0.214677930990931 0.108157901234574 0.292142280362908 0.132164074074078 0.292142280362908 0.16929 0.292142280362908 0.311467855775015 0.292142280362908 0.453703333333333 0.292142280362908 0.50104650121155 0.292142280362908 0.685186666666667 0.292142280362908 0.708858169658644 0.292142280362908 0.108157901234574 0.369606868193507 0.132164074074078 0.369606868193507 0.16929 0.369606868193507 0.311467855775015 0.369606868193507 0.453703333333333 0.369606868193507 0.50104650121155 0.369606868193507 0.685186666666667 0.369606868193507 0.708858169658644 0.369606868193507 0.108157901234574 0.453703333333333 0.132164074074078 0.453703333333333 0.16929 0.453703333333333 0.311467855775015 0.453703333333333 0.453703333333333 0.453703333333333 0.50104650121155 0.453703333333333 0.685186666666667 0.453703333333333 0.708858169658644 0.453703333333333 0.108157901234574 0.533144401467274 0.132164074074078 0.533144401467274 0.16929 0.533144401467274 0.311467855775015 0.533144401467274 0.453703333333333 0.533144401467274 0.50104650121155 0.533144401467274 0.685186666666667 0.533144401467274 0.708858169658644 0.533144401467274 0.108157901234574 0.636432391472026 0.132164074074078 0.636432391472026 0.16929 0.636432391472026 0.311467855775015 0.636432391472026 0.453703333333333 0.636432391472026 0.50104650121155 0.636432391472026 0.685186666666667 0.636432391472026 0.708858169658644 0.636432391472026 0.108157901234574 0.685186666666667 0.132164074074078 0.685186666666667 0.16929 0.685186666666667 0.311467855775015 0.685186666666667 0.453703333333333 0.685186666666667 0.50104650121155 0.685186666666667 0.685186666666667 0.685186666666667 0.708858169658644 0.685186666666667 0.108157901234574 0.76395 0.132164074074078 0.76395 0.16929 0.76395 0.311467855775015 0.76395 0.453703333333333 0.76395 0.50104650121155 0.76395 0.685186666666667 0.76395 0.708858169658644 0.76395 0.132164074074078 0.805882990397815 0.16929 0.805882990397815 0.311467855775015 0.805882990397815 0.453703333333333 0.805882990397815 0.50104650121155 0.805882990397815 0.685186666666667 0.805882990397815 0.708858169658644 0.805882990397815 0.16929 0.848295404663929 0.311467855775015 0.848295404663929 0.453703333333333 0.848295404663929 0.50104650121155 0.848295404663929 0.685186666666667 0.848295404663929 0.708858169658644 0.848295404663929 9 2 22 8 9 30 22 23 30 23 22 2 30 23 31 22 30 9 2 24 23 8 30 38 46 5 6 46 6 7 46 38 39 38 7 8 46 54 5 47 54 46 39 38 31 38 46 7 30 31 38 5 54 4 23 24 31 31 32 39 32 31 24 32 24 25 39 32 40 32 33 40 33 32 25 33 25 26 40 33 41 24 2 25 39 40 48 47 48 55 47 39 48 55 48 56 47 55 54 49 56 48 49 41 42 56 57 65 57 56 49 49 50 57 49 48 41 40 41 48 55 56 64 33 34 41 39 47 46 2 11 25 54 55 63 4 62 3 62 4 54 3 62 70 70 63 71 63 70 62 71 63 64 70 71 79 62 54 63 3 70 78 1 78 86 78 1 3 86 78 79 1 86 21 87 21 86 87 79 80 21 94 20 94 21 87 87 88 94 87 86 79 78 70 79 71 72 79 80 79 72 72 64 65 80 72 73 88 87 80 81 80 73 73 65 66 88 81 89 88 80 81 73 74 81 73 72 65 64 56 65 95 94 88 20 95 101 20 94 95 101 95 96 20 101 16 102 101 96 96 89 90 17 101 102 17 16 101 96 97 102 96 95 89 95 88 89 81 82 89 72 71 64 63 55 64 57 58 65 34 33 26 26 11 27 34 26 27 42 41 34 34 35 42 35 34 27 35 27 28 42 35 43 11 12 27 50 49 42 66 65 58 58 50 51 66 58 59 74 73 66 43 51 50 51 43 44 59 67 66 67 59 60 51 52 59 51 59 58 50 42 43 66 67 75 35 36 43 58 57 50 12 28 27 28 12 29 36 28 29 28 36 35 29 10 37 10 29 12 37 10 45 29 37 36 36 37 45 44 52 51 52 44 45 60 52 53 52 60 59 45 53 52 53 45 14 69 60 61 14 61 53 45 10 14 53 61 60 44 36 45 67 60 68 36 44 43 69 61 14 90 89 82 82 74 75 90 82 83 97 96 90 83 75 76 75 74 66 90 83 91 75 83 82 67 68 75 84 91 83 102 103 17 97 103 102 103 97 98 17 103 18 91 98 97 92 98 91 104 18 103 105 18 104 104 98 99 98 104 103 90 91 97 76 75 68 81 74 82 76 84 83 84 76 77 92 84 85 84 92 91 69 77 76 77 69 15 92 85 93 15 85 77 69 14 15 77 85 84 76 68 69 93 85 15 105 99 100 93 99 92 100 99 93 99 105 104 100 106 105 106 100 13 13 19 106 93 15 100 106 19 105 15 13 100 105 19 18 92 99 98 68 60 69 26 25 11 +75 125 1 2.48574665301919 +-600 0 624.91 -20 0 734.11 -410.140740740741 0 668.775432098766 -210.992592592593 0 705.942098765432 -20.0002757673372 599.999610095597 712.368159334899 -20 277.776028326418 729.621588098145 -20 447.006864379201 722.908380829331 -20.0008782074741 723.7699094332 692.289879102883 -20.0014178866947 692.837016059771 700.138932822838 -20.0010937496279 650.662217190383 706.773834964133 -600 643.12 581.66 -382.737825190752 683.625099256831 632.887023950974 -196.717985260504 707.998652214668 665.968331873236 -600 199.999943687854 620.968655318947 -600 424.599991193754 609.59352554658 -600 526.553251028806 600.871563786008 -600 582.052261385982 593.947748965666 -600 615.578930974202 588.215548875272 -600 99.9999905997116 623.799345110611 -600 144.480109739369 622.715884773663 -600 172.25677297668 621.893868312757 -600 44.4444444444444 624.672085048011 -600 72.2222222222222 624.306387174212 -410.160072307357 47.3333925044381 668.610802802895 -381.478377510505 47.7087794674574 674.472931055096 -210.994363215992 49.6828193156832 705.762306028148 -196.678718854928 49.8300402765991 708.125553194469 -410.188871576358 76.916190114034 668.331703364042 -381.504946112426 77.5261705488156 674.199079208296 -210.997009487034 80.733768714255 705.495679462694 -196.679437169561 80.9729809257373 707.857820631037 -410.227723200705 106.496285736741 667.932739921324 -381.540789910923 107.34080427164 673.806907578069 -211.000590272325 111.781597274146 705.11278708404 -196.680417420316 112.112768128488 707.473538277707 -410.305908099542 153.862418401054 667.060515880361 -381.612925698669 155.082309624211 672.947501470983 -211.007826223493 161.496552466025 704.270364435652 -196.682421268796 161.974859962201 706.628571708404 -410.362058147909 183.441266872929 666.37772143661 -381.664734074146 184.89531212339 672.273249493424 -211.01304455038 192.540279919529 703.606758925847 -196.683883064297 193.110320167974 705.963299246606 -410.422058445327 212.984145972439 665.593472607175 -381.72009708521 214.671695122601 671.497510587567 -211.018639249869 223.543561150584 702.84074560988 -196.68546463257 224.205010169957 705.19561995231 -410.513558693353 255.76133970674 664.278634398189 -381.804529203157 257.785911447532 670.194349735358 -211.027206520932 268.427376874742 701.548553806654 -196.687914033398 269.220553411884 703.901063043443 -410.861435673778 412.107469140599 657.493077241775 -382.125565251439 415.334135469973 663.434797651658 -211.060152373023 432.253526017259 694.766228104673 -196.697629740946 433.510865639227 697.110368773453 -410.948927043188 451.738167430424 655.150007340033 -382.206311762485 455.253458390563 661.091922403341 -211.068528236417 473.661216709463 692.393769433488 -196.700172048417 475.02683063736 694.735626388754 -411.188921866321 559.296182220556 646.635279917886 -382.427815879794 563.512292156089 652.556704618641 -211.091681496031 585.430699036638 683.702924266036 -196.707341188035 587.041973472552 686.037902638871 -411.296909673302 604.202418758734 641.495907638679 -382.527494792968 608.640754511772 647.394337866637 -211.102192766786 631.573728974919 678.428971666046 -196.71066467825 633.246443263827 680.761246104795 -411.330251655819 617.147936415069 639.709197168399 -382.558274308294 621.635697319204 645.598301220049 -211.105453347572 644.76729144061 676.593085266716 -196.71170566985 646.449161274949 678.924754136369 -411.427827711614 651.544437127736 633.875504282298 -382.648364195392 656.109469695427 639.730246786352 -211.115050651434 679.422195665103 670.594560531179 -196.714804209672 681.096794234309 672.925631739482 0 0 1 0 0.333333333333333 0 0.666666666666667 0 1 0.7533836 1 0.334837155555555 1 0.544110377777778 1 1 1 0.917794533333333 1 0.835589066666667 0 1 0.381610935490252 1 0.690805467745126 1 0 0.2786297 0 0.599238722222222 0 0.759543233333333 0 0.859408595324037 0 0.929704297662018 0 0.1392327 0 0.201186922222222 0 0.239908311111111 0 0.0618812 0 0.10055695 0.333333333333333 0.0618812 0.381610935490252 0.0618812 0.666666666666667 0.0618812 0.690805467745126 0.0618812 0.333333333333333 0.10055695 0.381610935490252 0.10055695 0.666666666666667 0.10055695 0.690805467745126 0.10055695 0.333333333333333 0.1392327 0.381610935490252 0.1392327 0.666666666666667 0.1392327 0.690805467745126 0.1392327 0.333333333333333 0.201186922222222 0.381610935490252 0.201186922222222 0.666666666666667 0.201186922222222 0.690805467745126 0.201186922222222 0.333333333333333 0.239908311111111 0.381610935490252 0.239908311111111 0.666666666666667 0.239908311111111 0.690805467745126 0.239908311111111 0.333333333333333 0.2786297 0.381610935490252 0.2786297 0.666666666666667 0.2786297 0.690805467745126 0.2786297 0.333333333333333 0.334837155555555 0.381610935490252 0.334837155555555 0.666666666666667 0.334837155555555 0.690805467745126 0.334837155555555 0.333333333333333 0.544110377777778 0.381610935490252 0.544110377777778 0.666666666666667 0.544110377777778 0.690805467745126 0.544110377777778 0.333333333333333 0.599238722222222 0.381610935490252 0.599238722222222 0.666666666666667 0.599238722222222 0.690805467745126 0.599238722222222 0.333333333333333 0.759543233333333 0.381610935490252 0.759543233333333 0.666666666666667 0.759543233333333 0.690805467745126 0.759543233333333 0.333333333333333 0.835589066666667 0.381610935490252 0.835589066666667 0.666666666666667 0.835589066666667 0.690805467745126 0.835589066666667 0.333333333333333 0.859408595324037 0.381610935490252 0.859408595324037 0.666666666666667 0.859408595324037 0.690805467745126 0.859408595324037 0.333333333333333 0.929704297662018 0.381610935490252 0.929704297662018 0.666666666666667 0.929704297662018 0.690805467745126 0.929704297662018 22 1 3 3 24 22 24 3 25 22 24 23 28 19 23 36 21 20 40 14 21 20 19 32 23 24 28 28 32 19 32 28 29 25 29 28 29 25 26 28 24 25 32 29 33 36 40 21 40 36 37 33 37 36 37 33 34 41 37 38 37 41 40 36 32 33 14 40 44 29 30 33 32 36 20 3 4 25 45 40 41 14 48 15 48 14 44 48 52 15 52 48 49 44 45 48 15 52 56 64 17 16 11 18 72 17 68 18 16 56 60 16 15 56 52 53 56 49 53 52 49 48 45 57 56 53 53 49 50 57 53 54 57 60 56 45 46 49 60 57 61 64 68 17 68 64 65 72 68 69 65 64 61 65 61 62 69 68 65 64 60 61 68 72 18 57 58 61 60 64 16 44 40 45 11 72 12 41 42 45 30 29 26 26 4 27 38 37 34 34 30 31 26 27 30 34 33 30 46 45 42 42 38 39 54 53 50 50 46 47 54 50 51 58 57 54 42 43 46 50 49 46 34 35 38 42 41 38 27 31 30 31 27 2 39 35 6 2 35 31 6 35 2 35 39 38 27 4 2 31 35 34 43 47 46 47 43 6 51 6 55 6 51 47 55 6 7 51 55 54 43 39 6 47 51 50 39 43 42 54 55 59 66 65 62 62 58 59 70 66 67 62 63 66 54 59 58 66 69 65 69 73 72 73 69 70 73 74 12 74 73 70 71 74 70 12 74 13 69 66 70 73 12 72 59 63 62 61 58 62 63 67 66 67 63 10 5 63 59 5 10 63 59 7 5 67 10 71 71 75 74 75 71 9 75 8 13 8 75 9 71 10 9 75 13 74 67 71 70 55 7 59 26 25 4 +90 154 1 0.546529807293812 +-853.7 0 473.9 -600 0 624.91 -835.241618809744 0 502.002924151635 -815.149065040098 0 525.931910539594 -792.686960206079 0 546.534401668298 -767.582022520297 0 564.148939689559 -738.512138326754 0 579.747489197717 -703.465388317879 0 594.217626911217 -651.122924008982 0 611.018551518401 -844.01 -100 484.65 -852.34688 -57.568 474.24048 -850.611401191177 -76.0495141576506 475.977090582538 -848.765851527078 -85.789954224427 478.38849886504 -846.768330437868 -92.7269018673979 481.071308453399 -600 -99.9999905997116 623.799345110611 -828.927643728924 -99.9999999999999 507.438699958419 -812.062268290741 -99.9999999999999 527.186709574106 -790.813641770736 -99.9999999999999 546.381184672736 -766.303803955038 -99.9999999999999 563.317713382293 -737.455786885414 -99.9999999999999 578.626519900672 -702.402838681722 -99.9999999999999 593.04328467397 -650.212436722727 -100 609.925545461659 -600 -55.5555555555556 624.544087791495 -600 -27.7777777777778 624.814878257887 -653.418374872402 -30.9419606610391 610.224909223048 -708.032808386989 -34.0942722065917 592.36287476495 -738.151658526529 -35.8789123618999 579.741375674075 -744.179369111338 -36.2450168963078 576.841959750839 -767.286443183634 -37.6885368271125 564.164470285085 -773.621866713122 -38.0978729540843 560.168528783473 -792.480532098243 -39.3610187672326 546.568476542867 -798.478052842185 -39.779228013164 541.610457787523 -814.983136810508 -40.9810696995837 525.983984961303 -820.016929069281 -41.3647684821707 520.541096175482 -837.254041603744 -42.7529591382064 498.8915624268 -653.197426517115 -43.3995563245599 610.163188840837 -707.636949899453 -46.7827741679696 592.353420010517 -737.721524933735 -48.6975962730721 579.767327240929 -743.748920530392 -49.0903807770011 576.875782661158 -766.873889643087 -50.6390492809556 564.231722113958 -773.218656642105 -51.0781976756745 560.246036090573 -792.110135027446 -52.433384555363 546.680145913574 -798.117357298097 -52.8821016325095 541.734359762239 -814.634746238779 -54.1718157772276 526.145929655097 -819.664252994041 -54.5836615805884 520.71616289179 -836.828059531789 -56.0743040901433 499.118488533482 -652.769377991577 -58.5492662359653 610.076705118015 -706.886781221988 -61.5216019642911 592.379533916186 -736.877507334357 -63.2024664243021 579.883285845943 -742.894216785361 -63.5471709587194 577.013210776083 -766.001929304708 -64.9060737689052 564.465250751574 -772.347726112722 -65.2913828990476 560.510360622831 -791.251206048468 -66.480520135674 547.050156407331 -797.262982944822 -66.8743450792498 542.143062694683 -813.783557079763 -68.006831819046 526.676595981859 -818.807905654544 -68.3687257460398 521.28922953405 -835.905692257633 -69.6802674481847 499.859435746965 -652.515981075463 -65.1363841382976 610.039029228845 -706.447154619753 -67.741706997718 592.414430171566 -736.373094843297 -69.2140580641949 579.981158193972 -742.380186424124 -69.515935699268 577.126603921196 -765.460789429987 -70.7058535340771 564.649592541037 -771.801611545257 -71.0432244043169 560.717816727942 -790.694946662596 -72.0844746633752 547.337799051347 -796.704407834954 -72.4293822080436 542.460288481138 -813.217947972862 -73.4215820596527 527.08745983408 -818.239078897814 -73.7388254399245 521.732706433658 -835.315219073281 -74.8897362563062 500.431885893272 -651.809764490526 -79.1225048991484 609.969001714999 -705.222960003258 -80.7137684161151 592.561922220307 -734.946120674245 -81.6108506608508 580.327511838342 -740.919329489463 -81.794624387623 577.522904076896 -763.889449848335 -82.5186423924179 565.277240127479 -770.205023551086 -82.7238601821656 561.421622582577 -789.034265545084 -83.3573640475452 548.307617864351 -795.026257151243 -83.5673449626276 543.52870838775 -811.496176346991 -84.1722704946088 528.468623736031 -816.504487947836 -84.3660987246355 523.22281988787 -833.532231707868 -85.07200372425 502.351637753369 -651.105775294451 -89.5329183553169 609.934806728332 -703.991454369734 -90.2949055136467 592.756776204308 -733.487689830097 -90.7230281258573 580.738129465664 -739.420326592807 -90.8106257422708 577.988426418202 -762.249060366127 -91.1554822813966 565.999635996264 -768.529676707867 -91.253187590008 562.229271807806 -787.264189434921 -91.554882065229 549.414683977525 -793.228898257163 -91.6549720340285 544.747163107265 -809.630451897659 -91.943898836187 530.040796175577 -814.619768382109 -92.0367505058741 524.918130069136 -831.588185099004 -92.3767281242759 504.530454490626 1 0 0 0 0.903480221863972 0 0.806960443727945 0 0.70791334231636 0 0.605606372376469 0 0.494866535513878 0 0.368133717381166 0 0.184066858690583 0 1 1 1 0.4 1 0.625080132826299 1 0.775080132826299 1 0.887540066413149 0 1 0.915204699811909 1 0.830409399623818 1 0.733487575724189 1 0.630649991393956 1 0.517272946982492 1 0.385636052389979 1 0.19281802619499 1 0 0.555555555555556 0 0.277777777777778 0.19281802619499 0.277777777777778 0.385636052389979 0.277777777777778 0.494866535513878 0.277777777777778 0.517272946982492 0.277777777777778 0.605606372376469 0.277777777777778 0.630649991393956 0.277777777777778 0.70791334231636 0.277777777777778 0.733487575724189 0.277777777777778 0.806960443727945 0.277777777777778 0.830409399623818 0.277777777777778 0.915204699811909 0.277777777777778 0.19281802619499 0.4 0.385636052389979 0.4 0.494866535513878 0.4 0.517272946982492 0.4 0.605606372376469 0.4 0.630649991393956 0.4 0.70791334231636 0.4 0.733487575724189 0.4 0.806960443727945 0.4 0.830409399623818 0.4 0.915204699811909 0.4 0.19281802619499 0.555555555555556 0.385636052389979 0.555555555555556 0.494866535513878 0.555555555555556 0.517272946982492 0.555555555555556 0.605606372376469 0.555555555555556 0.630649991393956 0.555555555555556 0.70791334231636 0.555555555555556 0.733487575724189 0.555555555555556 0.806960443727945 0.555555555555556 0.830409399623818 0.555555555555556 0.915204699811909 0.555555555555556 0.19281802619499 0.625080132826299 0.385636052389979 0.625080132826299 0.494866535513878 0.625080132826299 0.517272946982492 0.625080132826299 0.605606372376469 0.625080132826299 0.630649991393956 0.625080132826299 0.70791334231636 0.625080132826299 0.733487575724189 0.625080132826299 0.806960443727945 0.625080132826299 0.830409399623818 0.625080132826299 0.915204699811909 0.625080132826299 0.19281802619499 0.775080132826299 0.385636052389979 0.775080132826299 0.494866535513878 0.775080132826299 0.517272946982492 0.775080132826299 0.605606372376469 0.775080132826299 0.630649991393956 0.775080132826299 0.70791334231636 0.775080132826299 0.733487575724189 0.775080132826299 0.806960443727945 0.775080132826299 0.830409399623818 0.775080132826299 0.915204699811909 0.775080132826299 0.19281802619499 0.887540066413149 0.385636052389979 0.887540066413149 0.494866535513878 0.887540066413149 0.517272946982492 0.887540066413149 0.605606372376469 0.887540066413149 0.630649991393956 0.887540066413149 0.70791334231636 0.887540066413149 0.733487575724189 0.887540066413149 0.806960443727945 0.887540066413149 0.830409399623818 0.887540066413149 0.915204699811909 0.887540066413149 24 2 9 9 8 25 25 8 26 9 25 24 24 25 36 23 36 47 36 23 24 47 36 37 23 47 58 26 37 36 37 26 27 48 37 38 37 48 47 36 25 26 47 48 59 8 7 26 7 27 26 27 7 28 28 6 29 6 28 7 29 6 30 28 29 40 27 28 39 38 39 49 38 27 39 50 49 39 38 49 48 40 30 41 40 39 28 41 30 31 51 39 40 30 40 29 52 40 41 6 5 30 27 38 37 48 49 60 69 15 23 69 58 59 59 60 70 59 48 60 70 60 71 59 70 69 47 59 58 69 70 81 15 80 22 80 15 69 22 80 81 21 81 82 81 80 69 82 81 71 81 21 22 70 71 81 60 61 71 69 23 58 50 51 61 51 50 39 61 51 62 72 71 61 62 52 63 52 62 51 63 52 53 62 63 73 51 40 52 61 62 73 82 72 83 82 71 72 83 72 73 82 83 20 83 84 20 84 83 73 74 84 73 20 84 19 72 61 73 82 20 21 73 63 74 61 60 50 50 60 49 41 42 52 42 41 31 31 5 32 32 4 33 4 32 5 33 4 34 32 33 43 31 32 43 64 63 53 53 42 43 64 53 54 64 74 63 43 54 53 44 54 43 55 65 54 54 65 64 42 31 43 64 65 76 44 43 33 53 52 42 45 44 34 34 44 33 3 1 35 35 1 11 3 35 34 34 4 3 46 34 35 55 45 56 45 55 44 56 45 46 65 55 66 46 11 57 11 46 35 57 11 12 46 57 56 45 34 46 67 55 56 44 55 54 68 56 57 74 75 86 74 64 75 76 66 77 76 75 64 77 66 67 76 77 88 66 76 65 75 76 87 85 86 19 86 85 74 19 86 18 85 19 84 87 88 18 88 87 76 18 88 17 87 18 86 86 75 87 77 78 88 74 85 84 67 68 78 68 67 56 78 68 79 67 78 77 79 12 13 12 79 68 79 13 14 68 57 12 78 79 90 89 90 17 90 89 78 17 90 16 89 17 88 16 14 10 14 16 90 90 79 14 78 89 88 66 55 67 31 30 5 +67 110 1 0.930346298473507 +-844.01 -100 484.65 -600 -99.9999905997116 623.799345110611 -828.927643728924 -99.9999999999999 507.438699958419 -812.062268290741 -99.9999999999999 527.186709574106 -790.813641770736 -99.9999999999999 546.381184672736 -766.303803955038 -99.9999999999999 563.317713382293 -737.455786885414 -99.9999999999999 578.626519900672 -702.402838681722 -99.9999999999999 593.04328467397 -650.212436722727 -100 609.925545461659 -808.77 -200 519.08 -826.530707209267 -140.65172991922 505.796087486664 -818.956913580247 -160.001234567901 512.56975308642 -813.55899691358 -177.642843364198 516.308757716049 -600 -199.999967554145 620.968654478712 -797.458619676349 -200 533.237855632236 -783.771388243292 -200 545.953633789342 -762.674379788868 -200 560.840825638572 -735.316416670017 -200 575.529288291616 -700.582486771103 -200 590.027014452652 -643.663819456082 -200 608.659276100384 -600 -155.593964334705 622.399794238683 -600 -127.803412208505 623.156995884774 -644.955770217178 -127.634597591525 610.71612477813 -656.834585115949 -127.591375840372 607.208201041656 -694.193585176333 -127.458072318559 595.147705527012 -718.691507569477 -127.371619800868 585.908457727626 -728.077322208956 -127.338368622634 581.956925802449 -754.496887613387 -127.243146505001 569.125442769333 -782.417842880307 -127.136584598157 551.591962493755 -804.287925208413 -127.043962389419 533.298366118842 -819.114209926058 -126.972567997139 517.308662230784 -642.020132041782 -143.746620142647 611.106436170779 -653.399981724807 -143.564302997794 607.771796275706 -689.655431732163 -143.006423387665 596.232701021233 -713.710202051134 -142.645549440752 587.382907989736 -722.969542804168 -142.506654043537 583.605760113061 -749.130540694773 -142.108295043437 571.388231851914 -776.881621755171 -141.661201001357 554.81352856156 -798.635820718498 -141.27111210319 537.639540183225 -813.352518446242 -140.968926904691 522.699157250362 -640.16082771094 -154.510282548166 611.312405413706 -651.230919227117 -154.241589226145 608.08214955046 -686.816416620564 -153.421065191757 596.844734438107 -710.620256762797 -152.891974331559 588.209545212456 -719.813724584775 -152.688726122178 584.526739532176 -745.858267020939 -152.106798488962 572.638158754862 -773.54965359647 -151.453958800659 556.577848166784 -795.230714205263 -150.881428886325 540.01367496058 -809.818125973892 -150.433236737503 525.655923044212 -638.381916413522 -165.413314141922 611.469698778158 -649.166133221577 -165.093488983003 608.33202652708 -684.148972738623 -164.118625758224 597.352901043656 -707.740762073565 -163.4924471842 588.895998355743 -716.882615125007 -163.252527147425 585.291052729824 -742.848380551794 -162.567260032009 573.674141896087 -770.505756876203 -161.79915302681 558.043230975977 -792.095386110162 -161.121231461269 541.997344593068 -806.488265587486 -160.583539960774 528.144085612271 -635.864598314109 -182.256904916769 611.607401135815 -646.279234768091 -181.983521861355 608.581209301411 -680.520355162753 -181.152674016863 597.897143596349 -703.866101036478 -180.62276112853 589.641663592704 -712.949852158839 -180.420724137164 586.125997050034 -738.826354203732 -179.846351696042 574.827321747508 -766.417063841208 -179.203726752152 559.714103767842 -787.806789585512 -178.629817228264 544.307521721757 -801.816870326442 -178.163651731924 531.087735614327 1 0 0 0 0.915204699811909 0 0.830409399623818 0 0.733487575724189 0 0.630649991393956 0 0.517272946982492 0 0.385636052389979 0 0.19281802619499 0 1 1 1 0.444444444444444 1 0.666666666666667 1 0.833333333333333 0 1 0.922886100470241 1 0.845772200940481 1 0.742953668234136 1 0.623416989937179 1 0.480508678534476 1 0.240254339267238 1 0 0.555555555555556 0 0.277777777777778 0.19281802619499 0.277777777777778 0.240254339267238 0.277777777777778 0.385636052389979 0.277777777777778 0.480508678534476 0.277777777777778 0.517272946982492 0.277777777777778 0.623416989937179 0.277777777777778 0.742953668234136 0.277777777777778 0.845772200940481 0.277777777777778 0.922886100470241 0.277777777777778 0.19281802619499 0.444444444444444 0.240254339267238 0.444444444444444 0.385636052389979 0.444444444444444 0.480508678534476 0.444444444444444 0.517272946982492 0.444444444444444 0.623416989937179 0.444444444444444 0.742953668234136 0.444444444444444 0.845772200940481 0.444444444444444 0.922886100470241 0.444444444444444 0.19281802619499 0.555555555555556 0.240254339267238 0.555555555555556 0.385636052389979 0.555555555555556 0.480508678534476 0.555555555555556 0.517272946982492 0.555555555555556 0.623416989937179 0.555555555555556 0.742953668234136 0.555555555555556 0.845772200940481 0.555555555555556 0.922886100470241 0.555555555555556 0.19281802619499 0.666666666666667 0.240254339267238 0.666666666666667 0.385636052389979 0.666666666666667 0.480508678534476 0.666666666666667 0.517272946982492 0.666666666666667 0.623416989937179 0.666666666666667 0.742953668234136 0.666666666666667 0.845772200940481 0.666666666666667 0.922886100470241 0.666666666666667 0.19281802619499 0.833333333333333 0.240254339267238 0.833333333333333 0.385636052389979 0.833333333333333 0.480508678534476 0.833333333333333 0.517272946982492 0.833333333333333 0.623416989937179 0.833333333333333 0.742953668234136 0.833333333333333 0.845772200940481 0.833333333333333 0.922886100470241 0.833333333333333 22 2 9 9 23 22 23 9 24 22 23 32 41 21 32 21 22 32 24 33 32 33 24 25 23 24 32 33 42 32 9 8 24 8 25 24 25 8 26 26 7 27 7 26 8 25 26 35 43 33 34 34 25 35 27 36 35 36 27 28 26 27 35 44 34 35 7 28 27 25 34 33 45 35 36 59 21 50 50 41 42 42 51 50 51 42 43 41 32 42 50 51 60 14 59 20 14 21 59 60 20 59 20 60 61 59 50 60 51 52 60 50 21 41 43 52 51 52 43 44 52 44 53 45 44 35 43 34 44 54 44 45 61 53 62 53 61 52 19 62 63 54 62 53 63 62 54 62 19 61 53 44 54 61 19 20 45 46 54 52 61 60 42 33 43 36 37 45 28 6 5 37 36 28 5 29 28 29 5 4 28 29 38 55 54 46 46 37 38 38 47 46 47 38 39 37 28 38 46 47 56 29 30 38 46 45 37 30 39 38 30 4 3 30 3 31 31 3 1 48 47 39 48 39 40 31 11 40 11 31 1 48 40 49 31 40 39 39 30 31 49 40 11 29 4 30 47 48 57 64 63 55 63 54 55 65 55 56 56 47 57 46 56 55 65 56 57 64 18 63 18 64 65 65 17 18 66 17 65 64 55 65 65 57 66 63 18 19 57 58 66 58 57 49 66 58 67 12 58 49 49 11 12 13 58 12 16 67 15 67 16 66 15 13 10 13 15 67 67 58 13 66 16 17 49 57 48 28 7 6 +70 118 1 2.20001984819307 +-808.77 -200 519.08 -600 -199.999967554145 620.968654478712 -797.458619676349 -200 533.237855632236 -783.771388243292 -200 545.953633789342 -762.674379788868 -200 560.840825638572 -735.316416670017 -200 575.529288291616 -700.582486771103 -200 590.027014452652 -643.663819456082 -200 608.659276100384 -676.88 -623 542.55 -764.628552049992 -402.071178174059 531.734003962811 -726.959877781588 -518.719115559747 536.498882363588 -600 -643.12 581.66 -619.3387575 -638.70016 575.8039025 -631.595488128543 -635.795716755033 570.995099914302 -643.719677712615 -632.727678121655 564.930046883421 -656.573678413912 -629.195165128107 557.131981302973 -666.18543197749 -626.354440650485 550.527034250639 -600 -588.197944293069 593.014490687452 -600 -490.283495748555 604.404928337226 -600 -349.417818683123 614.264139307273 -637.764779719632 -346.189051191474 603.250340352128 -649.00348360259 -345.382984527373 599.802380360063 -685.86815489137 -342.853059151034 587.446589133007 -714.727449269598 -340.814621253805 575.737062067411 -719.549587090357 -340.455444905267 573.503691629956 -738.49587152558 -338.955660641756 563.624666349981 -749.084999775899 -338.031267363821 557.102364313148 -757.461664384184 -337.23645223698 551.244666095863 -766.594820981249 -336.282082905143 543.927411156852 -770.342971642259 -335.855822153992 540.566402891396 -634.262423108012 -419.798630086418 599.456441778563 -644.224395105838 -418.590114965496 596.33794798727 -676.814557800573 -414.791196999922 585.197760269869 -702.500227079367 -411.730514775203 574.632861295164 -706.824977267695 -411.191374568309 572.614733040482 -723.954575707771 -408.940316210704 563.673762300313 -733.654279760133 -407.552758005904 557.757602149982 -741.415703828812 -406.359455552112 552.43504324702 -749.996359501116 -404.926166885342 545.773728904429 -753.563504660783 -404.285819622805 542.709267431567 -630.579054742152 -484.386261815782 595.250074333055 -639.248888577023 -482.879316514473 592.470969280448 -667.513341473911 -478.126223149232 582.529759605991 -689.958503094345 -474.291847372106 573.050987729198 -693.771384949996 -473.616099038096 571.234779241465 -709.015996877783 -470.792578053765 563.170172042003 -717.778272424718 -469.049758064398 557.819382300889 -724.879620436875 -467.549023506021 552.996635587773 -732.849308820271 -465.743823384084 546.949772911916 -736.207555533848 -464.936324442484 544.163975292443 -626.374243223597 -543.449233523982 590.281531388972 -633.627175785433 -541.802604767433 587.896337264599 -657.169716873974 -536.579032179129 579.319550218565 -676.057998197346 -532.343198616197 571.045627591825 -679.305095510533 -531.594425421244 569.450716110811 -692.450510845611 -528.45632532418 562.339331583746 -700.154824580728 -526.510563464088 557.599024713622 -706.501154174939 -524.829077733341 553.314355014614 -713.757864842434 -522.798727304956 547.928212319831 -716.866192511315 -521.887735642299 545.442138468608 -622.888217573813 -582.195942089957 586.07697358143 -629.009307064851 -580.614540705351 584.031073289926 -648.797861790145 -575.565819177998 576.620985683063 -664.84135085087 -571.43033672088 569.360186135209 -667.632410073069 -570.694530006141 567.949378084972 -679.071723955213 -567.592978062061 561.624831523041 -685.903702195711 -565.654641406565 557.384228145067 -691.618722254371 -563.969900505906 553.538188175436 -698.26734452087 -561.923715623534 548.689392158657 -701.157517434384 -561.001460122129 546.44692601306 1 0 0 0 0.922886100470241 0 0.845772200940481 0 0.742953668234136 0 0.623416989937179 0 0.480508678534476 0 0.240254339267238 0 1 1 1 0.444444444444444 1 0.722222222222222 0 1 0.3 1 0.483372536081864 1 0.647163271069615 1 0.799178991702561 1 0.89958949585128 1 0 0.821893271506625 0 0.584417633515458 0 0.292208816757729 0.240254339267238 0.292208816757729 0.3 0.292208816757729 0.483372536081864 0.292208816757729 0.623416989937179 0.292208816757729 0.647163271069615 0.292208816757729 0.742953668234136 0.292208816757729 0.799178991702561 0.292208816757729 0.845772200940481 0.292208816757729 0.89958949585128 0.292208816757729 0.922886100470241 0.292208816757729 0.240254339267238 0.444444444444444 0.3 0.444444444444444 0.483372536081864 0.444444444444444 0.623416989937179 0.444444444444444 0.647163271069615 0.444444444444444 0.742953668234136 0.444444444444444 0.799178991702561 0.444444444444444 0.845772200940481 0.444444444444444 0.89958949585128 0.444444444444444 0.922886100470241 0.444444444444444 0.240254339267238 0.584417633515458 0.3 0.584417633515458 0.483372536081864 0.584417633515458 0.623416989937179 0.584417633515458 0.647163271069615 0.584417633515458 0.742953668234136 0.584417633515458 0.799178991702561 0.584417633515458 0.845772200940481 0.584417633515458 0.89958949585128 0.584417633515458 0.922886100470241 0.584417633515458 0.240254339267238 0.722222222222222 0.3 0.722222222222222 0.483372536081864 0.722222222222222 0.623416989937179 0.722222222222222 0.647163271069615 0.722222222222222 0.742953668234136 0.722222222222222 0.799178991702561 0.722222222222222 0.845772200940481 0.722222222222222 0.89958949585128 0.722222222222222 0.922886100470241 0.722222222222222 0.240254339267238 0.821893271506625 0.3 0.821893271506625 0.483372536081864 0.821893271506625 0.623416989937179 0.821893271506625 0.647163271069615 0.821893271506625 0.742953668234136 0.821893271506625 0.799178991702561 0.821893271506625 0.845772200940481 0.821893271506625 0.89958949585128 0.821893271506625 0.922886100470241 0.821893271506625 20 2 8 8 21 20 21 8 22 20 21 31 19 31 41 19 20 31 32 31 22 31 32 41 21 22 31 19 41 51 8 7 22 23 32 22 23 7 6 6 24 23 24 6 25 23 24 34 41 32 42 32 23 33 34 25 35 34 33 23 35 25 26 44 33 34 25 34 24 43 32 33 6 5 25 23 22 7 45 34 35 51 42 52 51 18 19 62 52 53 43 52 42 42 32 43 51 52 62 12 18 61 61 62 13 62 61 51 63 13 62 61 13 12 18 51 61 53 52 43 51 41 42 53 44 54 44 53 43 54 45 55 45 54 44 44 34 45 53 54 64 63 14 13 14 63 64 64 55 65 64 63 53 65 55 56 14 64 15 54 55 64 15 64 65 45 46 55 53 63 62 43 33 44 35 36 45 36 35 26 26 5 27 37 27 28 4 27 5 26 27 37 56 55 46 46 36 37 37 47 46 38 47 37 36 26 37 46 47 57 28 27 4 46 45 36 28 29 39 28 4 29 29 3 30 4 3 29 30 3 1 47 38 48 38 28 39 30 10 40 10 30 1 50 39 40 30 40 39 29 30 39 49 38 39 28 38 37 50 40 10 56 57 67 56 46 57 48 58 57 58 48 49 47 48 57 57 58 68 15 66 16 15 65 66 67 68 16 68 67 57 16 68 17 67 16 66 66 56 67 58 59 68 65 56 66 49 59 58 59 49 50 50 60 59 60 50 11 49 39 50 59 60 70 69 17 68 17 69 70 70 11 9 70 69 59 70 9 17 60 11 70 50 10 11 59 69 68 48 38 49 26 25 5 +59 97 1 1.73632705734923 +-20.0008782074737 -723.7699094332 692.289879102883 -600 -643.12 581.66 -190.247255390148 -708.704811885537 667.006311545885 -369.707720522957 -685.600010566781 635.445520724896 -488.56844520659 -665.864908539194 610.276174592657 -600 -684.65 555.24 -600 -679.234249352233 561.538835543362 -600 -673.006723316568 567.248239548849 -600 -665.849790479122 572.171279659939 -600 -657.469795393744 576.485382569639 -600 -650.723494233839 579.193763532102 -20.0008383170066 -782.649983376265 639.339819879384 -442.660550846554 -725.625009367168 584.07955607331 -225.237839622531 -761.486310871385 616.278039171289 -20.0017255796791 -745.751603779794 682.651780115796 -20.0017088696021 -759.075776301676 673.780757867147 -20.00169771616 -768.4255696724 664.829319908417 -20.0016894667257 -775.348651387764 655.422300763675 -20.0016833490327 -779.657729121789 647.241662226429 -189.883948742114 -720.121511480911 662.778367929477 -229.050565371967 -715.443691429176 656.548921701302 -369.064061967881 -695.871654356904 631.98449882993 -447.247787262446 -682.760115344825 616.255455467092 -488.09650988865 -675.146419868716 607.285660033497 -189.557364574523 -728.962364924186 658.739638403731 -228.612875082833 -724.123531084904 652.664832096179 -368.475047866107 -703.920259502609 628.600888569421 -446.728417582447 -690.363946160366 613.142707875887 -487.651929571934 -682.456317710774 604.328677470522 -188.992228079428 -741.741235655596 651.066661914607 -227.85337982199 -736.733029111854 645.271033890477 -367.442180069901 -715.758208993602 622.128650350064 -445.809285845887 -701.578455842866 607.195157371485 -486.860669346407 -693.239518377512 598.691240149152 -188.469995512773 -751.067091943063 643.284870264207 -227.150638783905 -746.001680925676 637.764815847486 -366.483927618576 -724.636009191523 615.567555504413 -444.955346663921 -710.03419079003 601.197245772876 -486.124985715114 -701.373686969876 593.027232009477 -188.400743365404 -752.136261341567 642.216449660133 -227.057504704102 -747.069156810192 636.734076631285 -366.357159633634 -725.673701042329 614.668215608085 -444.84254922883 -711.028298424364 600.377155820536 -486.027901717761 -702.331588790326 592.253961086061 -187.947205825792 -758.22842529038 635.10741850035 -226.448365990695 -753.178061654938 629.875298378456 -365.530438056205 -731.709376452538 608.690374466613 -444.108299176791 -716.85999631175 594.932172633317 -485.396635194883 -707.971003243277 587.122795873801 -187.758442320634 -760.327704002019 632.127427569962 -226.195296848092 -755.296554131905 626.999511424735 -365.18821673321 -733.856905269967 606.184524425241 -443.804989513564 -718.966855709174 592.650196000993 -485.136181270956 -710.02295459989 584.972451364795 -187.495022574741 -762.876752301039 627.988998412616 -225.842456214192 -757.882318970449 623.003765613804 -364.711926587031 -736.537108220356 602.698207107651 -443.383263948793 -721.635107307717 589.472581689263 -484.774239450123 -712.640743017894 581.976774431468 0 0 1 0 0.298322443731606 0 0.596644887463212 0 0.798322443731606 0 1 1 1 0.777777777777778 1 0.577777777777778 1 0.39880380166357 1 0.230455822164417 1 0.115227911082208 0 1 0.728133443495504 1 0.364066721747752 1 0 0.217252442700581 0 0.393226921288052 0 0.556166253313487 0 0.719105585338923 0 0.859552792669461 0.298322443731606 0.115227911082208 0.364066721747752 0.115227911082208 0.596644887463212 0.115227911082208 0.728133443495504 0.115227911082208 0.798322443731606 0.115227911082208 0.298322443731606 0.217252442700581 0.364066721747752 0.217252442700581 0.596644887463212 0.217252442700581 0.728133443495504 0.217252442700581 0.798322443731606 0.217252442700581 0.298322443731606 0.393226921288052 0.364066721747752 0.393226921288052 0.596644887463212 0.393226921288052 0.728133443495504 0.393226921288052 0.798322443731606 0.393226921288052 0.298322443731606 0.556166253313487 0.364066721747752 0.556166253313487 0.596644887463212 0.556166253313487 0.728133443495504 0.556166253313487 0.798322443731606 0.556166253313487 0.298322443731606 0.577777777777778 0.364066721747752 0.577777777777778 0.596644887463212 0.577777777777778 0.728133443495504 0.577777777777778 0.798322443731606 0.577777777777778 0.298322443731606 0.719105585338923 0.364066721747752 0.719105585338923 0.596644887463212 0.719105585338923 0.728133443495504 0.719105585338923 0.798322443731606 0.719105585338923 0.298322443731606 0.777777777777778 0.364066721747752 0.777777777777778 0.596644887463212 0.777777777777778 0.728133443495504 0.777777777777778 0.798322443731606 0.777777777777778 0.298322443731606 0.859552792669461 0.364066721747752 0.859552792669461 0.596644887463212 0.859552792669461 0.728133443495504 0.859552792669461 0.798322443731606 0.859552792669461 1 3 20 20 3 21 1 20 15 16 15 25 25 30 16 30 25 26 15 20 25 16 30 35 20 21 25 21 4 22 4 21 3 22 4 23 21 22 27 26 31 30 31 26 27 27 32 31 32 27 28 26 21 27 31 32 36 22 23 27 21 26 25 30 31 36 17 35 40 35 17 16 40 35 36 17 40 18 50 19 18 45 50 18 19 55 12 18 40 45 40 41 45 41 46 45 41 40 36 46 50 45 42 46 41 41 36 37 50 46 51 55 51 56 51 55 50 56 14 55 57 14 56 56 51 52 55 14 12 51 46 47 50 55 19 35 30 36 37 36 32 28 23 24 5 23 4 33 28 29 33 32 28 37 42 41 42 37 38 33 38 37 34 38 33 32 33 37 43 42 38 5 24 23 28 27 23 24 29 28 29 24 11 2 11 24 24 5 2 29 11 10 34 39 38 39 34 9 10 9 34 34 29 10 39 9 8 29 34 33 44 38 39 47 43 48 43 47 42 48 43 44 47 48 53 52 57 56 57 52 53 53 58 57 58 53 54 52 47 53 57 58 13 48 49 53 47 52 51 54 53 49 49 44 8 7 49 8 49 7 54 44 39 8 59 58 54 13 59 6 13 58 59 7 6 59 59 54 7 49 48 44 43 38 44 57 13 14 42 47 46 +93 163 1 0.247371342977575 +-600 -643.12 581.66 -676.88 -623 542.55 -619.3387575 -638.70016 575.8039025 -631.595488128543 -635.795716755033 570.995099914302 -643.719677712615 -632.727678121655 564.930046883421 -656.573678413912 -629.195165128107 557.131981302973 -666.18543197749 -626.354440650485 550.527034250639 -636.01 -667.8 548.74 -668.39155485094 -635.793063285979 543.709109655609 -659.768420216741 -646.602670482798 544.965184472916 -650.682885902307 -656.023932825534 546.36007270776 -643.298719500101 -662.426162207734 547.539940618118 -600 -684.65 555.24 -625.967183331964 -673.898063737834 550.461939568685 -614.688565795215 -679.26451247379 552.473619182493 -607.03157492704 -682.230857300366 553.891940301455 -600 -679.234249352233 561.538835543362 -600 -673.006723316568 567.248239548849 -600 -665.849790479122 572.171279659939 -600 -657.469795393744 576.485382569639 -600 -650.723494233839 579.193763532102 -613.588420957468 -647.45501193791 575.286022801673 -618.368499225195 -646.250028007767 573.759075139498 -627.257587898423 -643.936526073325 570.452854753976 -629.911612544152 -643.225782504287 569.322974241082 -641.288250488337 -640.059231705493 563.683878170712 -648.83751020719 -637.838517424764 559.277419933192 -653.321939521835 -636.470443060756 556.445023039335 -662.296152215192 -633.618659541195 550.380047988148 -612.934602423888 -653.085381707483 573.310994825287 -617.487874050791 -651.862128171904 571.879447255906 -625.948605083982 -649.503999285932 568.792420840951 -628.471694769546 -648.779526103034 567.741076647701 -639.264022159024 -645.563783290278 562.514779757817 -646.401200826872 -643.324517635204 558.450037433037 -650.630717504026 -641.951834683385 555.844823550042 -659.071179525698 -639.105673965583 550.284789704387 -612.787165158111 -654.226230052354 572.865184918252 -617.29138331907 -653.00103736461 571.453486668324 -625.661354760641 -650.637083632832 568.414837114963 -628.156903419846 -649.910715464206 567.381494465019 -638.825751494694 -646.688320701723 562.251613082852 -645.874702358394 -644.447177464562 558.266373092886 -650.049194372738 -643.074636695482 555.71325636018 -658.373764505158 -640.23184473606 550.266413494033 -611.524084269789 -662.687384191536 568.977250166552 -615.622289702114 -661.472469759111 567.733131804994 -623.253266906402 -659.110347233364 565.115255737721 -625.525819941601 -658.382501115236 564.241090503698 -635.190818327216 -655.159111260593 559.968941466456 -641.515045483041 -652.932390233132 556.687085225698 -645.23476804388 -651.577126772167 554.590507208272 -652.597449126325 -648.791997708598 550.121130611583 -611.36140010944 -663.641274411091 568.464244713792 -615.408202496746 -662.430751967812 567.242609672461 -622.946277546168 -660.074722934901 564.680926347305 -625.190855009422 -659.348363418687 563.827927158346 -634.729661109232 -656.131305912982 559.669339955872 -640.962388637504 -653.910058116289 556.480181729061 -644.624559776223 -652.558950844772 554.443589471315 -651.865332716779 -649.784730075151 550.102138782525 -610.154206148774 -669.994499989615 564.554451292897 -613.81963312639 -668.833624804613 563.513045010665 -620.666786153711 -666.554934286398 561.388382752586 -622.702996363867 -665.848842263599 560.696832576496 -631.301976860986 -662.715100155762 557.394804588265 -636.854363444713 -660.555520684506 554.902995222407 -640.089162548522 -659.246706684208 553.318971718805 -646.425609779253 -656.574248873227 549.947939900574 -609.680123498542 -672.190175898015 562.971005351275 -613.194830449258 -671.05518942512 562.007247198007 -619.767215282016 -668.818763487655 560.063488066555 -621.720309534657 -668.124058117993 559.437070851191 -629.944692299137 -665.036701704902 556.475883082681 -635.226952243432 -662.909441495617 554.261365941664 -638.292518137402 -661.621695497549 552.858422768415 -644.271584180039 -658.997360719835 549.879610757377 -608.650867453796 -676.485497751743 559.461827753486 -611.835572584047 -675.412902808918 558.677199631779 -617.802472363496 -673.279343933022 557.13751052125 -619.57187234894 -672.61257563498 556.653810707097 -626.968943584026 -669.639201986643 554.433979822996 -631.656672652017 -667.590416129894 552.82537326835 -634.350626868984 -666.353110943147 551.821284302367 -639.546206997659 -663.842011686532 549.715805316944 -608.338204382947 -677.679581039991 558.383539605151 -611.421985247229 -676.626303364251 557.655029167125 -617.202833675967 -674.524525860574 556.238893379138 -618.915665111524 -673.866402729926 555.798314760503 -626.058030383513 -670.928447949993 553.802310116637 -630.563087035899 -668.904128331227 552.378264419689 -633.143015700599 -667.682538336472 551.49669562438 -638.098396647773 -665.206615055148 549.66212519703 0 0 1 0 0.3 0 0.483372536081864 0 0.647163271069615 0 0.799178991702561 0 0.89958949585128 0 1 1 1 0.210030317112914 1 0.420060634225827 1 0.640253673813347 1 0.820126836906674 0 1 0.745001403601993 1 0.442490875950301 1 0.221245437975151 1 0 0.777777777777778 0 0.577777777777778 0 0.39880380166357 0 0.230455822164417 0 0.115227911082208 0.221245437975151 0.115227911082208 0.3 0.115227911082208 0.442490875950301 0.115227911082208 0.483372536081864 0.115227911082208 0.647163271069615 0.115227911082208 0.745001403601993 0.115227911082208 0.799178991702561 0.115227911082208 0.89958949585128 0.115227911082208 0.221245437975151 0.210030317112914 0.3 0.210030317112914 0.442490875950301 0.210030317112914 0.483372536081864 0.210030317112914 0.647163271069615 0.210030317112914 0.745001403601993 0.210030317112914 0.799178991702561 0.210030317112914 0.89958949585128 0.210030317112914 0.221245437975151 0.230455822164417 0.3 0.230455822164417 0.442490875950301 0.230455822164417 0.483372536081864 0.230455822164417 0.647163271069615 0.230455822164417 0.745001403601993 0.230455822164417 0.799178991702561 0.230455822164417 0.89958949585128 0.230455822164417 0.221245437975151 0.39880380166357 0.3 0.39880380166357 0.442490875950301 0.39880380166357 0.483372536081864 0.39880380166357 0.647163271069615 0.39880380166357 0.745001403601993 0.39880380166357 0.799178991702561 0.39880380166357 0.89958949585128 0.39880380166357 0.221245437975151 0.420060634225827 0.3 0.420060634225827 0.442490875950301 0.420060634225827 0.483372536081864 0.420060634225827 0.647163271069615 0.420060634225827 0.745001403601993 0.420060634225827 0.799178991702561 0.420060634225827 0.89958949585128 0.420060634225827 0.221245437975151 0.577777777777778 0.3 0.577777777777778 0.442490875950301 0.577777777777778 0.483372536081864 0.577777777777778 0.647163271069615 0.577777777777778 0.745001403601993 0.577777777777778 0.799178991702561 0.577777777777778 0.89958949585128 0.577777777777778 0.221245437975151 0.640253673813347 0.3 0.640253673813347 0.442490875950301 0.640253673813347 0.483372536081864 0.640253673813347 0.647163271069615 0.640253673813347 0.745001403601993 0.640253673813347 0.799178991702561 0.640253673813347 0.89958949585128 0.640253673813347 0.221245437975151 0.777777777777778 0.3 0.777777777777778 0.442490875950301 0.777777777777778 0.483372536081864 0.777777777777778 0.647163271069615 0.777777777777778 0.745001403601993 0.777777777777778 0.799178991702561 0.777777777777778 0.89958949585128 0.777777777777778 0.221245437975151 0.820126836906674 0.3 0.820126836906674 0.442490875950301 0.820126836906674 0.483372536081864 0.820126836906674 0.647163271069615 0.820126836906674 0.745001403601993 0.820126836906674 0.799178991702561 0.820126836906674 0.89958949585128 0.820126836906674 21 1 22 22 3 23 3 22 1 23 3 24 22 23 30 21 22 30 19 20 38 30 20 21 38 20 30 38 46 19 39 46 38 47 54 46 46 54 19 38 30 31 19 54 18 23 31 30 31 24 32 31 23 24 32 24 25 31 32 40 4 25 24 25 4 5 33 25 26 25 33 32 3 4 24 32 33 41 39 40 47 40 39 31 47 40 48 39 47 46 48 41 49 41 48 40 49 41 42 56 47 48 40 32 41 54 47 55 33 34 41 31 39 38 57 48 49 18 62 70 18 54 62 62 63 70 63 62 55 63 55 56 70 63 71 54 55 62 18 70 17 13 17 86 17 70 78 86 17 78 16 86 87 78 79 86 71 79 78 86 16 13 70 71 78 63 64 71 72 71 64 64 56 57 72 64 65 72 79 71 57 65 64 65 57 58 73 65 66 65 73 72 56 48 57 72 73 81 79 80 87 80 79 72 87 80 88 79 87 86 15 88 89 81 88 80 89 88 81 88 15 87 80 72 81 87 15 16 73 74 81 64 63 56 55 47 56 49 50 57 34 33 26 26 5 27 34 27 35 27 34 26 35 27 28 34 35 43 5 6 27 42 41 34 58 57 50 50 42 43 58 50 51 66 65 58 43 51 50 51 43 44 59 51 52 51 59 58 42 34 43 58 59 67 35 36 43 50 49 42 6 28 27 28 6 7 36 28 29 28 36 35 7 2 29 29 2 9 7 29 28 36 29 37 52 44 45 37 44 36 45 44 37 44 52 51 45 9 53 9 45 37 53 9 10 45 53 52 37 29 9 59 52 60 36 44 43 61 52 53 66 67 74 66 58 67 74 67 75 82 81 74 67 68 75 68 67 60 68 60 61 83 75 76 59 60 67 74 75 83 89 82 90 89 81 82 90 82 83 90 14 15 83 91 90 84 91 83 92 14 91 91 14 90 82 74 83 90 15 89 68 76 75 73 66 74 68 69 76 69 68 61 69 61 10 76 69 77 69 11 77 11 69 10 77 11 85 61 53 10 76 77 85 84 85 92 85 84 76 92 85 93 84 92 91 93 12 8 12 93 85 8 14 93 85 11 12 93 14 92 76 84 83 60 52 61 26 25 5 +93 162 1 0.547112311073358 +387.410490640632 -727.928389328809 756.560027803797 -20.0008782074737 -723.7699094332 692.289879102883 306.081167106133 -731.283996407786 739.348544178273 196.01017524507 -732.386098012818 721.734404521329 86.2399591540638 -729.671109457405 706.534640278785 -20.0008383170066 -782.649983376265 639.339819879384 -20.0017255796791 -745.751603779794 682.651780115796 -20.0017088696021 -759.075776301676 673.780757867147 -20.00169771616 -768.4255696724 664.829319908417 -20.0016894667257 -775.348651387764 655.422300763675 -20.0016833490327 -779.657729121789 647.241662226429 324.999364674401 -797.169225901266 666.299358845369 125.777013569847 -790.773219516426 652.452279897576 224.878073166291 -794.596031064388 659.883308364808 347.153859738325 -790.225153350485 688.690029290456 363.389233182177 -781.722119438637 708.560858479551 373.164960152399 -773.081036218909 723.322092906039 378.884491078934 -764.891051203228 733.80684547116 382.533653924722 -756.644956498057 741.808427380656 384.997811059939 -747.662621522234 748.277197893892 386.534121678699 -738.102004173828 753.149908067095 387.045920005356 -733.039672887664 755.047169448668 353.937201621186 -734.683686171733 747.090587139104 333.63484928695 -735.485622870872 742.819063198064 306.868152013188 -736.335029133085 737.67589277046 208.773844018582 -737.617577364063 721.688421967363 196.267252243435 -737.575988196758 719.852575032009 117.894047993756 -736.215244921851 708.886263203098 86.2163418203308 -735.130146542438 704.608020254504 354.112245052666 -739.621226219814 745.280272763196 333.825863200636 -740.391603629181 740.961095202212 307.110520843264 -741.212864953996 735.779367269453 209.140555905439 -742.503402406741 719.764725517196 196.622511425017 -742.474223525199 717.928719428933 118.030560521109 -741.243551136251 706.925848915303 86.2355891471877 -740.234078504079 702.605040948122 354.902908384653 -748.820436140638 741.095456959689 334.629436754693 -749.47125032443 736.802680580349 307.984632987546 -750.168858730315 731.662711085867 210.125592503341 -751.273802825459 715.770398090822 197.567949151707 -751.247315516614 713.937654135404 118.447260447908 -750.149279602701 702.842971793427 86.3862406634929 -749.243278816555 698.42597006425 356.203351203217 -757.405304689732 735.870932848349 335.921250597797 -757.897219739212 731.744924315827 309.31328238517 -758.420346885806 726.788154305992 211.41937516579 -759.159281925542 711.266984518889 198.803013524991 -759.113086533429 709.449963577854 119.039068396702 -758.01108528479 698.303677449903 86.6692249704781 -757.154594735355 693.804875341306 357.916635470786 -765.306107617487 729.484568192816 337.607581005576 -765.633766348171 725.639968507058 311.00874663022 -765.968813535623 720.986908256362 212.9641645365 -766.245282764022 706.094802746437 200.274044369193 -766.163239653355 704.314086003929 119.776209769794 -764.944744324498 693.227659820016 87.0630584220264 -764.087947271867 688.694474765262 360.194978413898 -773.224541307999 720.98453147448 339.83857417968 -773.389462779568 717.552310894613 313.224281156165 -773.529346810021 713.348287943366 214.908652168416 -773.253376676732 699.453369096479 202.123299167269 -773.118754668029 697.744715493817 120.729862368528 -771.663610395287 686.923512849104 87.6042982323202 -770.752823066628 682.438478635464 361.087682596955 -775.838889059164 717.583428189407 340.710675581824 -775.953329392068 714.317622323239 314.085601195597 -776.030251655825 710.297021831066 215.652051868129 -775.556657021909 696.833130203695 202.829918726218 -775.400906548535 695.159552058479 121.099419876914 -773.83769157689 684.494597740141 87.8197574906332 -772.894772205805 680.053466773296 342.958134642616 -781.728464013803 705.723535008258 316.297864834346 -781.669795836877 702.187026261382 217.54218448215 -780.727817079041 689.92600975658 204.626021984404 -780.517093224245 688.359672448081 122.047389285178 -778.646720735336 678.224211980566 88.3816478163566 -777.599448776646 673.95474242766 344.607103013214 -785.374370904159 699.16149071531 317.916465529516 -785.23469243221 695.986714413656 218.913443622171 -783.97917867003 684.685230249504 205.92878075625 -783.727840667065 683.212318537838 122.740514779572 -781.610402105641 673.575433903026 88.7982517005659 -780.469975200104 669.481718005945 320.381947114857 -789.967621791806 686.105194294432 220.991823267321 -788.263145848919 676.382410195346 207.903130527356 -787.949141391549 675.07461097457 123.796362923256 -785.424229274062 666.365135970433 89.4383102015715 -784.119075017503 662.613564048887 321.441184998764 -791.787346085507 681.703307746227 221.882863610764 -789.893472268683 672.699696951272 208.749553432935 -789.552032987006 671.470781901217 124.250196520448 -786.841128126206 663.217763966314 89.7145538385038 -785.457729934355 659.63861505744 0.16918 0.08333 0.91667 0.08333 0.311382763597895 0.08333 0.50098716242929 0.08333 0.708826906756423 0.08333 0.91667 0.91667 0.91667 0.264375150600102 0.91667 0.411021722586185 0.91667 0.546805585536261 0.91667 0.682589448486338 0.91667 0.799629724243169 0.3102 0.91668 0.647124211248285 0.916667585733882 0.478660433813443 0.916669420438957 0.264747812983676 0.764820594203788 0.229685151830055 0.626873578494003 0.207078248520542 0.513823736541737 0.19285843137703 0.421391734996037 0.183103301813975 0.337668095872583 0.176037946762809 0.253626410573318 0.171453961326189 0.169512121246896 0.170012259300436 0.126369997549254 0.229685151830055 0.126369997549254 0.264747812983676 0.126369997549254 0.3102 0.126369997549254 0.478660433813443 0.126369997549254 0.50098716242929 0.126369997549254 0.647124211248285 0.126369997549254 0.708826906756423 0.126369997549254 0.229685151830055 0.169512121246896 0.264747812983676 0.169512121246896 0.3102 0.169512121246896 0.478660433813443 0.169512121246896 0.50098716242929 0.169512121246896 0.647124211248285 0.169512121246896 0.708826906756423 0.169512121246896 0.229685151830055 0.253626410573318 0.264747812983676 0.253626410573318 0.3102 0.253626410573318 0.478660433813443 0.253626410573318 0.50098716242929 0.253626410573318 0.647124211248285 0.253626410573318 0.708826906756423 0.253626410573318 0.229685151830055 0.337668095872583 0.264747812983676 0.337668095872583 0.3102 0.337668095872583 0.478660433813443 0.337668095872583 0.50098716242929 0.337668095872583 0.647124211248285 0.337668095872583 0.708826906756423 0.337668095872583 0.229685151830055 0.421391734996037 0.264747812983676 0.421391734996037 0.3102 0.421391734996037 0.478660433813443 0.421391734996037 0.50098716242929 0.421391734996037 0.647124211248285 0.421391734996037 0.708826906756423 0.421391734996037 0.229685151830055 0.513823736541737 0.264747812983676 0.513823736541737 0.3102 0.513823736541737 0.478660433813443 0.513823736541737 0.50098716242929 0.513823736541737 0.647124211248285 0.513823736541737 0.708826906756423 0.513823736541737 0.229685151830055 0.546805585536261 0.264747812983676 0.546805585536261 0.3102 0.546805585536261 0.478660433813443 0.546805585536261 0.50098716242929 0.546805585536261 0.647124211248285 0.546805585536261 0.708826906756423 0.546805585536261 0.264747812983676 0.626873578494003 0.3102 0.626873578494003 0.478660433813443 0.626873578494003 0.50098716242929 0.626873578494003 0.647124211248285 0.626873578494003 0.708826906756423 0.626873578494003 0.264747812983676 0.682589448486338 0.3102 0.682589448486338 0.478660433813443 0.682589448486338 0.50098716242929 0.682589448486338 0.647124211248285 0.682589448486338 0.708826906756423 0.682589448486338 0.3102 0.764820594203788 0.478660433813443 0.764820594203788 0.50098716242929 0.764820594203788 0.647124211248285 0.764820594203788 0.708826906756423 0.764820594203788 0.3102 0.799629724243169 0.478660433813443 0.799629724243169 0.50098716242929 0.799629724243169 0.647124211248285 0.799629724243169 0.708826906756423 0.799629724243169 22 1 23 30 21 23 23 21 22 3 24 23 30 23 24 23 1 3 19 44 18 37 19 20 30 37 20 31 37 30 38 44 37 37 44 19 20 21 30 51 18 44 31 30 24 31 25 32 31 24 25 32 25 3 31 32 39 3 26 33 26 3 4 33 26 27 3 33 32 24 3 25 32 33 40 38 39 45 39 38 31 45 39 46 38 45 44 46 40 47 40 46 39 47 40 41 53 45 46 39 32 40 52 44 45 33 34 40 31 38 37 54 46 47 17 51 58 51 17 18 58 52 59 52 58 51 59 52 53 58 59 66 51 44 52 17 58 65 65 66 16 66 65 58 16 66 72 65 16 17 72 78 16 78 72 73 15 78 79 78 15 16 66 67 72 59 60 66 53 60 59 60 53 54 67 60 61 60 67 66 54 61 60 61 54 55 68 61 62 61 68 67 53 46 54 67 68 74 73 79 78 79 73 74 80 84 79 79 84 15 12 89 14 84 85 89 79 74 80 89 12 15 73 67 74 84 89 15 68 69 74 67 73 72 52 45 53 47 48 54 34 33 27 27 4 28 34 28 35 28 34 27 35 28 29 34 35 42 4 5 28 41 40 34 55 54 48 48 41 42 55 48 49 62 61 55 62 55 56 49 48 42 49 42 43 56 55 49 41 34 42 69 68 62 35 36 42 48 47 41 36 35 29 29 5 2 36 29 2 43 42 36 36 7 43 7 36 2 43 7 50 50 49 43 63 56 57 56 49 50 57 56 50 56 63 62 57 8 64 8 57 50 64 8 9 57 64 63 50 7 8 63 64 71 29 28 5 62 63 70 74 75 80 74 69 75 75 69 70 80 75 81 75 76 81 76 75 70 76 70 71 81 76 82 69 62 70 80 81 86 85 90 89 90 85 86 14 90 91 90 14 89 91 86 87 86 85 80 14 91 13 86 91 90 81 82 86 82 87 86 76 77 82 80 85 84 77 83 82 77 76 71 77 71 9 82 83 87 77 10 83 10 77 9 87 83 88 71 64 9 88 83 10 13 92 93 88 92 87 93 92 88 92 13 91 93 11 6 11 93 88 93 6 13 88 10 11 87 92 91 70 63 71 27 26 4 +108 190 1 0.360527881643588 +-853.7 0 473.9 -600 0 624.91 -835.241618809744 0 502.002924151635 -815.149065040098 0 525.931910539594 -792.686960206079 0 546.534401668298 -767.582022520297 0 564.148939689559 -738.512138326754 0 579.747489197717 -703.465388317879 0 594.217626911217 -651.122924008982 0 611.018551518401 -600 99.9999905997116 623.799345110611 -600 44.4444444444444 624.672085048011 -600 72.2222222222222 624.306387174212 -844.01 100 484.65 -675.389608686177 99.9999999999999 602.244654874331 -720.469683699908 99.9999999999999 586.054180523018 -751.281121382868 99.9999999999999 571.785495660309 -778.307453031136 99.9999999999999 555.583712336093 -800.488544684447 100 538.278615843402 -819.320719845863 100 519.284454547985 -832.232461536276 100 502.934189393606 -847.701561514278 89.7550378368762 479.822799628673 -849.844789339418 80.7333815488203 476.951661414416 -851.449556676514 69.0780168924704 475.019510906694 -853.040076734181 42.6079902465845 473.917473448672 -840.700955695436 41.5286964462579 493.94909904962 -834.990361359668 41.0550809400882 502.062545396152 -827.433012777562 40.4502939511619 511.861571762783 -815.005776376874 39.5037994526552 525.975468606164 -808.299111404007 39.0146667935818 532.709060425987 -792.505713131432 37.9130206650714 546.562684318623 -785.833812413812 37.465858542507 551.697560998722 -767.316774173485 36.2707389946432 564.161198439014 -758.3528265468 35.7124781062454 569.406623507563 -738.185074004691 34.4937875695073 579.740638855407 -726.750229220692 33.8209000127148 584.866917566687 -703.150198786788 32.4605662818148 594.185892789052 -679.907875041116 31.1426238929106 602.142264197649 -650.958128777999 29.5053940153788 610.949302483936 -839.985502932586 60.6005313230398 494.356615397882 -834.342250151024 60.0893416365661 502.437038719938 -826.839151537705 59.4369715354494 512.196104427348 -814.443457081537 58.4166810692041 526.252172300208 -807.735223513536 57.8896431808962 532.957999871312 -791.91351204142 56.7029837735284 546.753963507786 -785.225504127886 56.2214027520869 551.867225762495 -766.667869749657 54.9343942834992 564.277657260725 -757.690805825042 54.3332201696429 569.500306141629 -737.516773958127 53.0207898637241 579.788637704749 -726.094136980949 52.2960847345935 584.891818582207 -702.554957511886 50.8308079581659 594.168103070519 -679.413784429294 49.4108627524058 602.087606996513 -650.631018184544 47.6461697882264 610.854371185324 -839.444602217232 67.9980454321491 494.807554170526 -833.823601067343 67.5252605280928 502.851727789385 -826.338786604186 66.9222917988993 512.566859693908 -813.955088880955 65.9799263470599 526.559386634425 -807.247739946806 65.4933700649735 533.234820101109 -791.421639542007 64.3982113996315 546.968228863204 -784.731146954127 63.9538497850109 552.05835863152 -766.170413914352 62.7663980689006 564.413044711631 -757.195350320968 62.2117289343033 569.612540608934 -737.036844039761 61.0007399167566 579.856227216937 -725.630350752314 60.3319739415122 584.937960999682 -702.141346633284 58.9795889918602 594.177005593915 -679.070139828696 57.6687165592634 602.067001623946 -650.398046062921 56.0389570008414 610.803686740066 -837.922477044475 79.967855111685 496.387544908425 -832.327464481488 79.6342329345279 504.306009027529 -824.867258369787 79.2097655240669 513.868304925428 -812.509183999501 78.5481105676131 527.639301820355 -805.81168728756 78.2070890432125 534.208788449324 -790.006733022609 77.4404303602142 547.724876440444 -783.326420237725 77.1295800783214 552.735125920895 -764.80373657283 76.2991248353769 564.899268804675 -755.853859631835 75.9112043057351 570.020810232848 -735.771230977608 75.0640216229008 580.117203616717 -724.420368923617 74.5959521589982 585.130107099331 -701.075891012976 73.648836240283 594.253848561325 -678.185707232279 72.7299389621062 602.057378420705 -649.790131909812 71.5860093396643 610.7105811161 -837.591032868635 81.7785932930655 496.762564652164 -831.999245504502 81.4735543176331 504.651417724748 -824.542882634693 81.0856919622456 514.177621769929 -812.190713271387 80.4815038145166 527.896193701477 -805.496442524261 80.1702422732498 534.440592137179 -789.699820187379 79.4707054089801 547.90527338482 -783.023489388998 79.1871225454692 552.896673646096 -764.513742118518 78.4295640336035 565.016053687714 -755.571253769953 78.0756920882774 570.119403405241 -735.508226974694 77.3028067110439 580.181729467578 -724.170413889665 76.8757343444566 585.178905251153 -700.857524637501 76.011434483847 594.276709557551 -678.0048281095 75.1726847824873 602.061259214453 -649.66519518811 74.1281888798646 610.696598676921 -835.825170418469 89.3522914313473 498.817665651357 -830.249023881351 89.1781919774764 506.545493605987 -822.813779711877 88.957651543062 515.874907879542 -810.498508376565 88.6155245497377 529.306949431567 -803.825719550511 88.4397614619753 535.714085863114 -788.085140386517 88.0455044737814 548.897606679367 -781.435061692114 87.8858589103725 553.786059365955 -763.007049001951 87.4595560132601 565.661642694327 -754.109095234065 87.260408944381 570.666326632874 -734.158870413815 86.8252352100873 580.544877493083 -722.893121254714 86.5845866696326 585.45780167505 -699.748621467016 86.0970765972163 594.417804840998 -677.089384711887 85.6232788283429 602.102668863118 -649.032906853407 85.032090905658 610.645154357537 0 0 1 0 0.0965197781360276 0 0.193039556272055 0 0.29208665768364 0 0.394393627623531 0 0.505133464486122 0 0.631866282618834 0 0.815933141309417 0 1 1 1 0.444444444444444 1 0.722222222222222 0 1 0.713994363849374 1 0.547075117301341 1 0.429180516011584 1 0.319938206808343 1 0.223488174170839 1 0.134139514097002 1 0.0670697570485009 1 0 0.839476090838886 0 0.695004572593883 0 0.530786170749545 0 0.265393085374773 0.0670697570485009 0.265393085374773 0.0965197781360276 0.265393085374773 0.134139514097002 0.265393085374773 0.193039556272055 0.265393085374773 0.223488174170839 0.265393085374773 0.29208665768364 0.265393085374773 0.319938206808343 0.265393085374773 0.394393627623531 0.265393085374773 0.429180516011584 0.265393085374773 0.505133464486122 0.265393085374773 0.547075117301341 0.265393085374773 0.631866282618834 0.265393085374773 0.713994363849374 0.265393085374773 0.815933141309417 0.265393085374773 0.0670697570485009 0.444444444444444 0.0965197781360276 0.444444444444444 0.134139514097002 0.444444444444444 0.193039556272055 0.444444444444444 0.223488174170839 0.444444444444444 0.29208665768364 0.444444444444444 0.319938206808343 0.444444444444444 0.394393627623531 0.444444444444444 0.429180516011584 0.444444444444444 0.505133464486122 0.444444444444444 0.547075117301341 0.444444444444444 0.631866282618834 0.444444444444444 0.713994363849374 0.444444444444444 0.815933141309417 0.444444444444444 0.0670697570485009 0.530786170749545 0.0965197781360276 0.530786170749545 0.134139514097002 0.530786170749545 0.193039556272055 0.530786170749545 0.223488174170839 0.530786170749545 0.29208665768364 0.530786170749545 0.319938206808343 0.530786170749545 0.394393627623531 0.530786170749545 0.429180516011584 0.530786170749545 0.505133464486122 0.530786170749545 0.547075117301341 0.530786170749545 0.631866282618834 0.530786170749545 0.713994363849374 0.530786170749545 0.815933141309417 0.530786170749545 0.0670697570485009 0.695004572593883 0.0965197781360276 0.695004572593883 0.134139514097002 0.695004572593883 0.193039556272055 0.695004572593883 0.223488174170839 0.695004572593883 0.29208665768364 0.695004572593883 0.319938206808343 0.695004572593883 0.394393627623531 0.695004572593883 0.429180516011584 0.695004572593883 0.505133464486122 0.695004572593883 0.547075117301341 0.695004572593883 0.631866282618834 0.695004572593883 0.713994363849374 0.695004572593883 0.815933141309417 0.695004572593883 0.0670697570485009 0.722222222222222 0.0965197781360276 0.722222222222222 0.134139514097002 0.722222222222222 0.193039556272055 0.722222222222222 0.223488174170839 0.722222222222222 0.29208665768364 0.722222222222222 0.319938206808343 0.722222222222222 0.394393627623531 0.722222222222222 0.429180516011584 0.722222222222222 0.505133464486122 0.722222222222222 0.547075117301341 0.722222222222222 0.631866282618834 0.722222222222222 0.713994363849374 0.722222222222222 0.815933141309417 0.722222222222222 0.0670697570485009 0.839476090838886 0.0965197781360276 0.839476090838886 0.134139514097002 0.839476090838886 0.193039556272055 0.839476090838886 0.223488174170839 0.839476090838886 0.29208665768364 0.839476090838886 0.319938206808343 0.839476090838886 0.394393627623531 0.839476090838886 0.429180516011584 0.839476090838886 0.505133464486122 0.839476090838886 0.547075117301341 0.839476090838886 0.631866282618834 0.839476090838886 0.713994363849374 0.839476090838886 0.815933141309417 0.839476090838886 1 25 24 25 1 3 24 25 39 3 27 26 27 3 4 26 27 41 3 26 25 25 26 40 23 39 53 39 23 24 53 39 40 23 53 67 40 41 55 41 40 26 54 55 69 55 54 40 41 42 55 40 54 53 39 25 40 53 54 68 27 28 41 4 28 27 28 4 29 42 28 29 28 42 41 29 5 30 5 29 4 44 29 30 31 30 5 5 6 31 42 29 43 45 30 31 56 43 57 43 56 42 57 43 44 56 57 71 44 45 59 45 44 30 58 59 73 59 58 44 45 46 59 44 58 57 43 29 44 57 58 72 31 32 45 42 56 55 55 56 70 22 67 81 67 22 23 81 67 68 22 81 21 68 69 82 69 68 54 82 69 83 68 82 81 67 53 68 81 82 96 21 95 13 21 81 95 13 95 20 96 83 97 96 95 81 19 96 97 96 19 20 83 84 97 96 20 95 83 96 82 69 70 83 70 71 84 71 70 56 84 71 85 98 97 84 72 73 86 73 72 58 85 86 100 86 85 72 73 87 86 72 85 71 71 57 72 84 85 99 18 19 98 19 97 98 98 84 99 18 98 99 100 87 101 100 18 99 17 100 101 100 17 18 87 88 101 99 85 100 87 100 86 73 74 87 84 83 70 69 55 70 59 60 73 6 33 32 33 6 7 32 33 47 46 45 32 7 35 34 35 7 8 34 35 49 7 34 33 33 34 48 46 47 60 47 46 32 60 47 61 74 73 60 48 49 62 49 48 34 61 62 76 62 61 48 49 63 62 48 61 47 47 33 48 60 61 75 35 36 49 60 59 46 50 49 36 36 8 37 50 36 37 50 63 49 9 2 38 50 37 51 38 37 9 2 11 38 9 37 8 52 37 38 50 64 63 64 50 51 64 51 65 63 64 78 52 11 66 11 52 38 65 66 80 66 65 52 11 12 66 52 65 51 51 37 52 64 65 79 36 35 8 62 63 77 74 75 88 75 74 60 88 75 89 102 101 88 90 89 76 76 89 75 77 76 62 91 76 77 75 61 76 88 89 103 16 17 102 17 101 102 102 88 103 16 102 103 90 91 104 91 90 76 16 104 15 16 103 104 91 105 104 104 103 90 89 90 103 77 78 91 87 74 88 78 79 92 79 78 64 92 79 93 92 105 91 93 80 94 80 93 79 94 12 108 12 94 80 80 66 12 93 94 108 79 65 80 92 93 107 105 106 15 106 105 92 15 106 14 105 15 104 107 108 14 108 107 93 10 14 108 108 12 10 107 14 106 106 92 107 92 91 78 77 63 78 32 31 6 +114 205 1 1.35200975177637 +387.492364175061 726.769262650087 756.721482246979 387.410490640632 727.928389328809 756.560027803797 387.462654121133 727.16077786496 756.704425082116 387.439019336134 727.471494235206 756.664977036833 -20.0008782074741 723.7699094332 692.289879102883 133.123275994854 731.305604598163 712.869447311984 242.080849945331 732.37610302072 728.667515434511 316.039607753441 731.000573264805 741.172257269705 -20.0002757673372 599.999610095597 712.368159334899 -20.0014178866947 692.837016059771 700.138932822838 -20.0010937496279 650.662217190383 706.773834964133 206.960181655448 599.999226408255 745.280107946042 75.7222845935669 599.998952976953 725.789289737669 139.733517556626 599.998699044636 734.971852394602 224.393590584242 634.778885029338 744.437821414934 244.063915954728 662.777802534705 743.890354698117 265.533650033631 684.680063903231 743.802783729043 288.365103432233 701.170527705535 744.34007649512 312.120586761814 712.934052512236 745.667200983758 336.362410633653 720.655496893952 747.949125182364 362.16241507513 725.196618047142 751.604326027148 62.2940250206895 623.199876254668 721.656000142588 82.7374063723225 624.829385154595 724.362591935519 119.845009061834 627.63665725489 729.35094254403 151.754186561514 629.910908020904 733.762095950341 157.960344153949 630.340453556781 734.636867318698 197.152902950857 632.982231383459 740.316477419028 204.439039855507 633.464005302713 741.405841330817 211.915554262409 633.956934945161 742.535999001263 68.7486990625052 643.678052002853 720.291710378269 90.7290722879117 646.42601554973 723.059120973354 130.777548083913 651.121871067894 728.178655632601 165.390253983877 654.883028984512 732.74097374383 172.134883068979 655.588457881032 733.650032572213 214.699685836365 659.889423843385 739.580792034141 222.583418164103 660.666705134233 740.722321340157 230.653460096223 661.459772145243 741.907204181143 75.8381875870099 661.63046070162 719.012207936923 99.5097564641615 665.047480182802 721.882428536412 142.773600110277 670.82016445025 727.212185198928 180.320375265463 675.370472355093 731.99543550711 187.647736971647 676.215730660694 732.952442145899 233.859817360843 681.310859572093 739.221273905487 242.39136212261 682.221254949481 740.431374788245 251.106128721987 683.147134203119 741.687977157705 78.188297836383 666.810427504506 718.624009406474 102.420853276441 670.355269009125 721.537432513735 146.747843970564 676.316401477557 726.95544245543 185.260916642098 680.98521118234 731.828869820626 192.779867204593 681.849180380522 732.805087666203 240.190057127317 687.034568225344 739.206882353954 248.934471592258 687.957256210226 740.443617266537 257.861229575694 688.894617068147 741.728031113956 83.4231073782294 677.249424352353 717.809525248489 108.906099851327 680.947253228927 720.83614190138 155.598569863844 687.090601103643 726.486856263016 196.25560146131 691.821025867206 731.596063711252 204.198937442137 692.687640304231 732.622176886271 254.257727785538 697.831620637929 739.367527293977 263.471699518641 698.737664547248 740.673029690983 272.865721140895 699.655878385471 742.029373415277 91.3769582054318 690.720237752258 716.681691088029 118.764555895995 694.371958492869 719.926003549814 169.054223776723 700.287642158407 726.030267865955 212.955999921667 704.681030744635 731.599250383088 221.538935236913 705.468724607787 732.722608490895 275.558350830253 710.038358621989 740.141328017406 285.466496784995 710.827430928762 741.583349505287 295.547671268642 711.623997129304 743.083525834534 99.5892395070769 702.218720807066 715.635409567558 128.95686401086 705.559681711686 719.163122676393 182.990410977485 710.763190199094 725.866567151844 230.247605984434 714.401558742131 732.051179120971 239.486207150508 715.029532986156 733.306042303416 297.481911119399 718.526521557345 741.654319927287 308.063275722778 719.10965271599 743.290032114528 318.799307205636 719.695024827958 744.996664259931 104.871227768977 708.544219994644 715.023746947811 135.525994648928 711.581092791093 718.765339459469 192.003525165806 716.139907285931 725.925306491396 241.437311464456 719.134877728005 732.58653158061 251.096316809506 719.629811117435 733.944479052328 311.562715237149 722.249570546269 743.03744579987 322.538987265199 722.666424233484 744.832271563928 333.64715910798 723.08167431407 746.710122080562 108.496027371419 712.457760767523 714.633537933233 140.043443924456 715.250150533873 718.536180271829 198.224139725975 719.304498508593 726.04155384117 249.167395755219 721.806642890799 733.067669879338 259.114876280906 722.200392670686 734.50527665663 321.224901009288 724.15503316637 744.182495377108 332.447883933623 724.445687579634 746.104194670628 343.779809534028 724.731580873048 748.119358048379 117.509676902796 720.833825722594 713.783409961656 151.325365773605 722.930906776906 718.136360097834 213.879782314514 725.593687318682 726.611845608084 268.668027041065 726.764835118307 734.681122425203 279.335475978355 726.886317360414 736.349682130612 345.2894635065 727.038725285112 747.757618756588 357.006571220374 726.981845015642 750.063337865034 368.738340006634 726.908388939315 752.497134416914 124.367665148916 726.029123385118 713.277244616341 159.976118802537 727.55380410489 718.019357489295 226.052052514985 729.116131883724 727.334982676097 283.900066106695 729.25826484388 736.327186833567 295.121468154722 729.16858560284 738.203546011039 363.690886410612 727.884356580882 751.206587762804 375.626555062198 727.537698673444 753.874235894997 128.723988691551 728.842025891588 713.035064256984 165.512958679416 730.002816335807 718.044477391484 233.947531212001 730.892458564274 727.936519966264 293.826087667445 730.417044109967 737.571054323871 305.404263336933 730.199439033048 739.593661016227 375.453808669333 728.009483491696 753.736156342865 0.91666 0.76395 0.83071 0.91687 0.877351358024702 0.831280150891615 0.853754444444445 0.873925898491083 0.08333 0.91667 0.382285983616 0.91666753216 0.579955009193869 0.916675783155003 0.705335025297207 0.916707291241829 0.08333 0.08333 0.08333 0.63889 0.08333 0.36111 0.91667 0.08333 0.453703333333333 0.08333 0.685186666666667 0.08333 0.916670778374132 0.167097616293149 0.916672591471609 0.250865344448781 0.91667465625505 0.334633296329378 0.916676189687073 0.418401583797425 0.9166764087303 0.502170318715403 0.916674530347348 0.585939612945796 0.916669360627152 0.674944360548006 0.382285983616 0.167097616293149 0.453703333333333 0.167097616293149 0.579955009193869 0.167097616293149 0.685186666666667 0.167097616293149 0.705335025297207 0.167097616293149 0.83071 0.167097616293149 0.853754444444445 0.167097616293149 0.877351358024702 0.167097616293149 0.382285983616 0.250865344448781 0.453703333333333 0.250865344448781 0.579955009193869 0.250865344448781 0.685186666666667 0.250865344448781 0.705335025297207 0.250865344448781 0.83071 0.250865344448781 0.853754444444445 0.250865344448781 0.877351358024702 0.250865344448781 0.382285983616 0.334633296329378 0.453703333333333 0.334633296329378 0.579955009193869 0.334633296329378 0.685186666666667 0.334633296329378 0.705335025297207 0.334633296329378 0.83071 0.334633296329378 0.853754444444445 0.334633296329378 0.877351358024702 0.334633296329378 0.382285983616 0.36111 0.453703333333333 0.36111 0.579955009193869 0.36111 0.685186666666667 0.36111 0.705335025297207 0.36111 0.83071 0.36111 0.853754444444445 0.36111 0.877351358024702 0.36111 0.382285983616 0.418401583797425 0.453703333333333 0.418401583797425 0.579955009193869 0.418401583797425 0.685186666666667 0.418401583797425 0.705335025297207 0.418401583797425 0.83071 0.418401583797425 0.853754444444445 0.418401583797425 0.877351358024702 0.418401583797425 0.382285983616 0.502170318715403 0.453703333333333 0.502170318715403 0.579955009193869 0.502170318715403 0.685186666666667 0.502170318715403 0.705335025297207 0.502170318715403 0.83071 0.502170318715403 0.853754444444445 0.502170318715403 0.877351358024702 0.502170318715403 0.382285983616 0.585939612945796 0.453703333333333 0.585939612945796 0.579955009193869 0.585939612945796 0.685186666666667 0.585939612945796 0.705335025297207 0.585939612945796 0.83071 0.585939612945796 0.853754444444445 0.585939612945796 0.877351358024702 0.585939612945796 0.382285983616 0.63889 0.453703333333333 0.63889 0.579955009193869 0.63889 0.685186666666667 0.63889 0.705335025297207 0.63889 0.83071 0.63889 0.853754444444445 0.63889 0.877351358024702 0.63889 0.382285983616 0.674944360548006 0.453703333333333 0.674944360548006 0.579955009193869 0.674944360548006 0.685186666666667 0.674944360548006 0.705335025297207 0.674944360548006 0.83071 0.674944360548006 0.853754444444445 0.674944360548006 0.877351358024702 0.674944360548006 0.382285983616 0.76395 0.453703333333333 0.76395 0.579955009193869 0.76395 0.685186666666667 0.76395 0.705335025297207 0.76395 0.83071 0.76395 0.853754444444445 0.76395 0.877351358024702 0.76395 0.382285983616 0.831280150891615 0.453703333333333 0.831280150891615 0.579955009193869 0.831280150891615 0.685186666666667 0.831280150891615 0.705335025297207 0.831280150891615 0.83071 0.831280150891615 0.853754444444445 0.831280150891615 0.382285983616 0.873925898491083 0.453703333333333 0.873925898491083 0.579955009193869 0.873925898491083 0.685186666666667 0.873925898491083 0.705335025297207 0.873925898491083 0.83071 0.873925898491083 9 22 30 22 9 13 30 22 23 11 9 30 31 30 23 23 13 24 38 31 39 38 30 31 23 24 31 23 22 13 11 30 38 11 46 54 11 38 46 54 46 47 11 54 62 55 54 47 47 39 40 62 55 63 62 54 55 47 48 55 47 46 39 38 39 46 11 62 10 31 32 39 40 39 32 32 24 25 40 32 33 48 47 40 14 25 24 25 14 26 41 33 34 26 33 25 14 27 26 25 33 32 24 13 14 40 33 41 55 56 63 55 48 56 56 48 49 63 56 64 57 56 49 42 49 41 64 57 65 64 56 57 57 49 50 49 48 41 48 40 41 63 64 72 57 58 65 32 31 24 62 63 71 10 70 78 10 62 70 78 70 71 10 78 86 79 86 78 79 71 72 86 87 95 87 86 79 79 80 87 79 78 71 62 71 70 10 86 94 5 94 102 94 5 10 102 94 95 5 102 109 103 109 102 103 95 96 109 6 5 110 6 109 109 103 110 103 102 95 94 86 95 87 88 95 88 87 80 80 72 73 88 80 81 96 95 88 65 73 72 66 73 65 81 89 88 82 89 81 81 73 74 73 81 80 71 63 72 88 89 97 104 110 103 104 96 97 110 111 7 111 110 104 104 105 111 103 96 104 112 111 105 98 105 97 7 112 8 7 111 112 112 105 106 105 104 97 96 88 97 110 7 6 97 89 90 80 79 72 72 64 65 33 26 34 42 34 35 34 26 27 35 34 27 34 42 41 35 28 36 28 35 27 43 36 44 36 43 35 28 29 36 35 43 42 27 12 28 42 43 51 50 58 57 58 50 51 66 58 59 58 66 65 59 51 52 51 50 42 59 67 66 60 67 59 52 51 44 51 59 58 43 44 51 66 67 75 36 37 44 42 50 49 45 44 37 37 29 15 45 37 16 45 52 44 12 15 29 16 17 45 15 16 37 29 28 12 45 17 53 52 60 59 60 52 53 68 60 61 60 68 67 53 61 60 61 53 18 69 18 19 18 69 61 53 17 18 61 69 68 52 45 53 68 69 77 37 36 29 14 12 27 67 68 76 74 82 81 82 74 75 90 82 83 82 90 89 91 90 83 83 75 76 98 91 99 98 90 91 83 84 91 83 82 75 66 75 74 90 98 97 106 113 112 113 106 107 8 113 114 113 8 112 99 107 106 107 99 100 114 2 8 2 114 4 107 108 114 107 114 113 106 98 99 91 92 99 98 106 105 76 84 83 84 76 77 92 84 85 84 92 91 69 20 77 77 76 68 92 85 93 20 85 77 77 85 84 75 67 76 21 85 20 108 100 101 93 100 92 108 4 114 3 4 108 101 100 93 100 108 107 93 1 101 1 93 21 1 3 101 101 3 108 93 85 21 92 100 99 69 19 20 66 74 73 +59 97 1 2.16902848505362 +-600 643.12 581.66 -20.0008782074741 723.7699094332 692.289879102883 -382.737825190752 683.625099256831 632.887023950974 -196.717985260504 707.998652214668 665.968331873236 -20.0008383170068 782.649983376266 639.339819879385 -20.0016844888228 778.959017557459 648.758695874275 -20.0016919016563 773.361326004529 658.47858780591 -20.0017000976408 766.397345276115 667.052961662103 -20.0017098067058 758.309225097574 674.391145852768 -20.0017224069698 748.236422654507 681.234102917872 -20.0017367864988 737.063331299064 686.996815825023 -600 684.65 555.24 -272.680688919372 754.872154481871 610.013535538282 -439.143282750343 726.345405642983 584.673741601255 -600 653.932657404614 577.975495309001 -600 662.945171116019 573.811257888746 -600 670.931561759922 568.826965313624 -600 677.43636218902 563.354562894011 -600 681.307972830445 559.262748241252 -443.732996410813 684.019288308994 616.754241694388 -382.055224664222 694.473568300906 629.223331605441 -277.307372991253 709.917092943902 648.23026935502 -196.305166657093 720.116279117309 661.461413178431 -443.503527686685 687.451942130232 615.402416959115 -381.799210219745 698.067355555141 627.778500728698 -277.072479201353 713.736473234305 646.626506493408 -196.152833085758 724.094067650563 659.721926726015 -443.095740844337 693.050294250784 612.916761252334 -381.346546370737 703.922612848266 625.123650963379 -276.659518699237 719.939581629166 643.687964939529 -195.885786556594 730.529110627085 656.542532551782 -442.622300525414 698.878199867651 609.891616871389 -380.823093147859 710.011001565548 621.889354884634 -276.184290965438 726.359175879769 640.1118848558 -195.579452878498 737.149670744387 652.681909568288 -442.38306931616 701.585510867578 608.306482451315 -380.558973057892 712.83639478364 620.191897599189 -275.944982254945 729.325180887998 638.234006461213 -195.42546337067 740.192667491163 650.656685814871 -441.643385386881 709.070146882231 603.185157151605 -379.742317606568 720.629297073489 614.693854576917 -275.205241515125 737.445272400765 632.140111957319 -194.949786493314 748.459576449316 644.08781160275 -440.879274443604 715.538356482723 597.618194110904 -378.897052001184 727.314594150178 608.699978810437 -274.437745049153 744.297819640897 625.477394557648 -194.455334764949 755.338164721618 636.904995019914 -440.62893859845 717.403081342495 595.755256978189 -378.619645878225 729.224561894285 606.692473908021 -274.18522997779 746.224156266557 623.243419192061 -194.292226291471 757.249063541683 634.496431959964 -440.009353634183 721.532444811641 591.113006670607 -377.932242509989 733.405415670875 601.691712511382 -273.558332008319 750.364484368653 617.680598667702 -193.886396838729 761.307520387586 628.502194398677 -439.884895576406 722.285686117906 590.180526913666 -377.794066897919 734.15839765771 600.688064480289 -273.432183111331 751.095830340038 616.565513529924 -193.804634021291 762.015667802552 627.301965127741 0 0 1 0 0.381610935490252 0 0.690805467745126 0 1 1 1 0.833333333333333 1 0.666666666666667 1 0.516666666666667 1 0.381666666666667 1 0.246666666666667 1 0.123333333333334 0 1 0.555555555555556 1 0.277777777777778 1 0 0.168245098486514 0 0.336490196973029 0 0.521399882325375 0 0.714508733836577 0 0.857254366918289 0.277777777777778 0.123333333333334 0.381610935490252 0.123333333333334 0.555555555555556 0.123333333333334 0.690805467745126 0.123333333333334 0.277777777777778 0.168245098486514 0.381610935490252 0.168245098486514 0.555555555555556 0.168245098486514 0.690805467745126 0.168245098486514 0.277777777777778 0.246666666666667 0.381610935490252 0.246666666666667 0.555555555555556 0.246666666666667 0.690805467745126 0.246666666666667 0.277777777777778 0.336490196973029 0.381610935490252 0.336490196973029 0.555555555555556 0.336490196973029 0.690805467745126 0.336490196973029 0.277777777777778 0.381666666666667 0.381610935490252 0.381666666666667 0.555555555555556 0.381666666666667 0.690805467745126 0.381666666666667 0.277777777777778 0.521399882325375 0.381610935490252 0.521399882325375 0.555555555555556 0.521399882325375 0.690805467745126 0.521399882325375 0.277777777777778 0.666666666666667 0.381610935490252 0.666666666666667 0.555555555555556 0.666666666666667 0.690805467745126 0.666666666666667 0.277777777777778 0.714508733836577 0.381610935490252 0.714508733836577 0.555555555555556 0.714508733836577 0.690805467745126 0.714508733836577 0.277777777777778 0.833333333333333 0.381610935490252 0.833333333333333 0.555555555555556 0.833333333333333 0.690805467745126 0.833333333333333 0.277777777777778 0.857254366918289 0.381610935490252 0.857254366918289 0.555555555555556 0.857254366918289 0.690805467745126 0.857254366918289 1 20 15 20 1 3 15 20 24 15 28 16 28 15 24 28 32 16 32 28 29 24 25 28 16 32 36 20 21 24 25 24 21 21 3 22 25 21 22 29 28 25 32 33 36 32 29 33 33 37 36 37 33 34 29 30 33 36 37 41 25 26 29 21 20 3 16 36 17 17 40 44 40 17 36 44 40 41 17 44 18 52 19 18 48 52 18 19 56 12 18 44 48 44 45 48 45 49 48 45 44 41 49 52 48 49 45 46 41 42 45 52 49 53 56 14 12 14 56 57 53 57 56 57 53 54 56 52 53 14 57 13 49 50 53 52 56 19 40 36 41 37 38 41 22 4 23 4 22 3 23 4 2 22 23 26 26 30 29 27 30 26 34 38 37 35 38 34 34 30 31 30 34 33 23 27 26 22 26 25 27 31 30 10 31 27 11 27 23 23 2 11 10 27 11 35 39 38 39 35 9 10 9 35 35 31 10 39 9 8 31 35 34 38 39 43 42 43 46 42 38 43 50 46 47 42 46 45 50 54 53 51 54 50 58 13 57 59 13 58 58 54 55 54 58 57 46 43 47 46 50 49 47 51 50 51 47 7 7 47 43 43 8 7 51 7 6 55 59 58 59 55 6 6 5 59 55 51 6 59 5 13 51 55 54 39 8 43 38 42 41 +92 160 1 1.40886617592056 +-600 199.999943687854 620.968655318947 -808.77 200 519.08 -639.743564497282 200 609.810366814002 -691.73343291165 200 593.241802062694 -730.643407749375 200 577.696675341829 -761.135344497973 200 561.779359808091 -783.439732523311 200 546.224134317061 -797.316742285198 200 533.388899938402 -600 643.12 581.66 -600 424.599991193754 609.59352554658 -600 526.553251028806 600.871563786008 -600 582.052261385982 593.947748965666 -600 615.578930974202 588.215548875272 -676.88 623 542.55 -661.306034666644 627.817670454896 553.953968452367 -647.970487368622 631.593041709942 562.496723555137 -635.136385031971 634.923519440911 569.36187287045 -623.06850565298 637.831467182907 574.469879869451 -611.565245965293 640.486122029015 578.303435008574 -722.287775122557 530.57901934629 537.032280629449 -767.353720108064 391.98021219261 531.300812090092 -790.028795336993 297.364815614082 526.456421299074 -778.414600383252 298.438151542201 539.167070459858 -766.103942710827 299.368951676096 549.669484551987 -744.268916832511 300.740341563767 564.076390000506 -736.902614136919 301.152481023702 568.131375495207 -716.588054676107 302.207633054435 577.899964727957 -701.256684884665 302.951446354864 584.25056310474 -681.900016601717 303.857425882888 591.396790790562 -663.230908526409 304.723559798617 597.641427036228 -636.020020805727 306.038286622474 606.03119928854 -627.919561483582 306.459501501739 608.425646753962 -756.09751257903 394.110462117221 542.550533960013 -744.645787611099 395.957868644102 551.800689542954 -725.001892227877 398.679450699402 564.426273591359 -718.500424621985 399.497446415513 567.96748982168 -700.788392819883 401.592258234282 576.479100791744 -687.57465360887 403.069689650272 582.001298603691 -671.011142147741 404.870041245674 588.211648311128 -655.098943454572 406.591448290987 593.645326982673 -631.84736303401 409.201143980295 600.989733033034 -624.860980694026 410.035024028274 603.106462551635 -753.432278369523 404.309913883788 542.825514829251 -742.093084391462 406.251080075846 551.94134007924 -722.719145910162 409.110244263914 564.377409202734 -716.322147533473 409.969505713336 567.864164149524 -698.921418372115 412.169930854069 576.242410389424 -685.958772132018 413.721863516452 581.676151327168 -669.724316589278 415.613049729828 587.785249883608 -654.135034441764 417.421257010937 593.129206298063 -631.345513749113 420.161664410222 600.353238527761 -624.48950607625 421.036778005989 602.436579874195 -724.847990047893 499.33174937668 545.024358040917 -714.781186520804 501.992277901313 552.77948472316 -698.352096718529 505.887739775835 563.296548366422 -693.078962428466 507.053833864314 566.230255120198 -679.001307327612 510.032855814689 573.246886540941 -668.70061878256 512.129486297358 577.76862849014 -655.939553731863 514.68091281099 582.820919507667 -643.750476990236 517.115748877861 587.213151453902 -625.837216692533 520.784553463201 593.129361650333 -620.36908097416 521.94530267286 594.841020185314 -712.219019560841 533.822338788717 545.820594237717 -702.749354171558 536.605053469218 552.989668292548 -687.648868538052 540.654990915854 562.676649324516 -682.874032273442 541.861947811977 565.369295957509 -670.254505360615 544.935368047976 571.786855782632 -661.11096593329 547.090952760995 575.901857795792 -649.851351483347 549.707235900724 580.476525323055 -639.128420701602 552.197561167345 584.43272379811 -623.327725557796 555.935508123526 589.740666921388 -618.468663966123 557.112718962565 591.277173581623 -703.80826272668 554.583800964373 546.353769882839 -694.750543541716 557.374193239949 553.130871352022 -680.546688817944 561.411702358844 562.260973424475 -676.104736219337 562.60953760375 564.791172441354 -664.453297963713 565.649087891448 570.803014040441 -656.073730066283 567.772571987316 574.64072391163 -645.802091028143 570.341973725894 578.887926983904 -636.042434308887 572.780813173766 582.543764550922 -621.633150745656 576.430115203036 587.431430768402 -617.177948581108 577.576274679732 588.846793027416 -687.085869732522 591.204926743646 547.476937198799 -678.887844282636 593.83101063389 553.466103681185 -666.500564898403 597.561276184881 561.473140682719 -662.723810891161 598.651383475283 563.674112929539 -652.990890593191 601.383426675814 568.859138576735 -646.113953893328 603.264312856395 572.127546004352 -637.776678742101 605.51319044857 575.698127254274 -629.898765598721 607.625594771476 578.730046793231 -618.214846961738 610.760299189158 582.742144620922 -614.556976283294 611.741590616378 583.905191130882 1 0 0 0 0.777777777777778 0 0.555555555555556 0 0.396154886749153 0 0.264082152703618 0 0.155964447802209 0 0.0779822239011045 0 1 1 1 0.444444444444444 1 0.666666666666667 1 0.805105083095377 1 0.902552541547688 0 1 0.15007693011773 1 0.30015386023546 1 0.466755908727092 1 0.642741771698651 1 0.821370885849325 1 0 0.752041319202292 0 0.421429744805347 0 0.210714872402674 0.0779822239011045 0.210714872402674 0.15007693011773 0.210714872402674 0.264082152703618 0.210714872402674 0.30015386023546 0.210714872402674 0.396154886749153 0.210714872402674 0.466755908727092 0.210714872402674 0.555555555555556 0.210714872402674 0.642741771698651 0.210714872402674 0.777777777777778 0.210714872402674 0.821370885849325 0.210714872402674 0.0779822239011045 0.421429744805347 0.15007693011773 0.421429744805347 0.264082152703618 0.421429744805347 0.30015386023546 0.421429744805347 0.396154886749153 0.421429744805347 0.466755908727092 0.421429744805347 0.555555555555556 0.421429744805347 0.642741771698651 0.421429744805347 0.777777777777778 0.421429744805347 0.821370885849325 0.421429744805347 0.0779822239011045 0.444444444444444 0.15007693011773 0.444444444444444 0.264082152703618 0.444444444444444 0.30015386023546 0.444444444444444 0.396154886749153 0.444444444444444 0.466755908727092 0.444444444444444 0.555555555555556 0.444444444444444 0.642741771698651 0.444444444444444 0.777777777777778 0.444444444444444 0.821370885849325 0.444444444444444 0.0779822239011045 0.666666666666667 0.15007693011773 0.666666666666667 0.264082152703618 0.666666666666667 0.30015386023546 0.666666666666667 0.396154886749153 0.666666666666667 0.466755908727092 0.666666666666667 0.555555555555556 0.666666666666667 0.642741771698651 0.666666666666667 0.777777777777778 0.666666666666667 0.821370885849325 0.666666666666667 0.0779822239011045 0.752041319202292 0.15007693011773 0.752041319202292 0.264082152703618 0.752041319202292 0.30015386023546 0.752041319202292 0.396154886749153 0.752041319202292 0.466755908727092 0.752041319202292 0.555555555555556 0.752041319202292 0.642741771698651 0.752041319202292 0.777777777777778 0.752041319202292 0.821370885849325 0.752041319202292 0.0779822239011045 0.805105083095377 0.15007693011773 0.805105083095377 0.264082152703618 0.805105083095377 0.30015386023546 0.805105083095377 0.396154886749153 0.805105083095377 0.466755908727092 0.805105083095377 0.555555555555556 0.805105083095377 0.642741771698651 0.805105083095377 0.777777777777778 0.805105083095377 0.821370885849325 0.805105083095377 0.0779822239011045 0.902552541547688 0.15007693011773 0.902552541547688 0.264082152703618 0.902552541547688 0.30015386023546 0.902552541547688 0.396154886749153 0.902552541547688 0.466755908727092 0.902552541547688 0.555555555555556 0.902552541547688 0.642741771698651 0.902552541547688 0.777777777777778 0.902552541547688 0.821370885849325 0.902552541547688 22 2 8 8 24 23 24 8 7 23 24 34 8 23 22 22 23 33 21 33 43 33 21 22 43 33 34 21 43 53 43 44 53 44 43 34 44 34 35 54 53 44 33 23 34 21 53 20 24 25 34 7 6 25 25 6 26 25 35 34 26 5 27 5 26 6 27 5 28 26 27 37 25 26 36 35 36 45 36 35 25 45 36 46 45 44 35 46 37 47 37 46 36 47 37 38 56 45 46 36 26 37 55 44 45 27 28 37 24 7 25 57 46 47 20 63 73 20 53 63 54 55 64 55 54 44 74 64 65 54 64 63 53 54 63 63 64 74 20 83 14 83 20 73 83 73 74 14 83 15 74 84 83 75 84 74 85 15 84 84 15 83 73 63 74 55 65 64 75 65 66 56 65 55 66 65 56 65 75 74 66 57 67 57 66 56 67 57 58 75 66 76 56 46 57 77 66 67 85 76 86 76 85 75 86 76 77 85 86 16 86 87 16 87 86 77 87 77 78 16 87 17 76 66 77 85 16 15 67 68 77 75 85 84 55 45 56 47 48 57 28 38 37 38 28 29 4 30 29 30 4 3 38 29 39 4 29 28 28 5 4 40 29 30 58 48 49 39 48 38 49 48 39 48 58 57 59 49 50 40 49 39 50 49 40 49 59 58 39 29 40 58 59 69 30 31 40 38 48 47 41 40 31 31 3 32 41 31 32 41 50 40 42 32 10 1 32 3 10 32 1 32 42 41 41 42 52 50 51 60 51 50 41 60 51 61 50 60 59 62 61 52 52 61 51 10 52 42 11 52 10 51 41 52 60 61 71 31 30 3 59 60 70 68 78 77 78 68 69 69 70 79 69 59 70 79 70 80 69 79 78 58 69 68 78 79 89 88 89 17 88 78 89 17 89 18 88 17 87 80 90 89 90 80 81 18 90 91 90 18 89 79 80 89 70 71 80 78 88 87 81 71 72 71 70 60 72 71 62 71 81 80 82 72 12 11 72 62 12 72 11 72 82 81 62 52 11 81 82 92 91 92 19 91 81 92 19 92 13 91 19 18 12 13 92 13 9 19 82 12 92 81 91 90 71 61 62 58 68 67 +77 130 1 0.522661279396088 +-600 99.9999905997116 623.799345110611 -844.01 100 484.65 -675.389608686177 99.9999999999999 602.244654874331 -720.469683699908 99.9999999999999 586.054180523018 -751.281121382868 99.9999999999999 571.785495660309 -778.307453031136 99.9999999999999 555.583712336093 -800.488544684447 100 538.278615843402 -819.320719845863 100 519.284454547985 -832.232461536276 100 502.934189393606 -600 199.999943687854 620.968655318947 -600 144.480109739369 622.715884773663 -600 172.25677297668 621.893868312757 -808.77 200 519.08 -639.743564497282 200 609.810366814002 -691.73343291165 200 593.241802062694 -730.643407749375 200 577.696675341829 -761.135344497973 200 561.779359808091 -783.439732523311 200 546.224134317061 -797.316742285198 200 533.388899938402 -814.714469261638 173.409788981444 515.572848843427 -821.429414638876 153.243639335392 510.570160718474 -831.792692052431 128.483523280252 499.981883351977 -818.274655469035 128.58327431279 518.166711380294 -807.614945519279 128.652318119659 529.90026750843 -803.267233025457 128.678751905802 534.170244846382 -789.138613680144 128.759564726866 546.415627412861 -780.188236535377 128.807689570125 553.118049837828 -767.374531144967 128.873665706288 561.5999249941 -749.094780521064 128.963714736801 571.927947813899 -740.938943462096 129.002861780529 576.003853745626 -708.848459588512 129.153854034706 589.732438948841 -668.03340243105 129.34548342855 603.729215393528 -651.915868820525 129.422684214269 608.624531490418 -813.195199159163 140.972399338513 522.878001937472 -802.610968253511 141.193455424662 533.927050846787 -798.287674450251 141.277796658479 537.954744379272 -784.225711926397 141.534897080765 549.530058038485 -775.314309556652 141.687602575519 555.883926602689 -762.560981675357 141.896625428933 563.946556296718 -744.391725276011 142.181513415574 573.801451534787 -736.299062947157 142.305267077989 577.702746687571 -704.576876054322 142.782324626443 590.890566157515 -664.63246374107 143.388401810874 604.367298379381 -649.038433432455 143.633632336535 609.062119885255 -808.516175011306 153.770450403119 526.717391827636 -798.080601161413 154.127405953343 537.198135579499 -793.796177264268 154.262490152625 541.026776782195 -779.810262512078 154.671491243668 552.057109759885 -770.925300222578 154.913028944318 558.130529381402 -758.201983616393 155.242760149588 565.858223061645 -740.089918402872 155.691716585776 575.337272187979 -732.036045702333 155.886878053237 579.09995790434 -700.593011231763 156.641272343835 591.854451791535 -661.41861823455 157.605108804294 604.894935823671 -646.306824125603 157.99647753676 609.412909330547 -804.740896953084 166.07561315663 529.387249566449 -794.508701094468 166.477558037317 539.454782803095 -790.276235676874 166.628301991021 543.140281854245 -776.385021780957 167.08126636264 553.783066688096 -767.525366945654 167.347040127309 559.659618411336 -754.819335240014 167.70877369658 567.154560674869 -736.730820786799 168.200823607602 576.375514528506 -728.696118863753 168.414932116052 580.043789839603 -697.428838626141 169.245420491649 592.50462425562 -658.817466564542 170.31352489709 605.244009679572 -644.075450152119 170.74874289473 609.634427272518 -802.669953871625 173.981260925787 530.672149607313 -792.575933283135 174.356301103873 540.530793803463 -788.379978238973 174.496130208704 544.144338640942 -774.559028367914 174.914195743967 554.593492832432 -765.720427690212 175.158434671382 560.372447726735 -753.029963293859 175.490193129878 567.752856221004 -734.956642378938 175.941183544184 576.848301194929 -726.93147630205 176.137563913204 580.471216771724 -695.746599876785 176.901088660213 592.793688891674 -657.407773070236 177.887450300566 605.394088754992 -642.852090343069 178.29025871544 609.7239817574 1 0 0 0 0.713994363849374 0 0.547075117301341 0 0.429180516011584 0 0.319938206808343 0 0.223488174170839 0 0.134139514097002 0 0.0670697570485009 0 1 1 1 0.444444444444444 1 0.722222222222222 0 1 0.777777777777778 1 0.555555555555556 1 0.396154886749153 1 0.264082152703618 1 0.155964447802209 1 0.0779822239011045 1 0 0.796567190983301 0 0.593134381966603 0 0.296567190983301 0.0779822239011045 0.296567190983301 0.134139514097002 0.296567190983301 0.155964447802209 0.296567190983301 0.223488174170839 0.296567190983301 0.264082152703618 0.296567190983301 0.319938206808343 0.296567190983301 0.396154886749153 0.296567190983301 0.429180516011584 0.296567190983301 0.555555555555556 0.296567190983301 0.713994363849374 0.296567190983301 0.777777777777778 0.296567190983301 0.0779822239011045 0.444444444444444 0.134139514097002 0.444444444444444 0.155964447802209 0.444444444444444 0.223488174170839 0.444444444444444 0.264082152703618 0.444444444444444 0.319938206808343 0.444444444444444 0.396154886749153 0.444444444444444 0.429180516011584 0.444444444444444 0.555555555555556 0.444444444444444 0.713994363849374 0.444444444444444 0.777777777777778 0.444444444444444 0.0779822239011045 0.593134381966603 0.134139514097002 0.593134381966603 0.155964447802209 0.593134381966603 0.223488174170839 0.593134381966603 0.264082152703618 0.593134381966603 0.319938206808343 0.593134381966603 0.396154886749153 0.593134381966603 0.429180516011584 0.593134381966603 0.555555555555556 0.593134381966603 0.713994363849374 0.593134381966603 0.777777777777778 0.593134381966603 0.0779822239011045 0.722222222222222 0.134139514097002 0.722222222222222 0.155964447802209 0.722222222222222 0.223488174170839 0.722222222222222 0.264082152703618 0.722222222222222 0.319938206808343 0.722222222222222 0.396154886749153 0.722222222222222 0.429180516011584 0.722222222222222 0.555555555555556 0.722222222222222 0.713994363849374 0.722222222222222 0.777777777777778 0.722222222222222 0.0779822239011045 0.796567190983301 0.134139514097002 0.796567190983301 0.155964447802209 0.796567190983301 0.223488174170839 0.796567190983301 0.264082152703618 0.796567190983301 0.319938206808343 0.796567190983301 0.396154886749153 0.796567190983301 0.429180516011584 0.796567190983301 0.555555555555556 0.796567190983301 0.713994363849374 0.796567190983301 0.777777777777778 0.796567190983301 22 2 9 22 9 23 23 9 8 22 34 21 34 22 23 45 34 35 24 34 23 35 34 24 34 45 21 23 8 24 21 45 56 8 25 24 25 7 26 7 25 8 7 27 26 27 7 6 27 6 28 26 27 38 25 26 37 45 35 46 35 25 36 26 38 37 37 36 25 49 38 39 48 36 37 38 27 28 47 35 36 6 29 28 25 35 24 49 37 38 56 46 57 56 20 21 68 57 58 47 57 46 46 35 47 56 57 68 13 20 67 67 68 19 68 67 56 19 68 18 67 19 13 20 56 67 57 47 58 56 45 46 58 48 59 48 58 47 59 49 60 49 59 48 50 60 49 59 60 71 48 37 49 58 59 70 69 18 68 18 69 70 70 71 17 71 70 59 72 17 71 70 17 18 69 58 70 71 60 61 58 69 68 47 36 48 38 28 39 40 39 29 39 28 29 5 30 29 30 5 4 6 5 29 41 29 30 50 40 51 40 50 39 51 41 52 41 51 40 52 41 42 51 52 63 40 29 41 50 51 62 30 31 41 39 50 49 31 42 41 31 4 3 32 3 33 33 3 1 3 32 31 31 32 43 52 42 53 42 31 43 33 11 44 11 33 1 55 43 44 33 44 43 32 33 43 54 42 43 31 30 4 55 44 11 61 62 73 61 50 62 63 53 64 63 62 51 64 53 54 63 64 75 53 63 52 62 63 74 72 73 16 73 72 61 15 16 74 74 16 73 75 74 63 15 74 75 73 62 74 72 16 17 64 65 75 61 72 71 76 75 65 65 54 55 55 12 66 12 55 11 66 12 77 55 66 65 54 43 55 65 66 77 15 76 14 15 75 76 77 10 14 10 77 12 77 14 76 76 65 77 65 64 54 53 42 54 50 61 60 +122 219 1 0.440373921396032 +387.410490640632 727.928389328809 756.560027803797 324.999364674402 797.169225901266 666.299358845369 386.4082307168 739.130548543092 752.710886093591 384.746139708518 748.819920733376 747.556378564552 382.404661022819 757.01062332716 741.499236112036 379.056362037584 764.576434766362 734.15482417103 374.524822023972 771.447235814246 725.651156516131 366.53322527518 779.390859531634 712.994041539376 354.525894361328 786.921020147649 697.194932381881 340.624833011953 792.643877074034 681.684300029392 -20.0008383170068 782.649983376266 639.339819879385 165.012033659184 792.441117757854 655.525316953957 68.7211332397885 787.964900806756 647.659546470107 -20.0008782074741 723.7699094332 692.289879102883 -20.0016844888228 778.959017557459 648.758695874275 -20.0016919016563 773.361326004529 658.47858780591 -20.0017000976408 766.397345276115 667.052961662103 -20.0017098067058 758.309225097574 674.391145852768 -20.0017224069698 748.236422654507 681.234102917872 -20.0017367864988 737.063331299064 686.996815825023 133.123275994854 731.305604598163 712.869447311984 242.080849945331 732.37610302072 728.667515434511 316.039607753441 731.000573264805 741.172257269705 66.1687987424866 741.345042756723 699.07447703459 133.536142489132 743.465509936186 708.266480797795 153.706701685834 743.851517956179 711.05583723945 242.848194646278 744.166789663967 724.106528540961 307.242717850366 743.036959349358 735.016191576615 316.449138431521 742.783018600123 736.748226650205 325.992687736953 742.4944325173 738.604071423904 343.040521570555 741.912421233611 742.09501590758 358.276730121723 741.315905310065 745.441745101289 66.1934857568888 749.594339728416 695.068368308476 134.075117693506 751.526572753341 704.451590856009 154.396119494881 751.878422684804 707.271622008961 243.852908411486 752.191698533895 720.308182599268 308.127573511316 751.237735739884 731.099574889032 317.310104377001 751.023184244684 732.81091617284 326.831828571702 750.779631614486 734.644855292315 343.855584990402 750.289409886785 738.096176325408 359.098222482898 749.78836809666 741.407871379275 66.2207075299397 752.007237600181 693.719985248194 134.282086625533 753.900468133311 703.159071699077 154.656122795995 754.247790631735 705.987733771535 244.237671711361 754.589672770285 719.004719313658 308.491546876008 753.714016550261 729.722701731867 317.66871843872 753.515286053174 731.419484733773 327.18571319482 753.289501094448 733.237217024784 344.205418897061 752.834717081571 736.656652497152 359.452844160943 752.369740867452 739.936461814087 66.3062371042748 756.811173021326 690.736745998243 134.771238838904 758.653322839553 700.273541376088 155.264857838114 759.000171680281 703.115050549759 245.144529590035 759.441036125603 716.055582026467 309.378361946732 758.754895757205 726.561758606802 318.547318653476 758.592617431529 728.215954130029 328.057414241588 758.407375950531 729.985908910991 345.073688491896 758.032467654828 733.310145379598 360.335267038971 757.647729048113 736.493092661378 66.4473629574176 761.865009660046 687.077593910907 135.412014028906 763.699147386162 696.675539361871 156.054262163405 764.059536031294 699.517844133576 246.327629084478 764.668505658305 712.29677009552 310.57391467342 764.225819028125 722.466200780163 319.738097938053 764.107740610918 724.053143238161 329.244931482728 763.971056172394 725.747490751983 346.265067370202 763.690268065335 728.92039895431 361.549160553018 763.398393415074 731.948284417022 66.7430173752115 768.773881848 680.926671027635 136.544312899279 770.696761521542 690.465865908283 157.436169530957 771.10453727327 693.266550721742 248.407248304133 772.06049071195 705.599830764771 312.734351282823 772.012054482786 715.060386689674 321.8993505335 771.960654130051 716.509936336184 331.409391064093 771.896014796356 718.050433203643 348.449483250268 771.751738625787 720.916626280864 363.779868569 771.59105672431 723.631125496927 66.8149802344491 770.084924452297 679.568628909914 136.79935986893 772.041122694419 689.067258682037 157.745902930671 772.462484105373 691.851249406723 248.87408746146 773.501280061711 704.057238248148 313.22595241327 773.534397940201 713.342419792573 322.39218230064 773.496075293431 714.758864268714 331.903965045013 773.44537845308 716.262464641277 348.950059927386 773.327024792706 719.055516344478 364.291644382137 773.190690404922 721.69569619749 67.1435384665398 775.047178328672 673.69911681774 137.910471198873 777.192331259249 682.911950084021 159.090876432958 777.682119343983 685.59318133236 250.902584077043 779.092277801385 697.134810273468 315.380010130024 779.450981783315 705.60174379779 324.554465823419 779.462374443344 706.867938940985 334.076641490427 779.464004756937 708.205013112965 351.153068821978 779.441146778962 710.670274429797 67.3434251430907 777.483879352798 670.28976087096 138.558326862489 779.767214888215 679.258220523649 159.872647511448 780.302734555778 681.857810770807 252.082130816403 781.934729513943 692.932693490723 316.642287232924 782.463480829373 700.886852839723 325.823095178395 782.49923482957 702.062090530825 335.352857143763 782.52606330849 703.29910324647 352.449259578437 782.548013231003 705.569308198134 67.6665573129912 780.785022280115 664.909861461836 139.579508972223 783.321045008487 673.384873863118 161.102514314402 783.935934469231 675.825058819374 253.937897604189 785.923658218202 686.051787520161 318.637342448447 786.697952091123 693.151546187019 327.829632442287 786.767109656298 694.179943083994 337.372797734648 786.828001727525 695.25658802485 68.0190480210798 783.705275457898 659.132209399814 140.672166824467 786.552241697319 666.94356028329 162.416421413446 787.260800216209 669.174286235535 255.920192469337 789.638603055274 678.350394313517 320.775676119654 790.657556614007 684.479611622911 329.981425940479 790.758682415902 685.347217028772 339.5400901195 790.851864639806 686.249814796439 68.1924981598651 784.931761688615 656.302010187047 141.205791562365 787.943795927689 663.742670794061 163.057685481577 788.701117807308 665.857658663284 256.887411391633 791.274299754428 674.470812606953 321.820222396765 792.411377420207 680.106338585215 331.032742139447 792.527940202808 680.894149526314 0.83082 0.08333 0.6898 0.91668 0.828174663168774 0.178372188718438 0.823219304561951 0.264131447144687 0.816538969769205 0.341228195678923 0.807586340089068 0.418048812141494 0.796214973265763 0.494451210515284 0.777416440615851 0.594324859077858 0.750899531607268 0.70688621728176 0.721665293222386 0.812054633351997 0.0833300000000002 0.91667 0.420261618655693 0.916667599451303 0.251796452331962 0.916668542524006 0.08333 0.08333 0.08333 0.77778 0.08333 0.63889 0.08333 0.513889 0.08333 0.4013881 0.08333 0.2888872 0.08333 0.1861086 0.38232984 0.08333 0.580025006640119 0.08333 0.705422644960465 0.08333 0.251796452331962 0.1861086 0.38232984 0.1861086 0.420261618655693 0.1861086 0.580025006640119 0.1861086 0.6898 0.1861086 0.705422644960465 0.1861086 0.721665293222386 0.1861086 0.750899531607268 0.1861086 0.777416440615851 0.1861086 0.251796452331962 0.264131447144687 0.38232984 0.264131447144687 0.420261618655693 0.264131447144687 0.580025006640119 0.264131447144687 0.6898 0.264131447144687 0.705422644960465 0.264131447144687 0.721665293222386 0.264131447144687 0.750899531607268 0.264131447144687 0.777416440615851 0.264131447144687 0.251796452331962 0.2888872 0.38232984 0.2888872 0.420261618655693 0.2888872 0.580025006640119 0.2888872 0.6898 0.2888872 0.705422644960465 0.2888872 0.721665293222386 0.2888872 0.750899531607268 0.2888872 0.777416440615851 0.2888872 0.251796452331962 0.341228195678923 0.38232984 0.341228195678923 0.420261618655693 0.341228195678923 0.580025006640119 0.341228195678923 0.6898 0.341228195678923 0.705422644960465 0.341228195678923 0.721665293222386 0.341228195678923 0.750899531607268 0.341228195678923 0.777416440615851 0.341228195678923 0.251796452331962 0.4013881 0.38232984 0.4013881 0.420261618655693 0.4013881 0.580025006640119 0.4013881 0.6898 0.4013881 0.705422644960465 0.4013881 0.721665293222386 0.4013881 0.750899531607268 0.4013881 0.777416440615851 0.4013881 0.251796452331962 0.494451210515284 0.38232984 0.494451210515284 0.420261618655693 0.494451210515284 0.580025006640119 0.494451210515284 0.6898 0.494451210515284 0.705422644960465 0.494451210515284 0.721665293222386 0.494451210515284 0.750899531607268 0.494451210515284 0.777416440615851 0.494451210515284 0.251796452331962 0.513889 0.38232984 0.513889 0.420261618655693 0.513889 0.580025006640119 0.513889 0.6898 0.513889 0.705422644960465 0.513889 0.721665293222386 0.513889 0.750899531607268 0.513889 0.777416440615851 0.513889 0.251796452331962 0.594324859077858 0.38232984 0.594324859077858 0.420261618655693 0.594324859077858 0.580025006640119 0.594324859077858 0.6898 0.594324859077858 0.705422644960465 0.594324859077858 0.721665293222386 0.594324859077858 0.750899531607268 0.594324859077858 0.251796452331962 0.63889 0.38232984 0.63889 0.420261618655693 0.63889 0.580025006640119 0.63889 0.6898 0.63889 0.705422644960465 0.63889 0.721665293222386 0.63889 0.750899531607268 0.63889 0.251796452331962 0.70688621728176 0.38232984 0.70688621728176 0.420261618655693 0.70688621728176 0.580025006640119 0.70688621728176 0.6898 0.70688621728176 0.705422644960465 0.70688621728176 0.721665293222386 0.70688621728176 0.251796452331962 0.77778 0.38232984 0.77778 0.420261618655693 0.77778 0.580025006640119 0.77778 0.6898 0.77778 0.705422644960465 0.77778 0.721665293222386 0.77778 0.251796452331962 0.812054633351997 0.38232984 0.812054633351997 0.420261618655693 0.812054633351997 0.580025006640119 0.812054633351997 0.6898 0.812054633351997 0.705422644960465 0.812054633351997 14 24 20 24 14 21 20 24 33 25 33 24 25 21 26 33 34 43 34 33 25 25 26 34 25 24 21 20 33 19 19 42 51 42 19 33 18 51 60 51 18 19 42 43 51 52 60 51 52 43 44 60 69 18 61 69 60 60 52 61 52 51 43 42 33 43 18 69 17 34 35 43 44 43 35 35 26 27 44 35 36 53 52 44 22 27 26 27 22 28 45 36 37 28 36 27 22 23 28 27 36 35 26 21 22 44 36 45 61 53 62 61 52 53 70 62 71 62 70 61 53 54 62 61 70 69 63 62 54 46 54 45 71 63 72 71 62 63 63 54 55 54 53 45 53 44 45 70 71 80 63 64 72 35 34 26 69 70 79 16 17 87 17 69 78 87 17 78 87 79 88 79 87 78 95 88 96 88 95 87 79 80 88 87 95 16 69 79 78 16 95 103 15 103 110 15 16 103 117 15 110 15 117 11 103 104 110 110 111 117 104 96 97 117 13 11 118 13 117 111 110 104 104 103 96 95 96 103 88 89 96 97 96 89 89 80 81 105 111 104 105 97 98 89 90 97 105 104 97 72 81 80 73 81 72 90 98 97 91 98 90 90 81 82 81 90 89 79 70 80 105 98 106 111 112 119 111 105 112 118 119 12 119 118 111 112 113 119 111 118 117 120 119 113 107 113 106 12 120 2 12 119 120 120 113 114 113 112 106 105 106 112 118 12 13 106 98 99 89 88 80 80 71 72 36 28 37 46 37 38 29 28 23 37 28 29 37 46 45 29 30 39 30 29 23 46 38 47 39 38 29 30 31 39 29 38 37 23 31 30 48 38 39 55 47 56 47 55 46 64 56 65 56 64 55 47 48 56 55 64 63 57 65 56 57 48 49 75 65 66 66 65 57 57 58 66 57 56 48 47 38 48 74 64 65 39 40 48 46 55 54 31 32 40 31 23 32 40 32 41 31 40 39 4 32 3 41 4 5 41 32 4 3 32 1 23 1 32 40 41 50 49 50 58 50 49 40 58 67 66 59 67 58 58 50 59 49 58 57 59 5 6 5 59 50 67 68 77 6 68 59 59 68 67 50 41 5 66 67 76 40 49 48 7 68 6 73 82 81 82 73 74 91 82 83 82 91 90 92 91 83 83 74 75 99 92 100 99 91 92 83 84 92 83 82 74 73 64 74 91 99 98 107 114 113 114 107 108 121 2 120 2 121 122 114 115 121 114 121 120 100 108 107 108 100 101 115 122 121 122 115 116 108 109 115 108 115 114 107 99 100 2 122 10 92 93 100 99 107 106 75 76 84 76 75 66 84 93 92 85 93 84 84 76 85 75 84 83 77 7 86 7 77 68 93 85 94 86 85 77 85 86 8 77 85 76 76 67 77 8 86 7 101 109 108 109 101 102 116 10 122 10 116 9 109 9 116 109 116 115 94 8 102 8 94 85 102 9 109 9 102 8 94 102 101 101 93 94 93 101 100 74 65 75 64 73 72 +70 117 1 0.249880193550673 +-676.88 623 542.55 -600 643.12 581.66 -661.306034666644 627.817670454896 553.953968452367 -647.970487368622 631.593041709942 562.496723555137 -635.136385031971 634.923519440911 569.36187287045 -623.06850565298 637.831467182907 574.469879869451 -611.565245965293 640.486122029015 578.303435008574 -600 684.65 555.24 -600 653.932657404614 577.975495309001 -600 662.945171116019 573.811257888746 -600 670.931561759922 568.826965313624 -600 677.43636218902 563.354562894011 -600 681.307972830445 559.262748241252 -636.01 667.8 548.74 -614.758628257887 679.235185185185 552.46085048011 -622.97037037037 675.461111111111 550.988148148148 -629.400462962963 671.969444444445 549.866157407407 -645.31774119931 660.77717993255 547.213558030432 -654.754975034962 652.028177966815 545.726598968865 -663.080581738175 642.684946141749 544.474262253062 -670.030021642273 633.503318940422 543.478940683911 -654.626407767423 638.759665106585 554.250490931873 -643.983351919781 642.11992137167 560.85429024835 -641.533029386915 642.863803841786 562.246273847675 -632.315858936624 645.569598402231 566.975684904549 -626.631179742152 647.170832776044 569.466775294253 -621.290396935379 648.632131968316 571.516536093676 -610.709911891503 651.40872889448 574.913904733968 -649.472934537897 647.825426355673 553.44799238474 -639.95044802327 651.169071184774 558.970543886286 -637.743318352901 651.915402166836 560.139055609349 -629.394979014876 654.646161240685 564.133434442759 -624.216795499121 656.269955785621 566.263810723967 -619.340850547089 657.751605808571 568.040690377263 -609.690825338432 660.543176600176 571.047277420197 -643.918609522214 656.089902491766 552.534835921465 -635.599979693951 659.339444941781 556.802609640981 -633.652459097017 660.06892759713 557.7094081357 -626.225391738027 662.745090534991 560.838209192115 -621.580942691474 664.336314312629 562.541720113547 -617.195663571054 665.783028391402 563.99529688864 -608.546255176136 668.480344238322 566.541025862692 -643.301919843292 656.920973828553 552.429535900084 -635.116847028754 660.156045478139 556.555612602211 -633.198174311312 660.882636614926 557.432970104909 -625.873607520271 663.548548975886 560.464276659427 -621.288572854035 665.133305325798 562.11921473636 -616.957851534375 666.573325395475 563.535333750131 -608.419360006125 669.254673321635 566.025755444265 -638.013512774273 663.420173783547 551.495352927483 -630.974118551822 666.510200881109 554.39886826937 -629.303608629408 667.206742449588 555.02412903277 -622.863024500861 669.763636003788 557.221713186437 -618.791212628007 671.278936932197 558.457887721992 -614.930968832657 672.647901016328 559.545146011357 -607.342107563839 675.165160632705 561.531077315009 -636.300326233163 665.304720146834 551.181585305109 -629.632551415095 668.343389686687 553.6873665519 -628.042765382715 669.029120853751 554.231502984745 -621.890467176011 671.546494983507 556.162007643835 -617.986293689181 673.036613158364 557.263456747814 -614.279432227562 674.379984875131 558.243155845789 -606.997619328577 676.83880369494 560.057485061542 -633.679611549196 668.001423267334 550.6918905609 -627.581197811963 670.962078366573 552.58820438679 -626.115195027238 671.631443717418 553.009058958259 -620.405306862348 674.089253871207 554.536109910961 -616.758482422836 675.541609688315 555.434795150512 -613.286854712807 676.846646080215 556.251913961061 -606.474182482768 679.217424446341 557.801768868307 0 0 1 0 0.15007693011773 0 0.30015386023546 0 0.466755908727092 0 0.642741771698651 0 0.821370885849326 0 1 1 1 0.168245098486514 1 0.336490196973029 1 0.521399882325375 1 0.714508733836577 1 0.857254366918289 0 1 0.555555555555556 1 0.333333333333333 1 0.166666666666667 1 0 0.770772407514008 0 0.541544815028015 0 0.339633790193572 0 0.169816895096786 0.166666666666667 0.169816895096786 0.30015386023546 0.169816895096786 0.333333333333333 0.169816895096786 0.466755908727092 0.169816895096786 0.555555555555556 0.169816895096786 0.642741771698651 0.169816895096786 0.821370885849326 0.169816895096786 0.166666666666667 0.339633790193572 0.30015386023546 0.339633790193572 0.333333333333333 0.339633790193572 0.466755908727092 0.339633790193572 0.555555555555556 0.339633790193572 0.642741771698651 0.339633790193572 0.821370885849326 0.339633790193572 0.166666666666667 0.521399882325375 0.30015386023546 0.521399882325375 0.333333333333333 0.521399882325375 0.466755908727092 0.521399882325375 0.555555555555556 0.521399882325375 0.642741771698651 0.521399882325375 0.821370885849326 0.521399882325375 0.166666666666667 0.541544815028015 0.30015386023546 0.541544815028015 0.333333333333333 0.541544815028015 0.466755908727092 0.541544815028015 0.555555555555556 0.541544815028015 0.642741771698651 0.541544815028015 0.821370885849326 0.541544815028015 0.166666666666667 0.714508733836577 0.30015386023546 0.714508733836577 0.333333333333333 0.714508733836577 0.466755908727092 0.714508733836577 0.555555555555556 0.714508733836577 0.642741771698651 0.714508733836577 0.821370885849326 0.714508733836577 0.166666666666667 0.770772407514008 0.30015386023546 0.770772407514008 0.333333333333333 0.770772407514008 0.466755908727092 0.770772407514008 0.555555555555556 0.770772407514008 0.642741771698651 0.770772407514008 0.821370885849326 0.770772407514008 0.166666666666667 0.857254366918289 0.30015386023546 0.857254366918289 0.333333333333333 0.857254366918289 0.466755908727092 0.857254366918289 0.555555555555556 0.857254366918289 0.642741771698651 0.857254366918289 0.821370885849326 0.857254366918289 21 1 3 21 3 22 22 3 4 20 22 29 22 20 21 29 36 20 30 36 29 29 22 23 20 36 19 23 22 4 23 24 31 23 4 24 5 25 24 25 5 26 4 5 24 24 25 32 30 37 36 37 30 31 31 32 38 32 31 24 38 32 39 31 38 37 30 23 31 37 38 45 25 26 32 23 30 29 36 37 44 19 43 50 19 36 43 57 50 51 44 50 43 36 44 43 19 50 18 14 18 64 57 64 18 58 64 57 65 17 64 64 17 14 18 50 57 44 51 50 51 45 52 45 51 44 59 52 53 45 46 52 44 37 45 51 52 59 58 65 64 65 58 59 59 66 65 60 66 59 67 16 66 66 16 65 58 51 59 65 16 17 45 39 46 51 58 57 45 38 39 32 33 39 40 39 33 33 26 27 6 27 26 27 6 7 26 5 6 33 27 34 46 40 47 39 40 46 41 40 34 40 41 47 33 34 40 46 47 54 27 28 34 33 32 26 35 34 28 28 7 9 2 9 7 28 9 10 41 35 42 41 34 35 35 11 42 11 35 10 49 41 42 35 28 10 47 41 48 28 27 7 49 42 11 53 54 61 53 46 54 48 55 54 55 48 49 47 48 54 54 55 61 60 67 66 67 60 61 61 68 67 62 68 61 69 15 68 68 15 67 60 53 61 67 15 16 62 61 55 53 60 59 55 56 62 56 55 49 62 56 63 12 56 49 49 11 12 63 56 12 69 63 70 63 69 62 70 13 8 13 70 63 8 15 70 63 12 13 70 15 69 62 69 68 48 41 49 46 53 52 + +TShapes 122 +Ve +0.08 +-20 0 734.11 +0 0 + +0101101 +* +Ve +0.08 +118.23 0 753.48 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 1 0 0 1 +2 1 1 0 0 1 +2 2 2 0 0 1 +6 1 1 0 +6 2 2 0 +0 + +0101000 ++122 0 -121 0 * +Ve +0.08 +-20.0002757673372 -599.999610095597 712.368159334899 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 2 0 0 0.7533836 +2 3 1 0 0 0.7533836 +2 4 3 0 0 0.7533836 +6 3 1 0 +6 4 3 0 +0 + +0101000 ++119 0 -122 0 * +Ve +0.08 +206.960181655448 -599.999226408255 745.280107946042 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 3 0 0 1 +2 5 1 0 0 1 +2 6 4 0 0 1 +6 5 4 0 +6 6 1 0 +0 + +0101000 ++117 0 -119 0 * +Ed + 0.08 1 1 0 +1 4 0 0 1 +2 7 1 0 0 1 +6 7 1 0 +0 + +0101000 ++117 0 -121 0 * +Wi + +0101100 +-120 0 -118 0 -116 0 +115 0 * +Fa +0 0.08 1 0 +2 1 +0101000 ++114 0 * +Ve +0.08 +-600 0 624.91 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 5 0 0 1 +2 8 3 0 0 1 +2 9 5 0 0 1 +6 8 5 0 +6 9 3 0 +0 + +0101000 ++112 0 -122 0 * +Ve +0.08 +-600 -99.9999905997116 623.799345110611 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 6 0 0 1 +2 10 3 0 0 1 +2 11 6 0 0 1 +6 10 6 0 +6 11 3 0 +0 + +0101000 ++110 0 -112 0 * +Ve +0.08 +-600 -199.999967554145 620.968654478712 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 7 0 0 1 +2 12 3 0 0 1 +2 13 7 0 0 1 +6 12 7 0 +6 13 3 0 +0 + +0101000 ++108 0 -110 0 * +Ve +0.08 +-600 -643.12 581.66 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 8 0 0 1 +2 14 3 0 0 1 +2 15 8 0 0 1 +6 14 3 0 +6 15 8 0 +0 + +0101000 ++106 0 -108 0 * +Ve +0.08 +-20.0008782074737 -723.7699094332 692.289879102883 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 9 0 0 1 +2 16 3 0 0 1 +2 17 9 0 0 1 +6 16 3 0 +6 17 9 0 +0 + +0101000 ++104 0 -106 0 * +Ed + 0.08 1 1 0 +1 10 0 0 1 +2 18 3 0 0 1 +2 19 4 0 0 1 +6 18 4 0 +6 19 3 0 +0 + +0101000 ++119 0 -104 0 * +Wi + +0101100 +-111 0 -109 0 -107 0 -105 0 -103 0 -102 0 +118 0 * +Fa +0 0.08 3 0 +2 3 +0101000 ++101 0 * +Ve +0.08 +-600 -684.65 555.24 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 11 0 0 1 +2 20 9 0 0 1 +2 21 10 0 0 1 +6 20 10 0 +6 21 9 0 +0 + +0101000 ++99 0 -106 0 * +Ve +0.08 +-20.0008383170066 -782.649983376265 639.339819879384 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 12 0 0 1 +2 22 9 0 0 1 +6 22 9 0 +0 + +0101000 ++99 0 -97 0 * +Ed + 0.08 1 1 0 +1 13 0 0 1 +2 23 9 0 0 1 +2 24 11 0 0 1 +6 23 11 0 +6 24 9 0 +0 + +0101000 ++104 0 -97 0 * +Wi + +0101100 ++103 0 -98 0 +96 0 -95 0 * +Fa +0 0.08 9 0 +2 9 +0101000 ++94 0 * +Ve +0.08 +-808.77 -200 519.08 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 14 0 0 1 +2 25 8 0 0 1 +2 26 7 0 0 1 +6 25 7 0 +6 26 8 0 +0 + +0101000 ++92 0 -108 0 * +Ve +0.08 +-676.88 -623 542.55 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 15 0 0 1 +2 27 8 0 0 1 +6 27 8 0 +0 + +0101000 ++92 0 -90 0 * +Ed + 0.08 1 1 0 +1 16 0 0 1 +2 28 8 0 0 1 +2 29 10 0 0 1 +6 28 10 0 +6 29 8 0 +0 + +0101000 ++106 0 -90 0 * +Wi + +0101100 +-91 0 +89 0 -88 0 +105 0 * +Fa +0 0.08 8 0 +2 8 +0101000 ++87 0 * +Ve +0.08 +-844.01 -100 484.65 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 17 0 0 1 +2 30 7 0 0 1 +2 31 6 0 0 1 +6 30 7 0 +6 31 6 0 +0 + +0101000 ++85 0 -110 0 * +Ed + 0.08 1 1 0 +1 18 0 0 1 +2 32 7 0 0 1 +6 32 7 0 +0 + +0101000 ++85 0 -92 0 * +Wi + +0101100 +-84 0 +83 0 +91 0 +107 0 * +Fa +0 0.08 7 0 +2 7 +0101000 ++82 0 * +Ve +0.08 +-853.7 0 473.9 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 19 0 0 1 +2 33 6 0 0 1 +2 34 12 0 0 1 +6 33 6 0 +6 34 12 0 +0 + +0101000 ++80 0 -112 0 * +Ed + 0.08 1 1 0 +1 20 0 0 1 +2 35 6 0 0 1 +6 35 6 0 +0 + +0101000 ++80 0 -85 0 * +Wi + +0101100 +-79 0 +78 0 +84 0 +109 0 * +Fa +0 0.08 6 0 +2 6 +0101000 ++77 0 * +Ve +0.08 +-636.01 -667.8 548.74 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 21 0 0 1 +2 36 10 0 0 1 +6 36 10 0 +0 + +0101000 ++90 0 -75 0 * +Ed + 0.08 1 1 0 +1 22 0 0 1 +2 37 10 0 0 1 +6 37 10 0 +0 + +0101000 ++75 0 -99 0 * +Wi + +0101100 ++88 0 +74 0 +73 0 +98 0 * +Fa +0 0.08 10 0 +2 10 +0101000 ++72 0 * +Ve +0.08 +206.960181655448 599.999226408255 745.280107946042 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 23 0 0 1 +2 38 2 0 0 1 +6 38 2 0 +0 + +0101000 ++121 0 -70 0 * +Ve +0.08 +-20.0002757673372 599.999610095597 712.368159334899 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 24 0 0 1 +2 39 2 0 0 1 +2 40 13 0 0 1 +6 39 13 0 +6 40 2 0 +0 + +0101000 ++68 0 -70 0 * +Ed + 0.08 1 1 0 +1 25 0 0 0.7533836 +2 41 2 0 0 0.7533836 +2 42 5 0 0 0.7533836 +6 41 2 0 +6 42 5 0 +0 + +0101000 ++122 0 -68 0 * +Wi + +0101100 ++120 0 +69 0 -67 0 -66 0 * +Fa +0 0.08 2 0 +2 2 +0101000 ++65 0 * +Ve +0.08 +-20.0008782074741 723.7699094332 692.289879102883 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 26 0 0 1 +2 43 5 0 0 1 +2 44 13 0 0 1 +6 43 13 0 +6 44 5 0 +0 + +0101000 ++63 0 -68 0 * +Ve +0.08 +-600 643.12 581.66 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 27 0 0 1 +2 45 5 0 0 1 +2 46 14 0 0 1 +6 45 14 0 +6 46 5 0 +0 + +0101000 ++61 0 -63 0 * +Ve +0.08 +-600 199.999943687854 620.968655318947 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 28 0 0 1 +2 47 5 0 0 1 +2 48 15 0 0 1 +6 47 5 0 +6 48 15 0 +0 + +0101000 ++59 0 -61 0 * +Ve +0.08 +-600 99.9999905997116 623.799345110611 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 29 0 0 1 +2 49 5 0 0 1 +2 50 16 0 0 1 +6 49 16 0 +6 50 5 0 +0 + +0101000 ++57 0 -59 0 * +Ed + 0.08 1 1 0 +1 30 0 0 1 +2 51 5 0 0 1 +2 52 12 0 0 1 +6 51 12 0 +6 52 5 0 +0 + +0101000 ++112 0 -57 0 * +Wi + +0101100 ++111 0 +66 0 -62 0 -60 0 -58 0 -56 0 -55 0 * +Fa +0 0.08 5 0 +2 5 +0101000 ++54 0 * +Ve +0.08 +-20.0008383170068 782.649983376266 639.339819879385 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 31 0 0 1 +2 53 14 0 0 1 +2 54 17 0 0 1 +6 53 17 0 +6 54 14 0 +0 + +0101000 ++52 0 -63 0 * +Ve +0.08 +-600 684.65 555.24 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 32 0 0 1 +2 55 14 0 0 1 +6 55 14 0 +0 + +0101000 ++52 0 -50 0 * +Ed + 0.08 1 1 0 +1 33 0 0 1 +2 56 14 0 0 1 +2 57 18 0 0 1 +6 56 18 0 +6 57 14 0 +0 + +0101000 ++61 0 -50 0 * +Wi + +0101100 ++60 0 -51 0 +49 0 -48 0 * +Fa +0 0.08 14 0 +2 14 +0101000 ++47 0 * +Ve +0.08 +-808.77 200 519.08 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 34 0 0 1 +2 58 15 0 0 1 +2 59 16 0 0 1 +6 58 16 0 +6 59 15 0 +0 + +0101000 ++59 0 -45 0 * +Ve +0.08 +-676.88 623 542.55 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 35 0 0 1 +2 60 15 0 0 1 +2 61 18 0 0 1 +6 60 18 0 +6 61 15 0 +0 + +0101000 ++43 0 -61 0 * +Ed + 0.08 1 1 0 +1 36 0 0 1 +2 62 15 0 0 1 +6 62 15 0 +0 + +0101000 ++43 0 -45 0 * +Wi + +0101100 +-44 0 +58 0 -42 0 +41 0 * +Fa +0 0.08 15 0 +2 15 +0101000 ++40 0 * +Ve +0.08 +-844.01 100 484.65 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 37 0 0 1 +2 63 16 0 0 1 +2 64 12 0 0 1 +6 63 16 0 +6 64 12 0 +0 + +0101000 ++57 0 -38 0 * +Ed + 0.08 1 1 0 +1 38 0 0 1 +2 65 16 0 0 1 +6 65 16 0 +0 + +0101000 ++45 0 -38 0 * +Wi + +0101100 +-37 0 +56 0 +44 0 +36 0 * +Fa +0 0.08 16 0 +2 16 +0101000 ++35 0 * +Ed + 0.08 1 1 0 +1 39 0 0 1 +2 66 12 0 0 1 +6 66 12 0 +0 + +0101000 ++38 0 -80 0 * +Wi + +0101100 ++79 0 +55 0 +37 0 +33 0 * +Fa +0 0.08 12 0 +2 12 +0101000 ++32 0 * +Ve +0.08 +-636.01 667.8 548.74 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 40 0 0 1 +2 67 18 0 0 1 +6 67 18 0 +0 + +0101000 ++50 0 -30 0 * +Ed + 0.08 1 1 0 +1 41 0 0 1 +2 68 18 0 0 1 +6 68 18 0 +0 + +0101000 ++30 0 -43 0 * +Wi + +0101100 ++42 0 +48 0 +29 0 +28 0 * +Fa +0 0.08 18 0 +2 18 +0101000 ++27 0 * +Ve +0.08 +387.492364175061 -726.769262650087 756.721482246979 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 42 0 0 1 +2 69 4 0 0 1 +6 69 4 0 +0 + +0101000 ++25 0 -117 0 * +Ve +0.08 +387.410490640632 -727.928389328809 756.560027803797 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 43 0 0 1 +2 70 4 0 0 1 +2 71 11 0 0 1 +6 70 4 0 +6 71 11 0 +0 + +0101000 ++23 0 -104 0 * +Ed + 0.08 1 1 0 +1 44 0 0 1 +2 72 4 0 0 1 +6 72 4 0 +0 + +0101000 ++23 0 -25 0 * +Wi + +0101100 ++24 0 +116 0 +102 0 -22 0 +21 0 * +Fa +0 0.08 4 0 +2 4 +0101000 ++20 0 * +Ve +0.08 +324.999364674401 -797.169225901266 666.299358845369 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 45 0 0 1 +2 73 11 0 0 1 +6 73 11 0 +0 + +0101000 ++97 0 -18 0 * +Ed + 0.08 1 1 0 +1 46 0 0 1 +2 74 11 0 0 1 +6 74 11 0 +0 + +0101000 ++18 0 -23 0 * +Wi + +0101100 ++22 0 +95 0 +17 0 +16 0 * +Fa +0 0.08 11 0 +2 11 +0101000 ++15 0 * +Ve +0.08 +387.492364175061 726.769262650087 756.721482246979 +0 0 + +0101101 +* +Ve +0.08 +387.410490640632 727.928389328809 756.560027803797 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 47 0 0 1 +2 75 13 0 0 1 +6 75 13 0 +0 + +0101000 ++13 0 -12 0 * +Ed + 0.08 1 1 0 +1 48 0 0 1 +2 76 13 0 0 1 +2 77 17 0 0 1 +6 76 13 0 +6 77 17 0 +0 + +0101000 ++63 0 -12 0 * +Ed + 0.08 1 1 0 +1 49 0 0 1 +2 78 13 0 0 1 +6 78 13 0 +0 + +0101000 ++70 0 -13 0 * +Wi + +0101100 ++11 0 -10 0 +62 0 +67 0 +9 0 * +Fa +0 0.08 13 0 +2 13 +0101000 ++8 0 * +Ve +0.08 +324.999364674402 797.169225901266 666.299358845369 +0 0 + +0101101 +* +Ed + 0.08 1 1 0 +1 50 0 0 1 +2 79 17 0 0 1 +6 79 17 0 +0 + +0101000 ++12 0 -6 0 * +Ed + 0.08 1 1 0 +1 51 0 0 1 +2 80 17 0 0 1 +6 80 17 0 +0 + +0101000 ++6 0 -52 0 * +Wi + +0101100 ++5 0 +4 0 +51 0 +10 0 * +Fa +0 0.08 17 0 +2 17 +0101000 ++3 0 * +Sh + +0101000 ++113 0 +100 0 +93 0 +86 0 +81 0 +76 0 +71 0 +64 0 +53 0 +46 0 ++39 0 +34 0 +31 0 +26 0 +19 0 +14 0 +7 0 +2 0 * + ++1 0 \ No newline at end of file diff --git a/benchmarks/step/capot.geo b/benchmarks/step/capot.geo new file mode 100644 index 0000000000000000000000000000000000000000..e1291d8eebc91052a2a34024b755bcea8e2c7c9e --- /dev/null +++ b/benchmarks/step/capot.geo @@ -0,0 +1,9 @@ +Mesh.CharacteristicLengthFactor=0.2; +Merge "capot.brep"; + +Compound Line(1000) = {47,50}; +Compound Line(1001) = {44,46}; + +Compound Surface(100) = {1, 8, 15, 17, 16, 18, 9, 2, 3, 10, 7, 14, 11, 4, 12, 5, 6, 13} Boundary {{},{},{},{}}; + +//Recombine Surface {7, 4, 5, 6, 13, 12, 3, 11, 14, 2, 15, 16, 1, 9, 10, 8, 17, 18}; diff --git a/benchmarks/stl/PelvisARTHUR_CLASS_GEO.geo b/benchmarks/stl/PelvisARTHUR_CLASS_GEO.geo index 437b2d692850cb7cbed47a5cbdf4ec2dfea48659..a60748d70510508a56eb170439e12f55e894a914 100644 --- a/benchmarks/stl/PelvisARTHUR_CLASS_GEO.geo +++ b/benchmarks/stl/PelvisARTHUR_CLASS_GEO.geo @@ -1,13 +1,13 @@ Mesh.CharacteristicLengthFactor=0.2; -Merge "PelvisKO.msh"; //ARTHUR_CLASS.msh"; +Merge "PelvisARTHUR_CLASS.msh"; CreateTopology; Surface Loop(1002)={2,3}; Volume(1003)={1002}; Compound Line(10)={4}; -//Compound Line(20)={5}; +Compound Line(20)={5}; Compound Surface(200)={2}; Compound Surface(400)={3};