]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Added OPENCASCADE support to cmake.
authorLuca Heltai <luca.heltai@sissa.it>
Fri, 8 Aug 2014 15:11:07 +0000 (17:11 +0200)
committerLuca Heltai <luca.heltai@sissa.it>
Fri, 31 Oct 2014 10:06:21 +0000 (11:06 +0100)
Added occ_utilities.

Fixed config.h.in, added a test.

Fixed compilation issues.

Fixed test.

Fixed point ordering.

Added function closest_point to OpenCASCADE namespace.

16 files changed:
cmake/config/CMakeLists.txt
cmake/config/Make.global_options.in
cmake/configure/configure_opencascade.cmake [new file with mode: 0644]
cmake/modules/FindOPENCASCADE.cmake [new file with mode: 0644]
include/deal.II/base/config.h.in
include/deal.II/grid/occ_utilities.h [new file with mode: 0644]
source/grid/CMakeLists.txt
source/grid/occ_utilities.cc [new file with mode: 0644]
tests/CMakeLists.txt
tests/opencascade/CMakeLists.txt [new file with mode: 0644]
tests/opencascade/closest_point_to_shape.cc [new file with mode: 0644]
tests/opencascade/closest_point_to_shape.output [new file with mode: 0644]
tests/opencascade/iges_files/goteborg.iges [new file with mode: 0644]
tests/opencascade/iges_files/wigley.iges [new file with mode: 0644]
tests/opencascade/iges_read.cc [new file with mode: 0644]
tests/opencascade/iges_read.output [new file with mode: 0644]

index cf8204ce573e2619de883e4d2ced920e7c8412d6..dce4498ca087a8ca893e22901ec1c00ae54e6759 100644 (file)
@@ -333,6 +333,7 @@ IF(DEAL_II_COMPONENT_COMPAT_FILES)
   COND_SET_TO_YES(DEAL_II_WITH_METIS MAKEFILE_METIS)
   COND_SET_TO_YES(DEAL_II_WITH_MPI MAKEFILE_MPI)
   COND_SET_TO_YES(DEAL_II_WITH_MUMPS MAKEFILE_MUMPS)
+  COND_SET_TO_YES(DEAL_II_WITH_OPENCASCADE MAKEFILE_OPENCASCADE)
   COND_SET_TO_YES(DEAL_II_WITH_P4EST MAKEFILE_P4EST)
   COND_SET_TO_YES(DEAL_II_WITH_PETSC MAKEFILE_PETSC)
   COND_SET_TO_YES(DEAL_II_WITH_SLEPC MAKEFILE_SLEPC)
index d49bb5348bb6377c74622e0224d23c9fcd8adb9d..d49b920f6a0a7e1c67149364d2596d46d9009a6e 100644 (file)
@@ -50,18 +50,19 @@ DEAL_II_MINOR        = @DEAL_II_VERSION_MINOR@
 PERL                 = perl
 
 
-USE_CONTRIB_PETSC    = @MAKEFILE_PETSC@
-USE_CONTRIB_SLEPC    = @MAKEFILE_SLEPC@
-USE_CONTRIB_TRILINOS = @MAKEFILE_TRILINOS@
-USE_CONTRIB_HDF5     = @MAKEFILE_HDF5@
-USE_CONTRIB_BLAS     = @MAKEFILE_BLAS@
-USE_CONTRIB_LAPACK   = @MAKEFILE_LAPACK@
-USE_CONTRIB_MUMPS    = @MAKEFILE_MUMPS@
-USE_CONTRIB_ARPACK   = @MAKEFILE_ARPACK@
-USE_CONTRIB_METIS    = @MAKEFILE_METIS@
-USE_CONTRIB_UMFPACK  = @MAKEFILE_UMFPACK@
-USE_CONTRIB_P4EST    = @MAKEFILE_P4EST@
-DEAL_II_USE_MPI      = @MAKEFILE_MPI@
+USE_CONTRIB_PETSC       = @MAKEFILE_PETSC@
+USE_CONTRIB_SLEPC       = @MAKEFILE_SLEPC@
+USE_CONTRIB_TRILINOS    = @MAKEFILE_TRILINOS@
+USE_CONTRIB_HDF5        = @MAKEFILE_HDF5@
+USE_CONTRIB_BLAS        = @MAKEFILE_BLAS@
+USE_CONTRIB_LAPACK      = @MAKEFILE_LAPACK@
+USE_CONTRIB_MUMPS       = @MAKEFILE_MUMPS@
+USE_CONTRIB_ARPACK      = @MAKEFILE_ARPACK@
+USE_CONTRIB_METIS       = @MAKEFILE_METIS@
+USE_CONTRIB_UMFPACK     = @MAKEFILE_UMFPACK@
+USE_CONTRIB_P4EST       = @MAKEFILE_P4EST@
+USE_CONTRIB_OPENCASCADE = @MAKEFILE_OPENCASCADE@
+DEAL_II_USE_MPI         = @MAKEFILE_MPI@
 
 OBJEXT     = o
 EXEEXT     =
diff --git a/cmake/configure/configure_opencascade.cmake b/cmake/configure/configure_opencascade.cmake
new file mode 100644 (file)
index 0000000..3b4a956
--- /dev/null
@@ -0,0 +1,20 @@
+## ---------------------------------------------------------------------
+## $Id$
+##
+## Copyright (C) 2012 - 2013 by the deal.II authors
+##
+## This file is part of the deal.II library.
+##
+## The deal.II library is free software; you can use it, redistribute
+## it, and/or modify it under the terms of the GNU Lesser General
+## Public License as published by the Free Software Foundation; either
+## version 2.1 of the License, or (at your option) any later version.
+## The full text of the license can be found in the file LICENSE at
+## the top level of the deal.II distribution.
+##
+## ---------------------------------------------------------------------
+
+#
+# Configuration for the OpenCASCADE library:
+#
+CONFIGURE_FEATURE(OPENCASCADE)
diff --git a/cmake/modules/FindOPENCASCADE.cmake b/cmake/modules/FindOPENCASCADE.cmake
new file mode 100644 (file)
index 0000000..f6b03bc
--- /dev/null
@@ -0,0 +1,104 @@
+## ---------------------------------------------------------------------
+## $Id$
+##
+## Copyright (C) 2012 - 2014 by the deal.II authors
+##
+## This file is part of the deal.II library.
+##
+## The deal.II library is free software; you can use it, redistribute
+## it, and/or modify it under the terms of the GNU Lesser General
+## Public License as published by the Free Software Foundation; either
+## version 2.1 of the License, or (at your option) any later version.
+## The full text of the license can be found in the file LICENSE at
+## the top level of the deal.II distribution.
+##
+## ---------------------------------------------------------------------
+
+
+#
+# Try to find the OpenCASCADE (OCC) library. This scripts supports the
+# OpenCASCADE Community Edition (OCE) library, which is a cmake based
+# OCC library. You might try the original OpenCASCADE library, but your
+# mileage may vary.
+#
+# This module exports:
+#
+#   OPENCASCADE_DIR
+#   OPENCASCADE_INCLUDE_DIRS
+#   OPENCASCADE_LIBRARIES
+#   OPENCASCADE_VERSION
+#
+
+
+SET(OPENCASCADE_DIR "" CACHE PATH "An optional hint to a OpenCASCADE installation")
+SET_IF_EMPTY(OPENCASCADE_DIR "$ENV{OPENCASCADE_DIR}")
+SET_IF_EMPTY(OPENCASCADE_DIR "$ENV{OCC_DIR}")
+SET_IF_EMPTY(OPENCASCADE_DIR "$ENV{OCE_DIR}")
+
+
+DEAL_II_FIND_PATH(OPENCASCADE_INCLUDE_DIR Standard_Version.hxx
+  HINTS ${OPENCASCADE_DIR}
+  PATH_SUFFIXES include include/oce inc
+  )
+
+IF(EXISTS ${OPENCASCADE_INCLUDE_DIR}/Standard_Version.hxx)
+  FILE(STRINGS "${OPENCASCADE_INCLUDE_DIR}/Standard_Version.hxx" OPENCASCADE_VERSION
+    REGEX "#define OCC_VERSION _T"
+    )
+ENDIF()
+
+# These seem to be pretty much the only required ones.
+SET(OPENCASCADE_LIBRARIES  
+    TKFillet
+    TKMesh
+    TKernel
+    TKG2d
+    TKG3d
+    TKMath
+    TKIGES
+    TKSTL
+    TKShHealing
+    TKXSBase
+    TKBool
+    TKBO
+    TKBRep
+    TKTopAlgo
+    TKGeomAlgo
+    TKGeomBase
+    TKOffset
+    TKPrim
+    TKSTEP
+    TKSTEPBase
+    TKSTEPAttr
+    TKHLR
+    TKFeat
+  )
+
+SET(_libraries "")
+FOREACH(_library ${OPENCASCADE_LIBRARIES})
+  LIST(APPEND _libraries ${_library})
+  DEAL_II_FIND_LIBRARY(${_library}
+    NAMES ${_library}
+    HINTS ${OPENCASCADE_DIR}
+    PATH_SUFFIXES lib${LIB_SUFFIX} lib64 lib
+    NO_DEFAULT_PATH
+    NO_CMAKE_ENVIRONMENT_PATH
+    NO_CMAKE_PATH
+    NO_SYSTEM_ENVIRONMENT_PATH
+    NO_CMAKE_SYSTEM_PATH
+    NO_CMAKE_FIND_ROOT_PATH
+    )
+ENDFOREACH()
+
+
+DEAL_II_PACKAGE_HANDLE(OPENCASCADE
+  LIBRARIES
+    REQUIRED ${_libraries}
+  INCLUDE_DIRS
+    REQUIRED OPENCASCADE_INCLUDE_DIR
+  USER_INCLUDE_DIRS
+    REQUIRED OPENCASCADE_INCLUDE_DIR
+  CLEAR
+    OPENCASCADE_LIBRARIES ${_libraries}
+    TRILINOS_SUPPORTS_CPP11 TRILINOS_HAS_C99_TR1_WORKAROUND
+  )
index 43e5e14f6828cfb2a42120eab5071b068d727274..4bec00086adfdcc6f606f1b23bb35e143c387776 100644 (file)
 #endif
 
 
+/**********************************************
+ * Configured in configure_opencascade.cmake: *
+ **********************************************/
+
+#cmakedefine DEAL_II_WITH_OPENCASCADE
+
+
+
+
 #include <deal.II/base/numbers.h>
 #include <deal.II/base/types.h>
 
diff --git a/include/deal.II/grid/occ_utilities.h b/include/deal.II/grid/occ_utilities.h
new file mode 100644 (file)
index 0000000..e6f9b5c
--- /dev/null
@@ -0,0 +1,185 @@
+// ---------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2014 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+
+#ifndef __deal2__occ_utilities_h
+#define __deal2__occ_utilities_h
+
+#ifdef DEAL_II_WITH_OPENCASCADE
+
+#include <string>
+#include <TopoDS_Shape.hxx>
+#include <IFSelect_ReturnStatus.hxx>
+#include <Geom_Plane.hxx>
+#include <Geom_Curve.hxx>
+#include <gp_Pnt.hxx>
+
+#include <base/point.h>
+
+DEAL_II_NAMESPACE_OPEN
+
+/**
+ * @addtogroup OpenCASCADE
+ * @{
+ * We collect in this namespace all utilities which operate on
+ * OpenCASCADE entities. OpenCASCADE splits every object into a
+ * topological description and a geometrical entity. The basic
+ * topological description is a TopoDS_Shape. TopoDS_Shapes are light
+ * objects, and can be copied around. The closest deal.II analog is a
+ * TriaIterator.
+ *
+ * The OpenCASCADE topology is designed with reference to the STEP
+ * standard ISO-10303-42.  The structure is an oriented one-way graph,
+ * where parents refer to their children, and there are no back
+ * references. Abstract structure is implemented as C++ classes from
+ * the TopoDS package. A TopoDS_Shape is manipulated by value and
+ * contains 3 fields: location, orientation and a myTShape handle (of
+ * the TopoDS_TShape type). According to OpenCASCADE documentation,
+ * myTShape and Location are used to share data between various shapes
+ * and thus save huge amounts of memory. For example, an edge
+ * belonging to two faces has equal Locations and myTShape fields but
+ * different Orientations (Forward in context of one face and Reversed
+ * in one of the other).
+ *
+ * Valid shapes include collection of other shapes, solids, faces,
+ * edges, vertices, etc.
+ *
+ * Once a topological description is available, if a concrete
+ * geometrical object can be created, the BRep classes allow one to
+ * extract the actual geometrical information from a shape.
+ *
+ * This is done by inheriting abstract topology classes from the
+ * TopoDS package by those implementing a boundary representation
+ * model (from the BRep package). Only 3 types of topological objects
+ * have geometric representations – vertex, edge, and face.
+ *
+ * Every TopoDS_Shape can be queried to figure out what type of shape
+ * it is, and actual geometrical objects, like surfaces, curves or
+ * points, can be extracted using BRepTools.
+ *
+ * In this namespace we provide readers and writers that read standard
+ * CAD files, and return a TopoDS_Shape, or that write a CAD file,
+ * given a TopoDS_Shape. Most of the functions in the OpenCASCADE
+ * namespace deal with TopoDS_Shapes of one type or another, and
+ * provide interfaces to common deal.II objects, like Triangulation,
+ * Manifold, and so on.
+ *
+ * Notice that these tools are only useful when spacedim is equal to
+ * three, since OpenCASCADE only operates in three-dimensional mode.
+ *
+ * @author Luca Heltai, Andrea Mola, 2011--2014.
+ */
+namespace OpenCASCADE 
+{
+  /**
+   * Count the subobjects of a shape. This function just outputs some
+   * information about the TopoDS_Shape passed as argument. It counts
+   * the number of faces, edges and vertices (the only topological
+   * entities associated with actual geometries) which are contained
+   * in the given shape.
+   */
+  void count_elements(const TopoDS_Shape &shape,
+                     unsigned int &n_faces,
+                     unsigned int &n_edges,
+                     unsigned int &n_vertices);
+  
+  /**
+   * Read IGES files and translate their content into openCascade
+   * topological entities. The option scale_factor is used to
+   * compensate for different units being used in the IGES files and
+   * in the target application. The standard unit for IGES files is
+   * millimiters. The return object is a TopoDS_Shape which contains
+   * all objects from the file. 
+   */
+  TopoDS_Shape read_IGES(const std::string &filename, 
+                        const double scale_factor=1e-3);
+  
+  /**
+   * Perform the intersection of the given topological shape with the
+   * plane $c_x x + c_y y + c_z z +c = 0$. The returned topological
+   * shape will contain as few bsplines as possible. An exception is
+   * thrown if the intersection produces an empty shape.
+   */
+  TopoDS_Shape  intersect_plane(const TopoDS_Shape &in_shape,
+                               const double c_x,
+                               const double c_y,
+                               const double c_z,
+                               const double c,
+                               const double tolerance=1e-7);
+
+  
+  /**
+   * Creates a 3D smooth BSpline curve passing through the points in
+   * the assigned vector. The points are reordered internally
+   * according to their scalar product with the direction, if
+   * direction is different from zero, otherwise they are used as
+   * passed. Notice that this function changes the input points if
+   * required by the algorithm.
+   *
+   * This class is used to interpolate a BsplineCurve passing through
+   * an array of points, with a C2 Continuity.
+   */
+  TopoDS_Shape interpolation_curve(std::vector<dealii::Point<3> >  &curve_points,
+                                  const dealii::Point<3> direction=dealii::Point<3>(), 
+                                  const double tolerance=1e-7);
+
+  /**
+   * Get the closest point to the given topological shape. If the
+   * shape is not elementary, all its subshapes are iterated, faces
+   * first, then edges, and the closest point is returned together
+   * with the shape which contains it, and the u v coordinates of the
+   * point. If the returned shape is an edge, then only the u
+   * coordinate is filled with sensible information, and the v
+   * coordinate is set to zero.
+   */
+  Point<3> closest_point(const TopoDS_Shape in_shape, 
+                        const Point<3> origin,
+                        TopoDS_Shape &out_shape,
+                        double &u, 
+                        double &v, 
+                        const double tolerance=1e-7);
+
+  /**
+   * Convert OpenCASCADE point into a Point<3>.
+   */
+  Point<3> Pnt(const gp_Pnt &p);
+
+
+  /**
+   * Convert Point<3> into OpenCASCADE point.
+   */
+  gp_Pnt Pnt(const Point<3> &p);
+
+  
+  /**
+   * Sort two points according to their scalar product with
+   * direction. If the norm of the direction is zero, then use
+   * lexycographical ordering.
+   */
+  inline bool point_compare(const dealii::Point<3> &p1, const dealii::Point<3> &p2,
+                           const dealii::Point<3> direction=Point<3>(),
+                           const double tolerance=1e-10);
+                                     
+}
+/*@}*/
+
+DEAL_II_NAMESPACE_CLOSE
+
+#endif // DEAL_II_WITH_OPENCASCADE
+
+/*------------------------------ occ_utilities.h ------------------------------*/
+#endif
+/*------------------------------ occ_utilities.h ------------------------------*/
index b0d8f53dc3d23160212f4e8f76aad1eac742c3cf..738fc8c43b6e09973505f94a3bb4c98d5a900a26 100644 (file)
@@ -25,6 +25,7 @@ SET(_src
   intergrid_map.cc
   manifold.cc
   manifold_lib.cc
+  occ_utilities.cc
   persistent_tria.cc
   tria_accessor.cc
   tria_boundary.cc
diff --git a/source/grid/occ_utilities.cc b/source/grid/occ_utilities.cc
new file mode 100644 (file)
index 0000000..61c6244
--- /dev/null
@@ -0,0 +1,350 @@
+#include <deal.II/grid/occ_utilities.h>
+#include <deal.II/base/config.h>
+
+#ifdef DEAL_II_WITH_OPENCASCADE
+
+#include <deal.II/base/point.h>
+
+#include <stdio.h>
+#include <stdlib.h>
+#include <iostream>
+#include <set>
+
+#include <IGESControl_Reader.hxx>
+#include <IGESControl_Controller.hxx>
+
+// #include <IGESControl_Writer.hxx>
+#include <TopoDS.hxx>
+#include <TopoDS_Shape.hxx>
+// #include <TopoDS_Shell.hxx>
+#include <TopoDS_Face.hxx>
+#include <TopoDS_Edge.hxx>
+#include <BRepTools.hxx>
+
+// #include <XSControl_Reader.hxx>
+// #include <TopTools_SequenceOfShape.hxx>
+#include <Handle_Standard_Transient.hxx>
+#include <TColStd_SequenceOfTransient.hxx>
+#include <TColStd_HSequenceOfTransient.hxx>
+#include <TopExp_Explorer.hxx>
+// #include <gp_Pnt.hxx>
+// #include <gp_Vec.hxx>
+#include <GeomAPI_ProjectPointOnSurf.hxx>
+#include <GeomAPI_ProjectPointOnCurve.hxx>
+// #include <Standard_Real.hxx>
+// #include <Standard_Integer.hxx>
+// #include <BRep_Tool.hxx>
+// #include <Geom_Surface.hxx>
+#include <Geom_Plane.hxx>
+// #include <Prs3d_ShapeTool.hxx>
+// #include <GeomAPI_IntSS.hxx>
+// #include <Bnd_Box.hxx>
+// #include <gp_Trsf.hxx>
+// #include <gp_Ax3.hxx>
+// #include <gp_Pln.hxx>
+#include <BRepBuilderAPI_Transform.hxx>
+#include <GeomConvert_CompCurveToBSplineCurve.hxx>
+#include <BRepBuilderAPI_MakeEdge.hxx>
+// #include <TColGeom_Array1OfCurve.hxx>
+#include <TColgp_HArray1OfPnt.hxx>
+// #include <Geom_Curve.hxx>
+#include <Geom_BoundedCurve.hxx>
+// #include <Geom_TrimmedCurve.hxx>
+// #include <Geom_BSplineCurve.hxx>
+#include <GeomAPI_Interpolate.hxx>
+#include <BRepAlgo_Section.hxx>
+// #include <GeomLib_Tool.hxx>
+// #include <TColGeom_Array2OfBezierSurface.hxx>
+// #include <ProjLib_ProjectOnPlane.hxx>
+// #include <Adaptor3d_HCurve.hxx>
+// #include <GeomAdaptor_HCurve.hxx>
+#include <ShapeAnalysis_Surface.hxx>
+// #include <GeomLProp_SLProps.hxx>
+// #include <BRepExtrema_DistShapeShape.hxx>
+// #include <BRepBuilderAPI_MakeVertex.hxx>
+// #include <GCPnts_AbscissaPoint.hxx>
+// #include <GeomLProp_CLProps.hxx>
+
+#include <deal.II/base/utilities.h>
+#include <deal.II/base/exceptions.h>
+
+#include <boost/bind.hpp>
+
+#include <BRep_Builder.hxx>
+
+
+#include <vector>
+#include <algorithm>
+
+DEAL_II_NAMESPACE_OPEN
+
+namespace OpenCASCADE
+{
+  void count_elements(const TopoDS_Shape &shape,
+                     unsigned int &n_faces,
+                     unsigned int &n_edges,
+                     unsigned int &n_vertices) {
+    TopExp_Explorer exp;
+    n_faces=0, n_edges=0, n_vertices=0;
+    for(exp.Init(shape, TopAbs_FACE); exp.More(); exp.Next(), ++n_faces) {
+    }
+    for(exp.Init(shape, TopAbs_EDGE); exp.More(); exp.Next(), ++n_edges) {
+    }
+    for(exp.Init(shape, TopAbs_VERTEX); exp.More(); exp.Next(), ++n_vertices) {
+    }    
+  }
+
+  gp_Pnt Pnt(const Point<3> &p)
+  {
+    return gp_Pnt(p(0), p(1), p(2));
+  }
+
+  
+  Point<3> Pnt(const gp_Pnt &p)
+  {
+    return Point<3>(p.X(), p.Y(), p.Z());
+  }
+  
+  inline bool point_compare(const dealii::Point<3> &p1, const dealii::Point<3> &p2,
+                           const dealii::Point<3> direction=Point<3>(),
+                           const double tolerance=1e-10)
+  {
+    const double rel_tol=std::max(p1.norm(), p2.norm())*tolerance;
+    if(direction.norm() > 0.0)
+      return (p1*direction < p2*direction-rel_tol);
+    else 
+      for(int d=2; d>=0; --d) 
+       if(p1[d] < p2[d]-rel_tol)
+         return true;
+       else if(p2[d] < p1[d]-rel_tol)
+         return false;
+         
+    // If we got here, for all d, none of the conditions above was
+    // satisfied. The two points are equal up to tolerance
+    return false;
+  }
+  
+
+  TopoDS_Shape read_IGES(const std::string &filename, 
+                        const double scale_factor)
+  {
+    IGESControl_Reader reader;
+    IFSelect_ReturnStatus stat;
+    stat = reader.ReadFile(filename.c_str()); 
+    Assert(stat == IFSelect_RetDone, 
+          ExcMessage("Error in reading file!"));
+          
+    Standard_Boolean failsonly = Standard_False;
+    IFSelect_PrintCount mode = IFSelect_ItemsByEntity;
+    reader.PrintCheckLoad (failsonly, mode);
+
+    Handle(TColStd_HSequenceOfTransient) myList = reader.GiveList("iges-faces");
+                                    //selects all IGES faces in the
+                                    //file and puts them into a list
+                                    //called MyList,
+    Standard_Integer // nIgesFaces = myList->Length(), 
+      nTransFaces = reader.TransferList(myList);
+
+    AssertThrow(nTransFaces > 0, 
+               ExcMessage("Read nothing from file."));
+
+                                    // Handle IGES Scale here.
+    gp_Pnt Origin;
+    gp_Trsf scale;
+    scale.SetScale (Origin, scale_factor);
+
+    TopoDS_Shape sh = reader.OneShape();
+    BRepBuilderAPI_Transform trans(sh, scale);
+    
+    return trans.Shape();   // this is the actual translation
+  }
+  
+
+   TopoDS_Shape intersect_plane(const TopoDS_Shape &in_shape,
+                               const double c_x,
+                               const double c_y,
+                               const double c_z,
+                               const double c,
+                               const double tolerance) 
+   {
+     TopoDS_Shape out_shape;
+     Handle(Geom_Plane) plane = new Geom_Plane(c_x,c_y,c_z,c);
+
+     // This is to loop on the faces,
+     // that extracts all
+     // intersections.
+   
+     //TopExp_Explorer faceExplorer(in_shape , TopAbs_FACE);
+
+     std::vector<Handle_Geom_BoundedCurve> intersections;
+     BRepAlgo_Section section(in_shape, plane);
+     TopoDS_Shape edges = section.Shape();
+
+     TopoDS_Edge edge;
+     TopLoc_Location L;
+     Standard_Real First;
+     Standard_Real Last;   
+     gp_Pnt PIn(0.0,0.0,0.0);
+     gp_Pnt PFin(0.0,0.0,0.0);
+     gp_Pnt PMid(0.0,0.0,0.0); 
+     TopExp_Explorer edgeExplorer(edges , TopAbs_EDGE);
+     while (edgeExplorer.More())
+       {
+        edge = TopoDS::Edge(edgeExplorer.Current());
+        Handle(Geom_Curve) curve = BRep_Tool::Curve(edge,L,First,Last);
+        intersections.push_back(Handle(Geom_BoundedCurve)::DownCast(curve));
+        edgeExplorer.Next();
+       }
+  
+     // Now we build a single bspline out of all the geometrical
+     // curves
+     unsigned int numIntersEdges = intersections.size();  
+     for (unsigned int i = 0;i<intersections.size();++i)
+       {
+        if (intersections[i]->Value(intersections[i]->FirstParameter()).X() > 
+            intersections[i]->Value(intersections[i]->LastParameter()).X()  )
+          intersections[i]->Reverse();
+       }
+
+     GeomConvert_CompCurveToBSplineCurve
+       convert_bspline(intersections[0], Convert_TgtThetaOver2);
+     bool check = false, one_added = true, one_failed=true;
+     std::vector<bool> added(numIntersEdges, false);
+     added[0] = true;
+     while(one_added == true) 
+       {
+        one_added = false;
+        one_failed = false;
+        for (unsigned int i=1; i<numIntersEdges; ++i)
+          if(added[i] == false) 
+            { 
+              Handle(Geom_Curve) curve = intersections[i];
+              Handle(Geom_BoundedCurve) bcurve = Handle(Geom_BoundedCurve)::DownCast(curve);
+              check = convert_bspline.Add(bcurve,tolerance,0,1,0);
+              one_failed = one_failed || (check == false);
+              one_added = one_added || (check == true);
+              added[i] = check;
+              //cout<<i<<" -->  "<<added[i]<<"  "<<false<<endl;
+            }
+       }
+     Assert(one_failed == false,
+           ExcMessage("Bspline convertion of intersection with plane has failed."));
+
+     Handle(Geom_Curve) bspline = convert_bspline.BSplineCurve();
+
+     out_shape = BRepBuilderAPI_MakeEdge(bspline);
+
+     if (bspline->IsCN(1))
+       cout<<"Intersection with plane is at least a C1 curve"<<endl;
+     else
+       cout<<"Intersection with plane is not a C1 curve "<<endl;
+     return out_shape;
+   }
+
+
+
+  TopoDS_Shape interpolation_curve(std::vector<Point<3> > &curve_points,
+                                  const Point<3> direction,
+                                  const double tolerance)
+  {
+
+    unsigned int n_vertices = curve_points.size();
+
+    if(direction*direction > 0) 
+      {
+       std::sort(curve_points.begin(), curve_points.end(),
+                 boost::bind(&OpenCASCADE::point_compare, _1, _2, direction, tolerance));
+      }
+
+                                    // set up array of vertices
+    Handle(TColgp_HArray1OfPnt) vertices = new TColgp_HArray1OfPnt(1,n_vertices);
+    for (unsigned int vertex=0; vertex<n_vertices; ++vertex)
+      {
+       vertices->SetValue(vertex+1,Pnt(curve_points[vertex]));
+      }
+
+
+    GeomAPI_Interpolate bspline_generator(vertices, false, tolerance);
+    bspline_generator.Perform();
+    Assert( (bspline_generator.IsDone()), ExcMessage("Interpolated bspline generation failed"));
+    
+    Handle(Geom_BSplineCurve) bspline = bspline_generator.Curve();
+    TopoDS_Shape out_shape = BRepBuilderAPI_MakeEdge(bspline);
+    return out_shape;
+  }
+
+
+  Point<3> closest_point(const TopoDS_Shape in_shape, 
+                        const Point<3> origin,
+                        TopoDS_Shape &out_shape,
+                        double &u, 
+                        double &v, 
+                        const double tolerance) {
+    
+    TopExp_Explorer exp;
+    gp_Pnt Pproj = Pnt(origin);
+
+    double minDistance = 1e7;
+    gp_Pnt tmp_proj(0.0,0.0,0.0);
+    
+    unsigned int counter = 0;
+    u=0; v=0;
+    
+    for(exp.Init(in_shape, TopAbs_FACE); exp.More(); exp.Next()) {
+      TopoDS_Face face = TopoDS::Face(exp.Current());
+      
+      // the projection function needs a surface, so we obtain the
+      // surface upon which the face is defined
+      Handle(Geom_Surface) SurfToProj = BRep_Tool::Surface(face);
+      
+      ShapeAnalysis_Surface projector(SurfToProj);
+      gp_Pnt2d proj_params = projector.ValueOfUV(Pnt(origin), tolerance);
+      
+      SurfToProj->D0(proj_params.X(),proj_params.Y(),tmp_proj);
+      
+      double distance = Pnt(tmp_proj).distance(origin);
+      if (distance < minDistance)
+       {
+         minDistance = distance;
+         Pproj = tmp_proj;
+         out_shape = face;
+         u=proj_params.X();
+         v=proj_params.Y();
+         ++counter;
+       }
+    }
+
+    for(exp.Init(in_shape, TopAbs_EDGE); exp.More(); exp.Next()) {
+      TopoDS_Edge edge = TopoDS::Edge(exp.Current());
+
+      TopLoc_Location L;
+      Standard_Real First;
+      Standard_Real Last;
+      
+      // the projection function needs a Curve, so we obtain the
+      // curve upon which the edge is defined
+      Handle(Geom_Curve) CurveToProj = BRep_Tool::Curve(edge,L,First,Last);
+
+      GeomAPI_ProjectPointOnCurve Proj(Pnt(origin),CurveToProj);
+      unsigned int num_proj_points = Proj.NbPoints();
+      if ((num_proj_points > 0) && (Proj.LowerDistance() < minDistance))
+       {
+         minDistance = Proj.LowerDistance();
+         Pproj = Proj.NearestPoint();
+         out_shape = edge;
+         u=Proj.LowerDistanceParameter();
+         ++counter;
+       }
+    }
+    
+    Assert(counter > 0, ExcMessage("Could not find projection points."));
+    return Pnt(Pproj);
+  }
+
+} // end namespace
+
+DEAL_II_NAMESPACE_CLOSE
+
+#endif
index 4f683de2ca578c45cb4674ad14346fcffc87321e..35bfe8b82dbd1341ac69a3f7c78ee9ddc515dbd9 100644 (file)
@@ -61,7 +61,7 @@ ENDFOREACH()
 SET(_categories
   a-framework algorithms all-headers aniso base bits build_tests codim_one
   deal.II distributed_grids fe gla grid hp integrators lac lapack manifold
-  matrix_free mesh_converter metis mpi multigrid mumps petsc serialization
+  matrix_free mesh_converter metis mpi multigrid mumps opencascade petsc serialization
   slepc trilinos umfpack
   )
 
diff --git a/tests/opencascade/CMakeLists.txt b/tests/opencascade/CMakeLists.txt
new file mode 100644 (file)
index 0000000..f759a1d
--- /dev/null
@@ -0,0 +1,7 @@
+CMAKE_MINIMUM_REQUIRED(VERSION 2.8.9)
+INCLUDE(${DEAL_II_SOURCE_DIR}/tests/setup_testsubproject.cmake)
+PROJECT(testsuite CXX)
+INCLUDE(${DEAL_II_TARGET_CONFIG})
+IF(DEAL_II_WITH_OPENCASCADE)
+  DEAL_II_PICKUP_TESTS()
+ENDIF()
diff --git a/tests/opencascade/closest_point_to_shape.cc b/tests/opencascade/closest_point_to_shape.cc
new file mode 100644 (file)
index 0000000..b1ee136
--- /dev/null
@@ -0,0 +1,71 @@
+// Makes a OpenCASCADE cicrular arc, and project a few points onto it.
+
+
+#include "../tests.h"
+
+#include <deal.II/grid/occ_utilities.h>
+
+#include <base/logstream.h>
+#include <grid/tria.h>
+#include <grid/tria_accessor.h>
+#include <grid/grid_out.h>
+#include <grid/tria_iterator.h>
+#include <grid/grid_generator.h>
+#include <grid/tria_boundary_lib.h>
+
+#include <gp_Pnt.hxx>
+#include <gp_Dir.hxx>
+#include <gp_Ax2.hxx>
+#include <GC_MakeCircle.hxx>
+#include <BRepBuilderAPI_MakeEdge.hxx>
+#include <TopoDS_Edge.hxx>
+
+using namespace OpenCASCADE;
+
+
+int main () 
+{
+  std::ofstream logfile("output");
+  deallog.attach(logfile);
+  deallog.depth_console(0);
+
+                                  // A unit circle
+  gp_Dir z_axis(0.,0.,1.);
+  gp_Pnt center(0.,0.,0.);
+  gp_Ax2 axis(center, z_axis);
+  Standard_Real radius(1.);
+  
+  Handle(Geom_Curve) circle = GC_MakeCircle(axis, radius);
+  TopoDS_Edge edge = BRepBuilderAPI_MakeEdge(circle);
+  
+  
+                                  // Now get a few points and project
+                                  // them on the circle
+  std::vector<Point<3> > points;
+  
+  points.push_back(Point<3>(3,0,0));
+  points.push_back(Point<3>(0,3,0));
+                                  // This one is tricky... the point
+                                  // is not on the xy plane. If we
+                                  // put it on the axis (x=0, y=0),
+                                  // there should not exist a
+                                  // projection. Any value for z
+                                  // should give the same result.  
+  points.push_back(Point<3>(.1,0,3));
+  points.push_back(Point<3>(.1,0,4)); 
+
+  double u, v;
+  TopoDS_Shape sh;
+  for(unsigned int i=0; i<points.size(); ++i) 
+    {
+      Point<3> pp = closest_point(edge, points[i], sh, u, v);
+      
+      deallog << "Origin: " << points[i]
+             << ", on unit circle: " << pp
+             << ", with local coordinates (u, v): (" << u
+             << ", " << v << ")" << std::endl;
+    }
+  return 0;
+}
+
diff --git a/tests/opencascade/closest_point_to_shape.output b/tests/opencascade/closest_point_to_shape.output
new file mode 100644 (file)
index 0000000..adec99d
--- /dev/null
@@ -0,0 +1,5 @@
+
+DEAL::Origin: 3.00000 0.00000 0.00000, on unit circle: 1.00000 0.00000 0.00000, with local coordinates (u, v): (0.00000, 0.00000)
+DEAL::Origin: 0.00000 3.00000 0.00000, on unit circle: 6.12323e-17 1.00000 0.00000, with local coordinates (u, v): (1.57080, 0.00000)
+DEAL::Origin: 0.100000 0.00000 3.00000, on unit circle: 1.00000 0.00000 0.00000, with local coordinates (u, v): (0.00000, 0.00000)
+DEAL::Origin: 0.100000 0.00000 4.00000, on unit circle: 1.00000 0.00000 0.00000, with local coordinates (u, v): (0.00000, 0.00000)
diff --git a/tests/opencascade/iges_files/goteborg.iges b/tests/opencascade/iges_files/goteborg.iges
new file mode 100644 (file)
index 0000000..c4ef150
--- /dev/null
@@ -0,0 +1,1247 @@
+                                                                        S0000001
+,,31HOpen CASCADE IGES processor 6.3,13HFilename.iges,                  G0000001
+16HOpen CASCADE 6.3,31HOpen CASCADE IGES processor 6.3,32,308,15,308,15,G0000002
+,1.,6,1HM,1,0.00001,15H20111103.120309,1.44629E-05,3.234476,5Hamola,,11,G0000003
+0,15H20111103.120309,;                                                  G0000004
+     402       1       0       0       0       0       0       000000000D0000001
+     402       0       0       1       1                               0D0000002
+     510       2       0       0       0       0       0       000010000D0000003
+     510       0       0       1       1                               0D0000004
+     128       3       0       0       0       0       0       000010000D0000005
+     128       0       0     166       0                               0D0000006
+     508     169       0       0       0       0       0       000010000D0000007
+     508       0       0       2       1                               0D0000008
+     504     171       0       0       0       0       0       000010001D0000009
+     504       0       0       3       1                               0D0000010
+     126     174       0       0       0       0       0       000010000D0000011
+     126       0       0      74       0                               0D0000012
+     502     248       0       0       0       0       0       000010000D0000013
+     502       0       0       5       1                               0D0000014
+     126     253       0       0       0       0       0       000010000D0000015
+     126       0       0      10       0                               0D0000016
+     126     263       0       0       0       0       0       000010000D0000017
+     126       0       0       9       0                               0D0000018
+     126     272       0       0       0       0       0       000010000D0000019
+     126       0       0      14       0                               0D0000020
+     126     286       0       0       0       0       0       000010000D0000021
+     126       0       0       5       0                               0D0000022
+     126     291       0       0       0       0       0       000010000D0000023
+     126       0       0      73       0                               0D0000024
+     126     364       0       0       0       0       0       000010000D0000025
+     126       0       0       4       0                               0D0000026
+     126     368       0       0       0       0       0       000010000D0000027
+     126       0       0       9       0                               0D0000028
+     126     377       0       0       0       0       0       000010000D0000029
+     126       0       0       8       0                               0D0000030
+     126     385       0       0       0       0       0       000010000D0000031
+     126       0       0      13       0                               0D0000032
+     126     398       0       0       0       0       0       000010000D0000033
+     126       0       0     232       0                               0D0000034
+     110     630       0       0       0       0       0       000010000D0000035
+     110       0       0       1       0                               0D0000036
+     110     631       0       0       0       0       0       000010000D0000037
+     110       0       0       1       0                               0D0000038
+     110     632       0       0       0       0       0       000010000D0000039
+     110       0       0       1       0                               0D0000040
+     510     633       0       0       0       0       0       000010000D0000041
+     510       0       0       1       1                               0D0000042
+     128     634       0       0       0       0       0       000010000D0000043
+     128       0       0     245       0                               0D0000044
+     508     879       0       0       0       0       0       000010000D0000045
+     508       0       0       2       1                               0D0000046
+     110     881       0       0       0       0       0       000010000D0000047
+     110       0       0       1       0                               0D0000048
+     110     882       0       0       0       0       0       000010000D0000049
+     110       0       0       1       0                               0D0000050
+     110     883       0       0       0       0       0       000010000D0000051
+     110       0       0       1       0                               0D0000052
+     110     884       0       0       0       0       0       000010000D0000053
+     110       0       0       1       0                               0D0000054
+     510     885       0       0       0       0       0       000010000D0000055
+     510       0       0       1       1                               0D0000056
+     128     886       0       0       0       0       0       000010000D0000057
+     128       0       0      92       0                               0D0000058
+     508     978       0       0       0       0       0       000010000D0000059
+     508       0       0       2       1                               0D0000060
+     126     980       0       0       0       0       0       000010000D0000061
+     126       0       0     191       0                               0D0000062
+     110    1171       0       0       0       0       0       000010000D0000063
+     110       0       0       1       0                               0D0000064
+     110    1172       0       0       0       0       0       000010000D0000065
+     110       0       0       1       0                               0D0000066
+     110    1173       0       0       0       0       0       000010000D0000067
+     110       0       0       1       0                               0D0000068
+402,3,3,41,55;                                                   0000001P0000001
+510,5,1,1,7;                                                     0000003P0000002
+128,18,13,3,3,0,0,1,0,0,0.,0.,0.,0.,1.,2.,2.5,2.5,2.5,3.,3.5,    0000005P0000003
+3.5,3.5,4.,5.,6.,7.,8.,9.,10.,10.,10.,10.,0.,0.,0.,0.,1.,2.,3.,  0000005P0000004
+4.,5.,6.,7.,8.,9.,10.,11.,11.,11.,11.,1.,1.,1.,1.,1.,1.,1.,1.,   0000005P0000005
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000005P0000006
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000005P0000007
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000005P0000008
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000005P0000009
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000005P0000010
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000005P0000011
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000005P0000012
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000005P0000013
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000005P0000014
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000005P0000015
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000005P0000016
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000005P0000017
+1.,1.,1.,1.,1.,1.,-1.8411253,0.,-0.149978893,-1.8735103,0.,      0000005P0000018
+-0.149983363,-1.9382801,0.,-0.149992304,-1.9817766,0.,           0000005P0000019
+-0.149997968,-2.0045777,0.,-0.149999822,-2.0094125,0.,           0000005P0000020
+-0.150001092,-2.0150569,0.,-0.159265056,-2.0231086,0.,           0000005P0000021
+-0.17296688,-2.0299576,0.,-0.18546251,-2.0351962,0.,-0.19513311, 0000005P0000022
+-2.0420465,0.,-0.19674603,-2.0783114,0.,-0.20359583,-2.1701788,  0000005P0000023
+0.,-0.2217405,-2.3136179,0.,-0.24795104,-2.4542424,0.,           0000005P0000024
+-0.2685168,-2.56746892,0.,-0.2741742,-2.61219314,0.,-0.2653158,  0000005P0000025
+-2.62871465,0.,-0.2560485,-2.63758308,0.,-0.24960338,-1.8411299, 0000005P0000026
+4.028084E-03,-0.148771605,-1.8735149,4.028084E-03,-0.148770361,  0000005P0000027
+-1.9382783,4.028084E-03,-0.147972547,-1.9824499,2.351634E-03,    0000005P0000028
+-0.147983291,-2.0045777,1.64785E-03,-0.149999822,-2.0094125,     0000005P0000029
+2.014042E-03,-0.150001092,-2.0150569,2.014042E-03,-0.159265056,  0000005P0000030
+-2.0231086,2.014042E-03,-0.17296688,-2.0299576,2.014042E-03,     0000005P0000031
+-0.18546251,-2.0351962,2.014042E-03,-0.19513311,-2.0420465,      0000005P0000032
+1.613535E-03,-0.19674603,-2.0783114,1.027621E-02,-0.20359583,    0000005P0000033
+-2.1701788,2.337321E-02,-0.2217405,-2.3136179,4.472666E-02,      0000005P0000034
+-0.24795104,-2.4542424,5.92312E-02,-0.2685168,-2.56746892,       0000005P0000035
+6.124524E-02,-0.2741742,-2.61219314,4.029232E-02,-0.2653158,     0000005P0000036
+-2.63717686,3.42502E-02,-0.24960376,-2.64685205,0.,-0.24315793,  0000005P0000037
+-1.8411301,1.128321E-02,-0.142723764,-1.873515,1.087699E-02,     0000005P0000038
+-0.142728209,-1.9382791,1.087699E-02,-0.142737175,-1.9848368,    0000005P0000039
+9.669704E-03,-0.142745735,-2.0069992,6.848881E-03,-0.145162748,  0000005P0000040
+-2.0118352,5.641619E-03,-0.14637128,-2.0182799,2.014042E-03,     0000005P0000041
+-0.154833493,-2.0259314,2.014042E-03,-0.16894192,-2.0335879,     0000005P0000042
+2.014042E-03,-0.18223783,-2.0384195,2.014042E-03,-0.19110205,    0000005P0000043
+-2.0448693,2.014042E-03,-0.19271536,-2.0794531,2.155942E-02,     0000005P0000044
+-0.20077968,-2.1738078,5.278283E-02,-0.21086589,-2.3136218,      0000005P0000045
+8.945331E-02,-0.22739863,-2.4542456,0.1140338,-0.24716336,       0000005P0000046
+-2.57714109,0.1104062,-0.2520108,-2.63556549,7.817007E-02,       0000005P0000047
+-0.23952931,-2.660955046,3.182991E-02,-0.22341644,-2.660955046,  0000005P0000048
+0.,-0.22341644,-1.8411296,2.014616E-02,-0.13601217,-1.8735145,   0000005P0000049
+1.933941E-02,-0.13601664,-1.9382844,1.853263E-02,-0.13602558,    0000005P0000050
+-1.9872519,1.571755E-02,-0.13710188,-2.0094147,1.128321E-02,     0000005P0000051
+-0.13992514,-2.014251,9.669704E-03,-0.14153992,-2.0215018,       0000005P0000052
+2.780741E-03,-0.149194617,-2.0307661,2.014042E-03,-0.16249479,   0000005P0000053
+-2.038823,2.014042E-03,-0.17579037,-2.0440647,2.014042E-03,      0000005P0000054
+-0.18264014,-2.0513153,2.014042E-03,-0.18385218,-2.0855003,      0000005P0000055
+2.169102E-02,-0.18761415,-2.1818662,5.358958E-02,-0.18225559,    0000005P0000056
+-2.3140284,0.1003303,-0.1842851,-2.4542511,0.1341799,            0000005P0000057
+-0.19115346,-2.58319229,0.1386086,-0.19358643,-2.64685584,       0000005P0000058
+8.381169E-02,-0.19762449,-2.666596513,3.182991E-02,-0.19843592,  0000005P0000059
+-2.666596513,0.,-0.19843592,-1.8411293,2.820805E-02,-0.12942648, 0000005P0000060
+-1.8735142,2.659454E-02,-0.12943095,-1.9382841,2.458049E-02,     0000005P0000061
+-0.12943989,-1.9888655,2.055241E-02,-0.13105825,-2.0118358,      0000005P0000062
+1.651859E-02,-0.13468753,-2.0166665,1.369779E-02,-0.13630231,    0000005P0000063
+-2.0243224,6.042127E-03,-0.142749367,-2.0346502,2.014042E-03,    0000005P0000064
+-0.155293284,-2.0440621,2.014042E-03,-0.16732882,-2.0488986,     0000005P0000065
+2.014042E-03,-0.17538626,-2.0565547,2.014042E-03,-0.17579119,    0000005P0000066
+-2.0895265,7.792974E-03,-0.17935402,-2.1879153,2.458049E-02,     0000005P0000067
+-0.16493037,-2.3136316,5.358958E-02,-0.157290384,-2.4538562,     0000005P0000068
+0.1019438,-0.147634422,-2.58319533,0.112014,-0.147251949,        0000005P0000069
+-2.64363816,6.165149E-02,-0.158136153,-2.661364494,2.900911E-02, 0000005P0000070
+-0.17103371,-2.661364494,0.,-0.17103371,-1.8411329,3.787775E-02, 0000005P0000071
+-0.12096407,-1.8735178,3.586371E-02,-0.12096851,-1.938282,       0000005P0000072
+3.263666E-02,-0.12097748,-1.9918544,2.961561E-02,-0.12098528,    0000005P0000073
+-2.0157525,2.458049E-02,-0.12552347,-2.0215042,2.21602E-02,      0000005P0000074
+-0.12703441,-2.0308896,1.853263E-02,-0.12898257,-2.0452261,      0000005P0000075
+1.168375E-02,-0.13287728,-2.0600373,6.614312E-03,-0.13650836,    0000005P0000076
+-2.0687585,5.584393E-03,-0.13795364,-2.0771076,4.548759E-03,     0000005P0000077
+-0.13913032,-2.1075961,4.29702E-03,-0.142626812,-2.1955747,      0000005P0000078
+2.578778E-02,-0.13793396,-2.3136336,3.868453E-02,-0.13472393,    0000005P0000079
+-2.4538556,6.285878E-02,-0.12829501,-2.57393393,7.534928E-02,    0000005P0000080
+-0.1246826,-2.62711813,1.531132E-02,-0.13798804,-2.6444467,      0000005P0000081
+1.613535E-03,-0.147658933,-2.6444467,0.,-0.147658933,-1.8411331, 0000005P0000082
+4.351937E-02,-0.11492191,-1.8740329,4.150533E-02,-0.11492593,    0000005P0000083
+-1.9382821,3.747153E-02,-0.11493533,-1.9928616,3.411286E-02,     0000005P0000084
+-0.11494221,-2.0199368,3.270532E-02,-0.11494587,-2.0271461,      0000005P0000085
+3.223616E-02,-0.11494493,-2.0373079,3.182991E-02,-0.11494701,    0000005P0000086
+-2.0539924,3.102887E-02,-0.11494879,-2.0704824,3.022211E-02,     0000005P0000087
+-0.11495074,-2.0797402,2.983304E-02,-0.11495366,-2.0889979,      0000005P0000088
+2.944967E-02,-0.11495082,-2.1198208,2.833967E-02,-0.11495674,    0000005P0000089
+-2.2024253,2.699504E-02,-0.11496639,-2.3136383,3.344342E-02,     0000005P0000090
+-0.11498399,-2.4538605,4.634017E-02,-0.11499773,-2.5674881,      0000005P0000091
+3.062262E-02,-0.11501313,-2.62027095,1.007595E-02,-0.11502166,   0000005P0000092
+-2.63558227,1.613535E-03,-0.11501899,-2.63558227,0.,-0.11501899, 0000005P0000093
+-1.8411358,7.534928E-02,-8.067172E-02,-1.8735207,7.051441E-02,   0000005P0000094
+-8.067619E-02,-1.9382906,6.406604E-02,-8.068513E-02,-1.9967497,  0000005P0000095
+5.970039E-02,-8.1026E-02,-2.0261365,5.73831E-02,-8.108475E-02,   0000005P0000096
+-2.0356002,5.658777E-02,-8.109318E-02,-2.0450697,5.579245E-02,   0000005P0000097
+-8.110161E-02,-2.0633448,5.41446E-02,-8.110192E-02,-2.0815228,   0000005P0000098
+5.216489E-02,-8.110804E-02,-2.0914099,5.107203E-02,              0000005P0000099
+-8.110466E-02,-2.1012913,4.99792E-02,-8.110697E-02,-2.1333272,   0000005P0000100
+4.640311E-02,-8.111177E-02,-2.2108908,3.868453E-02,              0000005P0000101
+-8.112036E-02,-2.3132352,2.981587E-02,-8.113468E-02,-2.4538636,  0000005P0000102
+1.813212E-02,-8.115378E-02,-2.56668444,5.641619E-03,             0000005P0000103
+-8.116417E-02,-2.61181166,2.820797E-03,-8.117405E-02,            0000005P0000104
+-2.63075053,1.613535E-03,-8.117377E-02,-2.63075053,0.,           0000005P0000105
+-8.117377E-02,-1.8411412,0.1136276,-3.07097E-02,-1.8735262,      0000005P0000106
+0.1091989,-3.07141E-02,-1.938296,9.831624E-02,-3.07231E-02,      0000005P0000107
+-1.996566,8.824603E-02,-3.07266E-02,-2.0288765,8.340545E-02,     0000005P0000108
+-3.07311E-02,-2.0394846,8.186631E-02,-3.07328E-02,-2.0500927,    0000005P0000109
+8.032145E-02,-3.07344E-02,-2.070977,7.736332E-02,-3.0738E-02,    0000005P0000110
+-2.0917296,7.441093E-02,-3.07418E-02,-2.1026181,7.286605E-02,    0000005P0000111
+-3.07432E-02,-2.1135065,7.132119E-02,-3.07446E-02,-2.1477052,    0000005P0000112
+6.648633E-02,-3.07474E-02,-2.2205656,5.64104E-02,-3.07546E-02,   0000005P0000113
+-2.317274,3.908504E-02,-3.07684E-02,-2.4550759,2.055241E-02,     0000005P0000114
+-3.07844E-02,-2.56911053,9.269171E-03,-3.16061E-02,-2.60819559,  0000005P0000115
+6.042127E-03,-3.16101E-02,-2.627535,4.028084E-03,-3.16152E-02,   0000005P0000116
+-2.627535,0.,-3.16152E-02,-1.8411536,0.1692312,5.51161E-02,      0000005P0000117
+-1.8735386,0.1607745,5.51117E-02,-1.9383084,0.1462642,           0000005P0000118
+5.51027E-02,-1.9967672,0.1328353,5.50994E-02,-2.0312921,         0000005P0000119
+0.1250767,5.50912E-02,-2.0427469,0.1225248,5.50903E-02,          0000005P0000120
+-2.0542018,0.1199729,5.50894E-02,-2.0770086,0.1149378,           0000005P0000121
+5.50876E-02,-2.0996552,0.1100343,5.50856E-02,-2.1113618,         0000005P0000122
+0.1074653,5.50849E-02,-2.1230684,0.1048962,5.50843E-02,          0000005P0000123
+-2.1593327,9.684004E-02,5.50777E-02,-2.2318612,7.937736E-02,     0000005P0000124
+5.50702E-02,-2.3289702,5.600987E-02,5.50567E-02,-2.4655648,      0000005P0000125
+2.900911E-02,5.50396E-02,-2.58846162,1.047646E-02,5.50214E-02,   0000005P0000126
+-2.62794719,5.641619E-03,5.50177E-02,-2.64527255,4.028084E-03,   0000005P0000127
+5.50165E-02,-2.64527255,0.,5.50165E-02,-1.8411636,0.211137,      0000005P0000128
+0.1373143,-1.8735486,0.2034814,0.1373099,-1.938317,0.1869628,    0000005P0000129
+0.1389145,-1.9967793,0.1715199,0.1412571,-2.0331165,0.1627027,   0000005P0000130
+0.1428183,-2.045269,0.1597389,0.1433044,-2.0574215,0.156775,     0000005P0000131
+0.1437848,-2.0818066,0.1508016,0.1446884,-2.1059632,0.1444218,   0000005P0000132
+0.1452599,-2.1184477,0.1411032,0.1455518,-2.1309379,0.1377904,   0000005P0000133
+0.1458437,-2.1696216,0.1274627,0.1467433,-2.2471825,0.1079859,   0000005P0000134
+0.1497558,-2.3515437,8.09909E-02,0.1529647,-2.4921706,           0000005P0000135
+4.593394E-02,0.1545591,-2.61627429,1.933941E-02,0.1549482,       0000005P0000136
+-2.672284183,1.087699E-02,0.1549426,-2.69485063,4.028084E-03,    0000005P0000137
+0.1549406,-2.69485063,0.,0.1549406,-1.8411737,0.246194,          0000005P0000138
+0.2195183,-1.8735586,0.2385383,0.2195138,-1.9383255,0.2244343,   0000005P0000139
+0.2227262,-1.9967878,0.21235,0.2250688,-2.034938,0.2032811,      0000005P0000140
+0.2275357,-2.0478282,0.2001513,0.228423,-2.0607184,0.1970216,    0000005P0000141
+0.2293103,-2.0868535,0.1905389,0.2312226,-2.1130285,0.1839932,   0000005P0000142
+0.2331978,-2.1266452,0.1806231,0.234286,-2.1402676,0.1772588,    0000005P0000143
+0.23538,-2.1827252,0.1668853,0.2389495,-2.2693611,0.147071,      0000005P0000144
+0.2476692,-2.3954806,0.1172551,0.2585309,-2.5437597,             0000005P0000145
+7.897685E-02,0.2701968,-2.68519165,4.150533E-02,0.2798482,       0000005P0000146
+-2.75248379,1.813212E-02,0.2870967,-2.7734371,4.028084E-03,      0000005P0000147
+0.2866926,-2.7734367,0.,0.2870932,-1.8411863,0.2844723,          0000005P0000148
+0.2988957,-1.8735713,0.2776234,0.2988912,-1.9383381,0.2643261,   0000005P0000149
+0.3021036,-1.9967992,0.2508972,0.3057908,-2.0370607,0.2448036,   0000005P0000150
+0.3083054,-2.0508606,0.2427781,0.3092508,-2.0646605,0.2407526,   0000005P0000151
+0.3102019,-2.0930096,0.2367245,0.3123107,-2.1220676,0.2318897,   0000005P0000152
+0.315164,-2.1374174,0.2292405,0.316849,-2.1527672,0.2265857,     0000005P0000153
+0.3185338,-2.2012706,0.217923,0.324369,-2.3040248,0.1994533,     0000005P0000154
+0.3391285,-2.4551299,0.173265,0.3636881,-2.61066653,0.1345805,   0000005P0000155
+0.3850248,-2.7710322,8.13914E-02,0.400318,-2.8673392,            0000005P0000156
+4.029232E-02,0.407559,-2.9197186,4.028084E-03,0.4107771,         0000005P0000157
+-2.9225432,0.,0.4127881,-1.8410594,0.3328265,0.4117164,          0000005P0000158
+-1.8736931,0.3296052,0.4149392,-1.9383544,0.3231568,0.4209723,   0000005P0000159
+-1.9966245,0.3161019,0.427011,-2.0399682,0.3109695,0.431388,     0000005P0000160
+-2.0551008,0.3091615,0.432901,-2.0702276,0.3073591,0.4344198,    0000005P0000161
+-2.1018601,0.3035656,0.437573,-2.1352376,0.2994346,0.4408595,    0000005P0000162
+-2.1530419,0.2970886,0.442621,-2.1708463,0.2947485,0.4443825,    0000005P0000163
+-2.2276119,0.2868925,0.4500136,-2.3491699,0.2667464,0.4624216,   0000005P0000164
+-2.5192064,0.2280619,0.4765051,-2.68159585,0.1817274,0.4873659,  0000005P0000165
+-2.8443828,0.1273311,0.4954005,-2.9801719,6.447229E-02,          0000005P0000166
+0.5002233,-3.0595482,4.028084E-03,0.5014179,-3.0595482,0.,       0000005P0000167
+0.5014179,1.961052526,10.,0.,11.;                                0000005P0000168
+508,4,0,9,1,0,1,0,33,0,9,2,1,1,0,35,0,9,3,1,1,0,37,0,9,4,0,1,0,  0000007P0000169
+39;                                                              0000007P0000170
+504,10,11,13,1,13,2,15,13,1,13,3,17,13,3,13,4,19,13,2,13,4,21,   0000009P0000171
+13,1,13,5,23,13,5,13,6,25,13,2,13,6,27,13,5,13,7,29,13,7,13,8,   0000009P0000172
+31,13,6,13,8;                                                    0000009P0000173
+126,80,5,1,0,1,0,0.,0.,0.,0.,0.,0.,1.294475869E-02,              0000011P0000174
+1.294475869E-02,1.294475869E-02,3.677477935E-02,3.677477935E-02, 0000011P0000175
+3.677477935E-02,6.37318215E-02,6.37318215E-02,6.37318215E-02,    0000011P0000176
+9.214808598E-02,9.214808598E-02,9.214808598E-02,0.121332981,     0000011P0000177
+0.121332981,0.121332981,0.151632798,0.151632798,0.151632798,     0000011P0000178
+0.1758443,0.1758443,0.1758443,0.210359082,0.210359082,           0000011P0000179
+0.210359082,0.246682918,0.246682918,0.246682918,0.284528737,     0000011P0000180
+0.284528737,0.284528737,0.32376227,0.32376227,0.32376227,        0000011P0000181
+0.364138741,0.364138741,0.364138741,0.405236432,0.405236432,     0000011P0000182
+0.405236432,0.436342998,0.436342998,0.436342998,0.478039961,     0000011P0000183
+0.478039961,0.478039961,0.519962761,0.519962761,0.519962761,     0000011P0000184
+0.562315329,0.562315329,0.562315329,0.605309669,0.605309669,     0000011P0000185
+0.605309669,0.649262383,0.649262383,0.649262383,0.68324956,      0000011P0000186
+0.68324956,0.68324956,0.730724691,0.730724691,0.730724691,       0000011P0000187
+0.780978326,0.780978326,0.780978326,0.83357938,0.83357938,       0000011P0000188
+0.83357938,0.887890113,0.887890113,0.887890113,0.943462915,      0000011P0000189
+0.943462915,0.943462915,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000011P0000190
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000011P0000191
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000011P0000192
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000011P0000193
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,-2.010663,-5.551115123E-17,     0000011P0000194
+-0.152057631,-2.010663,2.192562401E-03,-0.150991702,-2.010663,   0000011P0000195
+2.470301091E-04,-0.152631099,-2.010663,3.029158552E-03,          0000011P0000196
+-0.149674216,-2.010663,3.365191399E-03,-0.14822999,-2.010663,    0000011P0000197
+5.118457775E-03,-0.146908691,-2.010663,5.873359039E-03,          0000011P0000198
+-0.145955269,-2.010663,7.654583196E-03,-0.144053896,-2.010663,   0000011P0000199
+9.260894273E-03,-0.142222174,-2.010663,1.010271957E-02,          0000011P0000200
+-0.141272708,-2.010663,1.181875623E-02,-0.139358061,-2.010663,   0000011P0000201
+1.366229627E-02,-0.137383774,-2.010663,1.466167086E-02,          0000011P0000202
+-0.136322917,-2.010663,1.683693655E-02,-0.134021987,-2.010663,   0000011P0000203
+1.927946131E-02,-0.131406427,-2.010663,2.055775019E-02,          0000011P0000204
+-0.130017481,-2.010663,2.317581602E-02,-0.12712326,-2.010663,    0000011P0000205
+2.577881373E-02,-0.124119062,-2.010663,2.700662073E-02,          0000011P0000206
+-0.122665714,-2.010663,2.933857512E-02,-0.119793233,-2.010663,   0000011P0000207
+3.198439543E-02,-0.116381303,-2.010663,3.324359497E-02,          0000011P0000208
+-0.114736043,-2.010663,3.649498241E-02,-0.110454568,-2.010663,   0000011P0000209
+4.020176937E-02,-0.105529255,-2.010663,4.245514765E-02,          0000011P0000210
+-0.102481673,-2.010663,4.719737423E-02,-9.593294872E-02,         0000011P0000211
+-2.010663,5.208215231E-02,-8.88424219E-02,-2.010663,             0000011P0000212
+5.460381E-02,-8.507750011E-02,-2.010663,5.974289917E-02,         0000011P0000213
+-7.713985772E-02,-2.010663,6.481581795E-02,-6.871139627E-02,     0000011P0000214
+-2.010663,6.739620648E-02,-6.429056883E-02,-2.010663,            0000011P0000215
+7.264475388E-02,-5.50632489E-02,-2.010663,7.790443011E-02,       0000011P0000216
+-4.5424964E-02,-2.010663,8.059095806E-02,-4.0423136E-02,         0000011P0000217
+-2.010663,8.606806939E-02,-3.0103057E-02,-2.010663,              0000011P0000218
+9.161316932E-02,-1.9467868E-02,-2.010663,9.444582827E-02,        0000011P0000219
+-1.4004167E-02,-2.010663,0.100168309,-2.879354E-03,-2.010663,    0000011P0000220
+0.105899822,8.425014E-03,-2.010663,0.108786628,1.4163351E-02,    0000011P0000221
+-2.010663,0.113846214,2.4300656E-02,-2.010663,0.118870191,       0000011P0000222
+3.4520839E-02,-2.010663,0.121026173,3.8937164E-02,-2.010663,     0000011P0000223
+0.126048143,4.9299837E-02,-2.010663,0.131002538,5.9715297E-02,   0000011P0000224
+-2.010663,0.13381038,6.5695126E-02,-2.010663,0.139406089,        0000011P0000225
+7.771038E-02,-2.010663,0.144935488,8.9750801E-02,-2.010663,      0000011P0000226
+0.147694038,9.5785175E-02,-2.010663,0.153216264,0.107895475,     0000011P0000227
+-2.010663,0.158704444,0.119935304,-2.010663,0.16145713,          0000011P0000228
+0.125960258,-2.010663,0.166999357,0.1380393,-2.010663,           0000011P0000229
+0.172546846,0.149963785,-2.010663,0.17534571,0.155930209,        0000011P0000230
+-2.010663,0.1810135,0.167934885,-2.010663,0.186703971,           0000011P0000231
+0.179832759,-2.010663,0.189584341,0.185821639,-2.010663,         0000011P0000232
+0.194712178,0.196428819,-2.010663,0.199840153,0.206957809,       0000011P0000233
+-2.010663,0.202072482,0.211527279,-2.010663,0.207403955,         0000011P0000234
+0.222418152,-2.010663,0.212701313,0.233179592,-2.010663,         0000011P0000235
+0.215756708,0.239389757,-2.010663,0.222083463,0.252160531,       0000011P0000236
+-2.010663,0.228501245,0.264932869,-2.010663,0.231834725,         0000011P0000237
+0.271513948,-2.010663,0.238710655,0.284997455,-2.010663,         0000011P0000238
+0.245687148,0.298514533,-2.010663,0.24927514,0.305430764,        0000011P0000239
+-2.010663,0.256599596,0.319488991,-2.010663,0.26397988,          0000011P0000240
+0.333549081,-2.010663,0.267739885,0.340689745,-2.010663,         0000011P0000241
+0.275365647,0.355132896,-2.010663,0.283020109,0.369561637,       0000011P0000242
+-2.010663,0.286896874,0.376854443,-2.010663,0.294726199,         0000011P0000243
+0.391556216,-2.010663,0.302569582,0.406237062,-2.010663,         0000011P0000244
+0.306527711,0.413635185,-2.010663,0.310488219,0.42102837,        0000011P0000245
+-2.010663,0.314450974,0.428417309,0.,1.,1.,2.053360425E-14,      0000011P0000246
+1.026680213E-14;                                                 0000011P0000247
+502,8,-2.010663,-2.69966341E-17,-0.152057631,-2.010663,          0000013P0000248
+0.314450974,0.428417309,-2.63758308,-6.938893904E-18,            0000013P0000249
+-0.24960338,-3.0595482,0.,0.5014179,-1.8410594,5.42101086E-19,   0000013P0000250
+-0.149985705,-1.8410594,0.332475514,0.410906755,3.053863,        0000013P0000251
+-2.541098842E-21,7.5097E-02,3.059549,0.2786476,0.2962533;        0000013P0000252
+126,13,3,1,0,1,0,2.537723945,2.537723945,2.537723945,            0000015P0000253
+2.537723945,3.,3.5,3.5,3.5,4.,5.,6.,7.,8.,9.,10.,10.,10.,10.,1., 0000015P0000254
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,-2.010663,0.,             0000015P0000255
+-0.152057631,-2.015662672,0.,-0.160297113,-2.023366971,0.,       0000015P0000256
+-0.173438264,-2.0299576,0.,-0.18546251,-2.0351962,0.,            0000015P0000257
+-0.19513311,-2.0420465,0.,-0.19674603,-2.0783114,0.,-0.20359583, 0000015P0000258
+-2.1701788,0.,-0.2217405,-2.3136179,0.,-0.24795104,-2.4542424,   0000015P0000259
+0.,-0.2685168,-2.56746892,0.,-0.2741742,-2.61219314,0.,          0000015P0000260
+-0.2653158,-2.62871465,0.,-0.2560485,-2.63758308,0.,-0.24960338, 0000015P0000261
+2.537723945,10.,0.,1.,0.;                                        0000015P0000262
+126,13,3,1,0,1,0,0.,0.,0.,0.,1.,2.,3.,4.,5.,6.,7.,8.,9.,10.,11., 0000017P0000263
+11.,11.,11.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,           0000017P0000264
+-2.63758308,0.,-0.24960338,-2.64685205,0.,-0.24315793,           0000017P0000265
+-2.660955046,0.,-0.22341644,-2.666596513,0.,-0.19843592,         0000017P0000266
+-2.661364494,0.,-0.17103371,-2.6444467,0.,-0.147658933,          0000017P0000267
+-2.63558227,0.,-0.11501899,-2.63075053,0.,-8.117377E-02,         0000017P0000268
+-2.627535,0.,-3.16152E-02,-2.64527255,0.,5.50165E-02,            0000017P0000269
+-2.69485063,0.,0.1549406,-2.7734367,0.,0.2870932,-2.9225432,0.,  0000017P0000270
+0.4127881,-3.0595482,0.,0.5014179,0.,11.,0.,-1.,0.;              0000017P0000271
+126,17,3,0,0,1,0,1.983431199,1.983431199,1.983431199,            0000019P0000272
+1.983431199,2.,2.5,2.5,2.5,3.,3.5,3.5,3.5,4.,5.,6.,7.,8.,9.,10., 0000019P0000273
+10.,10.,10.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000019P0000274
+1.,-2.010663,0.314450974,0.428417309,-2.0111089,0.31439781,      0000019P0000275
+0.428462701,-2.025041531,0.312736992,0.429880652,-2.0399682,     0000019P0000276
+0.3109695,0.431388,-2.0551008,0.3091615,0.432901,-2.0702276,     0000019P0000277
+0.3073591,0.4344198,-2.1018601,0.3035656,0.437573,-2.1352376,    0000019P0000278
+0.2994346,0.4408595,-2.1530419,0.2970886,0.442621,-2.1708463,    0000019P0000279
+0.2947485,0.4443825,-2.2276119,0.2868925,0.4500136,-2.3491699,   0000019P0000280
+0.2667464,0.4624216,-2.5192064,0.2280619,0.4765051,-2.68159585,  0000019P0000281
+0.1817274,0.4873659,-2.8443828,0.1273311,0.4954005,-2.9801719,   0000019P0000282
+6.447229E-02,0.5002233,-3.0595482,4.028084E-03,0.5014179,        0000019P0000283
+-3.0595482,0.,0.5014179,1.983431199,10.,0.115177732,             0000019P0000284
+-0.166179628,0.979345915;                                        0000019P0000285
+126,3,3,1,0,1,0,0.,0.,0.,0.,1.,1.,1.,1.,1.,1.,1.,1.,-2.010663,   0000021P0000286
+-5.551115123E-17,-0.152057631,-1.974311411,3.379513416E-16,      0000021P0000287
+-0.148765555,-1.90690583,-2.55382012E-16,-0.150360728,           0000021P0000288
+-1.8410594,0.,-0.149985705,0.,1.,-2.317290063E-15,-1.,           0000021P0000289
+2.390508681E-14;                                                 0000021P0000290
+126,80,5,1,0,1,0,0.,0.,0.,0.,0.,0.,1.294475869E-02,              0000023P0000291
+1.294475869E-02,1.294475869E-02,3.677477935E-02,3.677477935E-02, 0000023P0000292
+3.677477935E-02,6.37318215E-02,6.37318215E-02,6.37318215E-02,    0000023P0000293
+9.214808598E-02,9.214808598E-02,9.214808598E-02,0.121332981,     0000023P0000294
+0.121332981,0.121332981,0.151632798,0.151632798,0.151632798,     0000023P0000295
+0.1758443,0.1758443,0.1758443,0.210359082,0.210359082,           0000023P0000296
+0.210359082,0.246682918,0.246682918,0.246682918,0.284528737,     0000023P0000297
+0.284528737,0.284528737,0.32376227,0.32376227,0.32376227,        0000023P0000298
+0.364138741,0.364138741,0.364138741,0.405236432,0.405236432,     0000023P0000299
+0.405236432,0.436342998,0.436342998,0.436342998,0.478039961,     0000023P0000300
+0.478039961,0.478039961,0.519962761,0.519962761,0.519962761,     0000023P0000301
+0.562315329,0.562315329,0.562315329,0.605309669,0.605309669,     0000023P0000302
+0.605309669,0.649262383,0.649262383,0.649262383,0.68324956,      0000023P0000303
+0.68324956,0.68324956,0.730724691,0.730724691,0.730724691,       0000023P0000304
+0.780978326,0.780978326,0.780978326,0.83357938,0.83357938,       0000023P0000305
+0.83357938,0.887890113,0.887890113,0.887890113,0.943462915,      0000023P0000306
+0.943462915,0.943462915,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000023P0000307
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000023P0000308
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000023P0000309
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000023P0000310
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,-1.8410594,0.,-0.149985705,     0000023P0000311
+-1.8410594,1.94105762E-03,-0.149670429,-1.8410594,               0000023P0000312
+3.953147554E-03,-0.148248166,-1.8410594,5.466665102E-03,         0000023P0000313
+-0.147338218,-1.8410594,1.058378997E-02,-0.143807259,-1.8410594, 0000023P0000314
+1.542521295E-02,-0.139979952,-1.8410594,1.85248731E-02,          0000023P0000315
+-0.137431978,-1.8410594,2.498510314E-02,-0.131944386,-1.8410594, 0000023P0000316
+3.118963641E-02,-0.126371626,-1.8410594,3.441740781E-02,         0000023P0000317
+-0.123404882,-1.8410594,4.091883086E-02,-0.117297353,-1.8410594, 0000023P0000318
+4.717631203E-02,-0.111149171,-1.8410594,5.032404869E-02,         0000023P0000319
+-0.107983572,-1.8410594,5.654806627E-02,-0.101546828,-1.8410594, 0000023P0000320
+6.249240885E-02,-9.505765959E-02,-1.8410594,6.543285048E-02,     0000023P0000321
+-9.17562212E-02,-1.8410594,7.129161942E-02,-8.499829516E-02,     0000023P0000322
+-1.8410594,7.688027919E-02,-7.820730141E-02,-1.8410594,          0000023P0000323
+7.967292822E-02,-7.472859688E-02,-1.8410594,8.456058784E-02,     0000023P0000324
+-6.850485914E-02,-1.8410594,8.92175475E-02,-6.237714555E-02,     0000023P0000325
+-1.8410594,9.124278252E-02,-5.967803695E-02,-1.8410594,          0000023P0000326
+9.606883409E-02,-5.318372777E-02,-1.8410594,0.1007206,           0000023P0000327
+-4.6794132E-02,-1.8410594,0.103426012,-4.3059129E-02,-1.8410594, 0000023P0000328
+0.108916869,-3.5421098E-02,-1.8410594,0.114288681,-2.782792E-02, 0000023P0000329
+-1.8410594,0.117013504,-2.3943545E-02,-1.8410594,0.122515474,    0000023P0000330
+-1.6028865E-02,-1.8410594,0.127892135,-8.144049E-03,-1.8410594,  0000023P0000331
+0.130601597,-4.129166E-03,-1.8410594,0.136049947,4.032165E-03,   0000023P0000332
+-1.8410594,0.141354158,1.2164998E-02,-1.8410594,0.144016457,     0000023P0000333
+1.6298821E-02,-1.8410594,0.149344117,2.46803E-02,-1.8410594,     0000023P0000334
+0.154516698,3.3054873E-02,-1.8410594,0.157101182,3.730256E-02,   0000023P0000335
+-1.8410594,0.162251227,4.5889693E-02,-1.8410594,0.167271835,     0000023P0000336
+5.4512832E-02,-1.8410594,0.169774209,5.8875125E-02,-1.8410594,   0000023P0000337
+0.174119176,6.65639E-02,-1.8410594,0.178377621,7.430147E-02,     0000023P0000338
+-1.8410594,0.180196475,7.7644473E-02,-1.8410594,0.184416739,     0000023P0000339
+8.549123E-02,-1.8410594,0.188553015,9.3394207E-02,-1.8410594,    0000023P0000340
+0.190894689,9.7939813E-02,-1.8410594,0.195538041,0.107097605,    0000023P0000341
+-1.8410594,0.200068991,0.11633135,-1.8410594,0.202313678,        0000023P0000342
+0.120979443,-1.8410594,0.20678277,0.1303638,-1.8410594,          0000023P0000343
+0.211177964,0.139827597,-1.8410594,0.213372722,0.14460442,       0000023P0000344
+-1.8410594,0.21777496,0.154270896,-1.8410594,0.222153182,        0000023P0000345
+0.164020636,-1.8410594,0.224356071,0.168951466,-1.8410594,       0000023P0000346
+0.228808882,0.178952612,-1.8410594,0.233264857,0.188999438,      0000023P0000347
+-1.8410594,0.23552025,0.194087774,-1.8410594,0.23952723,         0000023P0000348
+0.203118347,-1.8410594,0.243543738,0.21214846,-1.8410594,        0000023P0000349
+0.245300683,0.216095151,-1.8410594,0.249526309,0.225579079,      0000023P0000350
+-1.8410594,0.253787059,0.235126076,-1.8410594,0.256286392,       0000023P0000351
+0.240722105,-1.8410594,0.261440945,0.252256973,-1.8410594,       0000023P0000352
+0.266606865,0.263807227,-1.8410594,0.269263041,0.269744245,      0000023P0000353
+-1.8410594,0.274700072,0.281894155,-1.8410594,0.280135776,       0000023P0000354
+0.294036749,-1.8410594,0.282915756,0.300246055,-1.8410594,       0000023P0000355
+0.288566883,0.312867097,-1.8410594,0.294218347,0.325487115,      0000023P0000356
+-1.8410594,0.297089541,0.331898334,-1.8410594,0.302898823,       0000023P0000357
+0.344869705,-1.8410594,0.30870889,0.357842223,-1.8410594,        0000023P0000358
+0.311647498,0.364403364,-1.8410594,0.317576144,0.377640396,      0000023P0000359
+-1.8410594,0.323505304,0.390878549,-1.8410594,0.32649547,        0000023P0000360
+0.397554779,-1.8410594,0.329485594,0.404230962,-1.8410594,       0000023P0000361
+0.332475514,0.410906755,0.,1.,1.,1.710477977E-15,                0000023P0000362
+3.420955954E-15;                                                 0000023P0000363
+126,3,3,0,0,1,0,0.,0.,0.,0.,1.,1.,1.,1.,1.,1.,1.,1.,-2.010663,   0000025P0000364
+0.314450974,0.428417309,-1.974311411,0.31661061,0.426463046,     0000025P0000365
+-1.90690583,0.3255725,0.417612602,-1.8410594,0.332475514,        0000025P0000366
+0.410906755,0.,1.,-6.657404889E-03,0.728061661,0.685479319;      0000025P0000367
+126,15,3,1,0,1,0,0.296616137,0.296616137,0.296616137,            0000027P0000368
+0.296616137,1.,2.,3.,4.,5.,6.,7.,7.5,7.5,7.5,8.,9.,10.,10.,10.,  0000027P0000369
+10.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,-1.8410594,  0000027P0000370
+0.,-0.149985705,-1.716900674,0.,-0.149980783,-1.462481026,0.,    0000027P0000371
+-0.15,-0.954836,0.,-0.15,-0.371762,0.,-0.15,0.190771,0.,-0.15,   0000027P0000372
+0.767805,0.,-0.15,1.337583,0.,-0.15,1.694527,0.,-0.15,1.965682,  0000027P0000373
+0.,-0.15,2.055056,0.,-0.15,2.144462,0.,-0.10152926,2.409698,0.,  0000027P0000374
+-2.76261E-02,2.727355,0.,3.35265E-02,2.915937,0.,5.81277E-02,    0000027P0000375
+3.053863,0.,7.5097E-02,0.296616137,10.,0.,-1.,0.;                0000027P0000376
+126,9,3,0,0,1,0,0.,0.,0.,0.,0.375,1.,2.,3.,4.,5.,6.,6.,6.,6.,1., 0000029P0000377
+1.,1.,1.,1.,1.,1.,1.,1.,1.,3.053863,0.,7.5097E-02,3.053846,      0000029P0000378
+1.510538E-03,7.51142E-02,3.053355,1.861274E-02,7.56295E-02,      0000029P0000379
+3.047905,9.028867E-02,7.90676E-02,3.039327,0.1539141,            0000029P0000380
+8.38246E-02,3.031894,0.2026803,8.99651E-02,3.028489,0.235317,    0000029P0000381
+0.1205908,3.036543,0.2490148,0.1675358,3.042303,0.2590907,       0000029P0000382
+0.2088356,3.059549,0.2786476,0.2962533,0.,6.,-0.97640375,        0000029P0000383
+-0.142741566,0.162051113;                                        0000029P0000384
+126,15,3,0,0,1,0,0.296749084,0.296749084,0.296749084,            0000031P0000385
+0.296749084,1.,2.,3.,4.,5.,6.,7.,7.5,7.5,7.5,8.,9.,10.,10.,10.,  0000031P0000386
+10.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,-1.8410594,  0000031P0000387
+0.332475514,0.410906755,-1.71692972,0.34597113,0.397746596,      0000031P0000388
+-1.462518655,0.36921918,0.375061351,-0.954904,0.3960858,         0000031P0000389
+0.3417409,-0.371823,0.4105961,0.3148146,0.190709,0.4154309,      0000031P0000390
+0.2911115,0.767748,0.4097893,0.271034,1.337529,0.4045711,        0000031P0000391
+0.2586131,1.694481,0.3921263,0.2552858,1.965624,0.3783256,       0000031P0000392
+0.2581369,2.055021,0.3733477,0.2594849,2.144419,0.3683698,       0000031P0000393
+0.2608272,2.409665,0.3523032,0.2660468,2.727324,0.3247703,       0000031P0000394
+0.2785133,2.91591,0.299383,0.2890105,3.059549,0.2786476,         0000031P0000395
+0.2962533,0.296749084,10.,2.56866501E-02,0.571434205,            0000031P0000396
+0.820245784;                                                     0000031P0000397
+126,312,8,1,0,1,0,0.,0.,0.,0.,0.,0.,0.,0.,0.,8.516307792E-02,    0000033P0000398
+8.516307792E-02,8.516307792E-02,8.516307792E-02,8.516307792E-02, 0000033P0000399
+8.516307792E-02,8.516307792E-02,8.516307792E-02,0.170326155,     0000033P0000400
+0.170326155,0.170326155,0.170326155,0.170326155,0.170326155,     0000033P0000401
+0.170326155,0.170326155,0.227101539,0.227101539,0.227101539,     0000033P0000402
+0.227101539,0.227101539,0.227101539,0.227101539,0.227101539,     0000033P0000403
+0.259544616,0.259544616,0.259544616,0.259544616,0.259544616,     0000033P0000404
+0.259544616,0.259544616,0.259544616,0.296622419,0.296622419,     0000033P0000405
+0.296622419,0.296622419,0.296622419,0.296622419,0.296622419,     0000033P0000406
+0.296622419,0.306190884,0.306190884,0.306190884,0.306190884,     0000033P0000407
+0.306190884,0.306190884,0.306190884,0.306190884,0.316068009,     0000033P0000408
+0.316068009,0.316068009,0.316068009,0.316068009,0.316068009,     0000033P0000409
+0.316068009,0.316068009,0.337139209,0.337139209,0.337139209,     0000033P0000410
+0.337139209,0.337139209,0.337139209,0.337139209,0.337139209,     0000033P0000411
+0.359615157,0.359615157,0.359615157,0.359615157,0.359615157,     0000033P0000412
+0.359615157,0.359615157,0.359615157,0.3835895,0.3835895,         0000033P0000413
+0.3835895,0.3835895,0.3835895,0.3835895,0.3835895,0.3835895,     0000033P0000414
+0.409162134,0.409162134,0.409162134,0.409162134,0.409162134,     0000033P0000415
+0.409162134,0.409162134,0.409162134,0.436439609,0.436439609,     0000033P0000416
+0.436439609,0.436439609,0.436439609,0.436439609,0.436439609,     0000033P0000417
+0.436439609,0.450518306,0.450518306,0.450518306,0.450518306,     0000033P0000418
+0.450518306,0.450518306,0.450518306,0.450518306,0.514878064,     0000033P0000419
+0.514878064,0.514878064,0.514878064,0.514878064,0.514878064,     0000033P0000420
+0.514878064,0.514878064,0.549203268,0.549203268,0.549203268,     0000033P0000421
+0.549203268,0.549203268,0.549203268,0.549203268,0.549203268,     0000033P0000422
+0.566919503,0.566919503,0.566919503,0.566919503,0.566919503,     0000033P0000423
+0.566919503,0.566919503,0.566919503,0.585207229,0.585207229,     0000033P0000424
+0.585207229,0.585207229,0.585207229,0.585207229,0.585207229,     0000033P0000425
+0.585207229,0.624221044,0.624221044,0.624221044,0.624221044,     0000033P0000426
+0.624221044,0.624221044,0.624221044,0.624221044,0.644357206,     0000033P0000427
+0.644357206,0.644357206,0.644357206,0.644357206,0.644357206,     0000033P0000428
+0.644357206,0.644357206,0.665142923,0.665142923,0.665142923,     0000033P0000429
+0.665142923,0.665142923,0.665142923,0.665142923,0.665142923,     0000033P0000430
+0.675700747,0.675700747,0.675700747,0.675700747,0.675700747,     0000033P0000431
+0.675700747,0.675700747,0.675700747,0.686426156,0.686426156,     0000033P0000432
+0.686426156,0.686426156,0.686426156,0.686426156,0.686426156,     0000033P0000433
+0.686426156,0.708568935,0.708568935,0.708568935,0.708568935,     0000033P0000434
+0.708568935,0.708568935,0.708568935,0.708568935,0.731425997,     0000033P0000435
+0.731425997,0.731425997,0.731425997,0.731425997,0.731425997,     0000033P0000436
+0.731425997,0.731425997,0.755020384,0.755020384,0.755020384,     0000033P0000437
+0.755020384,0.755020384,0.755020384,0.755020384,0.755020384,     0000033P0000438
+0.760965426,0.760965426,0.760965426,0.760965426,0.760965426,     0000033P0000439
+0.760965426,0.760965426,0.760965426,0.785512698,0.785512698,     0000033P0000440
+0.785512698,0.785512698,0.785512698,0.785512698,0.785512698,     0000033P0000441
+0.785512698,0.797981154,0.797981154,0.797981154,0.797981154,     0000033P0000442
+0.797981154,0.797981154,0.797981154,0.797981154,0.823722481,     0000033P0000443
+0.823722481,0.823722481,0.823722481,0.823722481,0.823722481,     0000033P0000444
+0.823722481,0.823722481,0.826952766,0.826952766,0.826952766,     0000033P0000445
+0.826952766,0.826952766,0.826952766,0.826952766,0.826952766,     0000033P0000446
+0.833464205,0.833464205,0.833464205,0.833464205,0.833464205,     0000033P0000447
+0.833464205,0.833464205,0.833464205,0.846693795,0.846693795,     0000033P0000448
+0.846693795,0.846693795,0.846693795,0.846693795,0.846693795,     0000033P0000449
+0.846693795,0.853360675,0.853360675,0.853360675,0.853360675,     0000033P0000450
+0.853360675,0.853360675,0.853360675,0.853360675,0.866906083,     0000033P0000451
+0.866906083,0.866906083,0.866906083,0.866906083,0.866906083,     0000033P0000452
+0.866906083,0.866906083,0.870305715,0.870305715,0.870305715,     0000033P0000453
+0.870305715,0.870305715,0.870305715,0.870305715,0.870305715,     0000033P0000454
+0.994635102,0.994635102,0.994635102,0.994635102,0.994635102,     0000033P0000455
+0.994635102,0.994635102,0.994635102,0.995607375,0.995607375,     0000033P0000456
+0.995607375,0.995607375,0.995607375,0.995607375,0.995607375,     0000033P0000457
+0.995607375,0.999511718,0.999511718,0.999511718,0.999511718,     0000033P0000458
+0.999511718,0.999511718,0.999511718,0.999511718,1.,1.,1.,1.,1.,  0000033P0000459
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000033P0000460
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000033P0000461
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000033P0000462
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000033P0000463
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000033P0000464
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000033P0000465
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000033P0000466
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000033P0000467
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000033P0000468
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000033P0000469
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000033P0000470
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000033P0000471
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000033P0000472
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000033P0000473
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000033P0000474
+1.,1.,1.983431198,10.999999998,0.,1.984239761,10.980949557,0.,   0000033P0000475
+1.985055869,10.961335918,0.,1.985879815,10.94111261,0.,          0000033P0000476
+1.986711913,10.920228083,0.,1.987552497,10.898623092,0.,         0000033P0000477
+1.98840192,10.876228074,0.,1.989260547,10.852960527,0.,          0000033P0000478
+1.990128755,10.828722388,0.,1.990996967,10.804484071,0.,         0000033P0000479
+1.991874745,10.779275206,0.,1.992762521,10.752995452,0.,         0000033P0000480
+1.993660679,10.725528191,0.,1.994569596,10.696736577,0.,         0000033P0000481
+1.995489774,10.666451536,0.,1.996421846,10.634460177,0.,         0000033P0000482
+1.997366229,10.600503086,0.,1.997995822,10.577864908,0.,         0000033P0000483
+1.998630919,10.554351929,0.,1.999271649,10.529886582,0.,         0000033P0000484
+1.99991834,10.504374634,0.,2.000570641,10.477728763,0.,          0000033P0000485
+2.001229385,10.449817468,0.,2.001893615,10.420543263,0.,         0000033P0000486
+2.002563803,10.389765756,0.,2.002946762,10.372178802,0.,         0000033P0000487
+2.003331639,10.354101413,0.,2.003718407,10.335510738,0.,         0000033P0000488
+2.00410702,10.316383231,0.,2.004497414,10.296696507,0.,          0000033P0000489
+2.004889508,10.276431198,0.,2.005283204,10.255572817,0.,         0000033P0000490
+2.005678388,10.234113617,0.,2.00613004,10.209588818,0.,          0000033P0000491
+2.006583525,10.184280468,0.,2.007038973,10.158176055,0.,         0000033P0000492
+2.007496196,10.131278482,0.,2.007952471,10.103629097,0.,         0000033P0000493
+2.008411397,10.075250463,0.,2.008870947,10.046243496,0.,         0000033P0000494
+2.009330215,10.016732675,0.,2.009448733,10.009116986,0.,         0000033P0000495
+2.009567213,10.001468179,0.,2.0096857,9.993785556,0.,            0000033P0000496
+2.009803887,9.986082806,0.,2.009922268,9.978340462,0.,           0000033P0000497
+2.010040498,9.970573418,0.,2.010158793,9.962773369,0.,           0000033P0000498
+2.010277097,9.954942907,0.,2.01039922,9.946859787,0.,            0000033P0000499
+2.010521364,9.938743722,0.,2.010643547,9.93059447,0.,            0000033P0000500
+2.010765773,9.92241189,0.,2.010888037,9.914195943,0.,            0000033P0000501
+2.011010325,9.905946692,0.,2.011132608,9.897664301,0.,           0000033P0000502
+2.011254851,9.889349036,0.,2.011515635,9.871609745,0.,           0000033P0000503
+2.01177614,9.853721796,0.,2.012036498,9.835683479,0.,            0000033P0000504
+2.012296796,9.817494013,0.,2.012557079,9.799153554,0.,           0000033P0000505
+2.012817345,9.780663189,0.,2.013077552,9.762024938,0.,           0000033P0000506
+2.013337612,9.743241754,0.,2.013615012,9.723206388,0.,           0000033P0000507
+2.013892316,9.703005814,0.,2.014169365,9.68264438,0.,2.01444617, 0000033P0000508
+9.662125722,0.,2.014722763,9.641455413,0.,2.014999124,           0000033P0000509
+9.620641256,0.,2.015275179,9.599691231,0.,2.015550874,           0000033P0000510
+9.578609086,0.,2.015844955,9.556121517,0.,2.016138657,           0000033P0000511
+9.53348401,0.,2.016431969,9.510702805,0.,2.016724922,            0000033P0000512
+9.487782881,0.,2.017017576,9.464728446,0.,2.017310008,           0000033P0000513
+9.441543434,0.,2.017602294,9.418231991,0.,2.017894501,           0000033P0000514
+9.394798975,0.,2.018206182,9.369803695,0.,2.018517785,           0000033P0000515
+9.344670595,0.,2.018829412,9.319403822,0.,2.019140967,           0000033P0000516
+9.294012557,0.,2.019452517,9.268506214,0.,2.019764366,           0000033P0000517
+9.242892519,0.,2.020076824,9.217178435,0.,2.020389673,           0000033P0000518
+9.191373965,0.,2.020723403,9.163849185,0.,2.021057661,           0000033P0000519
+9.136220573,0.,2.021392708,9.108502014,0.,2.021728027,           0000033P0000520
+9.080694383,0.,2.022064986,9.052832337,0.,2.02240181,            0000033P0000521
+9.024893084,0.,2.022741238,8.996932592,0.,2.023081799,           0000033P0000522
+8.968928405,0.,2.023257582,8.954474807,0.,2.023433699,           0000033P0000523
+8.940010385,0.,2.023610182,8.925535466,0.,2.023787062,           0000033P0000524
+8.911050379,0.,2.023964372,8.896555453,0.,2.024142145,           0000033P0000525
+8.882051015,0.,2.024320413,8.867537393,0.,2.024499207,           0000033P0000526
+8.853014917,0.,2.025316517,8.786626368,0.,2.026144673,           0000033P0000527
+8.720052423,0.,2.026986203,8.653323171,0.,2.027841491,           0000033P0000528
+8.586463654,0.,2.02871436,8.519512223,0.,2.029608015,            0000033P0000529
+8.452511908,0.,2.030521909,8.385500032,0.,2.031460064,           0000033P0000530
+8.318521268,0.,2.03196038,8.28279932,0.,2.032467484,8.247085811, 0000033P0000531
+0.,2.032982203,8.211389961,0.,2.033504066,8.17571571,0.,         0000033P0000532
+2.034033132,8.140064498,0.,2.034570488,8.104437115,0.,           0000033P0000533
+2.035117402,8.068834639,0.,2.035673156,8.03325845,0.,            0000033P0000534
+2.035960004,8.014896741,0.,2.036249353,7.996540641,0.,           0000033P0000535
+2.036540862,7.978195581,0.,2.036834779,7.959856222,0.,           0000033P0000536
+2.037131438,7.941517524,0.,2.037430827,7.923176816,0.,           0000033P0000537
+2.037732608,7.904831636,0.,2.03803699,7.886478127,0.,            0000033P0000538
+2.038351187,7.867532619,0.,2.038668107,7.848578451,0.,           0000033P0000539
+2.038987765,7.829612197,0.,2.039310182,7.810630377,0.,           0000033P0000540
+2.03963538,7.791629457,0.,2.039963388,7.772605852,0.,            0000033P0000541
+2.040294239,7.75355592,0.,2.040627968,7.734475966,0.,            0000033P0000542
+2.041339901,7.693772116,0.,2.042065016,7.652931214,0.,           0000033P0000543
+2.042803537,7.611917448,0.,2.043555817,7.57069243,0.,2.04432234, 0000033P0000544
+7.529214466,0.,2.045103728,7.487437821,0.,2.045900751,           0000033P0000545
+7.445311995,0.,2.046714329,7.402780986,0.,2.047134242,           0000033P0000546
+7.380829428,0.,2.047558487,7.358770448,0.,2.04798735,            0000033P0000547
+7.336594957,0.,2.048420786,7.314296127,0.,2.04885883,            0000033P0000548
+7.291866066,0.,2.049301739,7.269294569,0.,2.049749877,           0000033P0000549
+7.246569973,0.,2.050203343,7.223682109,0.,2.050671436,           0000033P0000550
+7.200055919,0.,2.051145218,7.176255733,0.,2.051624881,           0000033P0000551
+7.152269558,0.,2.052110591,7.12808507,0.,2.052602533,            0000033P0000552
+7.103688945,0.,2.053100947,7.079066185,0.,2.053606168,           0000033P0000553
+7.05419944,0.,2.05411867,7.029068342,0.,2.054378989,7.016303367, 0000033P0000554
+0.,2.054641168,7.003469673,0.,2.054905394,6.990567981,0.,        0000033P0000555
+2.0551713,6.977583519,0.,2.055439763,6.964534522,0.,2.055710452, 0000033P0000556
+6.951406354,0.,2.055983861,6.938205931,0.,2.056260137,           0000033P0000557
+6.924930307,0.,2.056540821,6.911444062,0.,2.056824446,           0000033P0000558
+6.897880621,0.,2.057111295,6.884239407,0.,2.057401653,           0000033P0000559
+6.87051984,0.,2.057695804,6.856721341,0.,2.057994031,            0000033P0000560
+6.842843333,0.,2.058296619,6.828885237,0.,2.058603851,           0000033P0000561
+6.814846474,0.,2.059238173,6.785863293,0.,2.059892477,           0000033P0000562
+6.756536938,0.,2.060569494,6.726862904,0.,2.061272233,           0000033P0000563
+6.696837644,0.,2.062003984,6.666458567,0.,2.062768318,           0000033P0000564
+6.635724041,0.,2.063569082,6.604633392,0.,2.064410408,           0000033P0000565
+6.573186902,0.,2.065278904,6.540725963,0.,2.066190591,6.5078865, 0000033P0000566
+0.,2.067150126,6.474668219,0.,2.068162484,6.441073231,0.,        0000033P0000567
+2.069232962,6.407106049,0.,2.070367174,6.372773589,0.,           0000033P0000568
+2.071571058,6.338085169,0.,2.072850869,6.303052512,0.,           0000033P0000569
+2.074171939,6.266889902,0.,2.075573948,6.230360304,0.,           0000033P0000570
+2.077063446,6.19347863,0.,2.078648047,6.156258644,0.,            0000033P0000571
+2.080334801,6.118722383,0.,2.082131124,6.08089451,0.,            0000033P0000572
+2.084045402,6.042798064,0.,2.086084429,6.004468098,0.,           0000033P0000573
+2.086598181,5.994810133,0.,2.087119881,5.985137851,0.,           0000033P0000574
+2.087649489,5.975450784,0.,2.088186969,5.965748459,0.,           0000033P0000575
+2.088732283,5.956030407,0.,2.089285392,5.946296157,0.,           0000033P0000576
+2.089846259,5.936545239,0.,2.090414847,5.926777183,0.,           0000033P0000577
+2.092762564,5.886444393,0.,2.095241888,5.845819299,0.,           0000033P0000578
+2.097850175,5.80486631,0.,2.100584782,5.763548375,0.,            0000033P0000579
+2.103443131,5.721824703,0.,2.106422769,5.679648479,0.,           0000033P0000580
+2.109521433,5.636964582,0.,2.112737111,5.593707303,0.,           0000033P0000581
+2.11437048,5.571735231,0.,2.116034006,5.549615468,0.,            0000033P0000582
+2.117727522,5.527338289,0.,2.119450763,5.504894408,0.,           0000033P0000583
+2.121203412,5.482274285,0.,2.122985145,5.459467439,0.,           0000033P0000584
+2.124795681,5.436461755,0.,2.126634825,5.413242798,0.,           0000033P0000585
+2.130431756,5.365306965,0.,2.134350486,5.316463793,0.,           0000033P0000586
+2.138388831,5.266589867,0.,2.142544404,5.215541767,0.,           0000033P0000587
+2.146814514,5.163135359,0.,2.15119473,5.109154538,0.,            0000033P0000588
+2.155677975,5.053322892,0.,2.160255935,4.995171767,0.,           0000033P0000589
+2.160830434,4.987874404,0.,2.161406401,4.980541279,0.,           0000033P0000590
+2.161983857,4.973172191,0.,2.162562822,4.965766941,0.,           0000033P0000591
+2.163143319,4.958325329,0.,2.163725366,4.950847154,0.,           0000033P0000592
+2.164308986,4.943332216,0.,2.1648942,4.935780315,0.,2.166073846, 0000033P0000593
+4.920557578,0.,2.167259972,4.905184733,0.,2.168452757,           0000033P0000594
+4.889660236,0.,2.169652377,4.873982759,0.,2.170859011,           0000033P0000595
+4.858151192,0.,2.172072839,4.842164642,0.,2.173294042,           0000033P0000596
+4.826022432,0.,2.174522802,4.809724104,0.,2.17701933,            0000033P0000597
+4.776610035,0.,2.179547051,4.742851778,0.,2.182107486,           0000033P0000598
+4.708445723,0.,2.184702175,4.673393135,0.,2.187332641,           0000033P0000599
+4.637701151,0.,2.190000361,4.601383791,0.,2.192706738,           0000033P0000600
+4.564462963,0.,2.195453066,4.526969466,0.,2.196837055,           0000033P0000601
+4.50807492,0.,2.19823111,4.489036014,0.,2.199635679,4.469852715, 0000033P0000602
+0.,2.201050659,4.450533095,0.,2.202475917,4.43108612,0.,         0000033P0000603
+2.203911519,4.411518341,0.,2.205357687,4.391834486,0.,           0000033P0000604
+2.206814475,4.372041949,0.,2.209774303,4.331828494,0.,           0000033P0000605
+2.212778096,4.291164565,0.,2.215826947,4.250103437,0.,           0000033P0000606
+2.218922543,4.208694744,0.,2.22206608,4.166999273,0.,            0000033P0000607
+2.225257285,4.125099511,0.,2.228493528,4.083105959,0.,           0000033P0000608
+2.231769062,4.041159195,0.,2.232591154,4.030631439,0.,           0000033P0000609
+2.233415764,4.020105744,0.,2.234242548,4.00958967,0.,            0000033P0000610
+2.235072246,3.99906767,0.,2.235903005,3.988579271,0.,            0000033P0000611
+2.236736759,3.978082853,0.,2.237572614,3.967597442,0.,           0000033P0000612
+2.238410965,3.957114247,0.,2.268686384,3.586585898,0.,           0000033P0000613
+2.306476754,3.097603196,0.,2.327287014,3.075685891,0.,           0000033P0000614
+2.399342021,1.942197312,0.,2.359616172,2.143616437,0.,           0000033P0000615
+2.445786875,1.323805042,0.,2.478905511,0.768445753,0.,           0000033P0000616
+2.52286648,0.197888699,0.,2.523203055,0.193405813,0.,2.52353963, 0000033P0000617
+0.188922927,0.,2.523876204,0.184440041,0.,2.524212779,           0000033P0000618
+0.179957155,0.,2.524549354,0.175474269,0.,2.524885928,           0000033P0000619
+0.170991382,0.,2.525222503,0.166508496,0.,2.525559078,           0000033P0000620
+0.16202561,0.,2.526910656,0.144023746,0.,2.528262234,            0000033P0000621
+0.126021881,0.,2.529613813,0.108020017,0.,2.530965391,           0000033P0000622
+9.001815282E-02,0.,2.532316969,7.201628848E-02,0.,2.533668548,   0000033P0000623
+5.401442415E-02,0.,2.535020126,3.601255982E-02,0.,2.536371704,   0000033P0000624
+1.801069549E-02,0.,2.536539497,1.58040887E-02,0.,2.536718137,    0000033P0000625
+1.320519093E-02,0.,2.53685457,1.213278926E-02,0.,2.537086413,    0000033P0000626
+7.609639345E-03,0.,2.53718069,8.061970397E-03,0.,2.537405247,    0000033P0000627
+3.802333079E-03,0.,2.537550024,2.428190827E-03,0.,2.53772394,    0000033P0000628
+1.401645235E-07,0.,0.,1.,0.,0.,1.;                               0000033P0000629
+110,2.537723945,0.,0.,10.,0.,0.;                                 0000035P0000630
+110,10.,0.,0.,10.,11.,0.;                                        0000037P0000631
+110,10.,11.,0.,1.983431199,11.,0.;                               0000039P0000632
+510,43,1,1,45;                                                   0000041P0000633
+128,3,80,3,5,0,0,1,0,0,0.,0.,0.,0.,1.,1.,1.,1.,0.,0.,0.,0.,0.,   0000043P0000634
+0.,1.294475869E-02,1.294475869E-02,1.294475869E-02,              0000043P0000635
+3.677477935E-02,3.677477935E-02,3.677477935E-02,6.37318215E-02,  0000043P0000636
+6.37318215E-02,6.37318215E-02,9.214808598E-02,9.214808598E-02,   0000043P0000637
+9.214808598E-02,0.121332981,0.121332981,0.121332981,0.151632798, 0000043P0000638
+0.151632798,0.151632798,0.1758443,0.1758443,0.1758443,           0000043P0000639
+0.210359082,0.210359082,0.210359082,0.246682918,0.246682918,     0000043P0000640
+0.246682918,0.284528737,0.284528737,0.284528737,0.32376227,      0000043P0000641
+0.32376227,0.32376227,0.364138741,0.364138741,0.364138741,       0000043P0000642
+0.405236432,0.405236432,0.405236432,0.436342998,0.436342998,     0000043P0000643
+0.436342998,0.478039961,0.478039961,0.478039961,0.519962761,     0000043P0000644
+0.519962761,0.519962761,0.562315329,0.562315329,0.562315329,     0000043P0000645
+0.605309669,0.605309669,0.605309669,0.649262383,0.649262383,     0000043P0000646
+0.649262383,0.68324956,0.68324956,0.68324956,0.730724691,        0000043P0000647
+0.730724691,0.730724691,0.780978326,0.780978326,0.780978326,     0000043P0000648
+0.83357938,0.83357938,0.83357938,0.887890113,0.887890113,        0000043P0000649
+0.887890113,0.943462915,0.943462915,0.943462915,1.,1.,1.,1.,1.,  0000043P0000650
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000043P0000651
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000043P0000652
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000043P0000653
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000043P0000654
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000043P0000655
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000043P0000656
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000043P0000657
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000043P0000658
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000043P0000659
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000043P0000660
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000043P0000661
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000043P0000662
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000043P0000663
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000043P0000664
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000043P0000665
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,-2.010663,-5.551115123E-17,        0000043P0000666
+-0.152057631,-1.974311411,3.379513416E-16,-0.148765555,          0000043P0000667
+-1.90690583,-2.55382012E-16,-0.150360728,-1.8410594,0.,          0000043P0000668
+-0.149985705,-2.010663,2.192562401E-03,-0.150991702,             0000043P0000669
+-1.974311411,1.619049172E-03,-0.148878561,-1.90690583,           0000043P0000670
+1.965241651E-03,-0.149907151,-1.8410594,1.94105762E-03,          0000043P0000671
+-0.149670429,-2.010663,2.470301091E-04,-0.152631099,             0000043P0000672
+-1.974311411,5.546741602E-03,-0.145259846,-1.90690583,           0000043P0000673
+3.2176678E-03,-0.149020153,-1.8410594,3.953147554E-03,           0000043P0000674
+-0.148248166,-2.010663,3.029158552E-03,-0.149674216,             0000043P0000675
+-1.974311411,6.02978599E-03,-0.145365907,-1.90690583,            0000043P0000676
+4.932647609E-03,-0.147724612,-1.8410594,5.466665102E-03,         0000043P0000677
+-0.147338218,-2.010663,3.365191399E-03,-0.14822999,-1.974311411, 0000043P0000678
+1.299002734E-02,-0.139674167,-1.90690583,9.083787559E-03,        0000043P0000679
+-0.144515117,-1.8410594,1.058378997E-02,-0.143807259,-2.010663,  0000043P0000680
+5.118457775E-03,-0.146908691,-1.974311411,1.870902151E-02,       0000043P0000681
+-0.133403766,-1.90690583,1.326527503E-02,-0.14106994,-1.8410594, 0000043P0000682
+1.542521295E-02,-0.139979952,-2.010663,5.873359039E-03,          0000043P0000683
+-0.145955269,-1.974311411,2.259150365E-02,-0.129297962,          0000043P0000684
+-1.90690583,1.587413351E-02,-0.138762115,-1.8410594,             0000043P0000685
+1.85248731E-02,-0.137431978,-2.010663,7.654583196E-03,           0000043P0000686
+-0.144053896,-1.974311411,3.055282177E-02,-0.12039078,           0000043P0000687
+-1.90690583,2.134691379E-02,-0.133815458,-1.8410594,             0000043P0000688
+2.498510314E-02,-0.131944386,-2.010663,9.260894273E-03,          0000043P0000689
+-0.142222174,-1.974311411,3.824294372E-02,-0.111355863,          0000043P0000690
+-1.90690583,2.657709196E-02,-0.128805692,-1.8410594,             0000043P0000691
+3.118963641E-02,-0.126371626,-2.010663,1.010271957E-02,          0000043P0000692
+-0.141272708,-1.974311411,4.223531436E-02,-0.106546377,          0000043P0000693
+-1.90690583,2.929812855E-02,-0.126141901,-1.8410594,             0000043P0000694
+3.441740781E-02,-0.123404882,-2.010663,1.181875623E-02,          0000043P0000695
+-0.139358061,-1.974311411,5.024062927E-02,-9.6669594E-02,        0000043P0000696
+-1.90690583,3.477589553E-02,-0.120664532,-1.8410594,             0000043P0000697
+4.091883086E-02,-0.117297353,-2.010663,1.366229627E-02,          0000043P0000698
+-0.137383774,-1.974311411,5.77928136E-02,-8.684226892E-02,       0000043P0000699
+-1.90690583,4.007508586E-02,-0.115137553,-1.8410594,             0000043P0000700
+4.717631203E-02,-0.111149171,-2.010663,1.466167086E-02,          0000043P0000701
+-0.136322917,-1.974311411,6.151378983E-02,-8.185559209E-02,      0000043P0000702
+-1.90690583,4.274805686E-02,-0.112283085,-1.8410594,             0000043P0000703
+5.032404869E-02,-0.107983572,-2.010663,1.683693655E-02,          0000043P0000704
+-0.134021987,-1.974311411,6.876776868E-02,-7.182285773E-02,      0000043P0000705
+-1.90690583,4.806031994E-02,-0.106454887,-1.8410594,             0000043P0000706
+5.654806627E-02,-0.101546828,-2.010663,1.927946131E-02,          0000043P0000707
+-0.131406427,-1.974311411,7.546311645E-02,-6.196024984E-02,      0000043P0000708
+-1.90690583,5.318997368E-02,-0.100523708,-1.8410594,             0000043P0000709
+6.249240885E-02,-9.505765959E-02,-2.010663,2.055775019E-02,      0000043P0000710
+-0.130017481,-1.974311411,7.873262251E-02,-5.699277017E-02,      0000043P0000711
+-1.90690583,5.573634636E-02,-9.749640361E-02,-1.8410594,         0000043P0000712
+6.543285048E-02,-9.17562212E-02,-2.010663,2.317581602E-02,       0000043P0000713
+-0.12712326,-1.974311411,8.520357137E-02,-4.6882515E-02,         0000043P0000714
+-1.90690583,6.08194654E-02,-9.129058222E-02,-1.8410594,          0000043P0000715
+7.129161942E-02,-8.499829516E-02,-2.010663,2.577881373E-02,      0000043P0000716
+-0.124119062,-1.974311411,9.131874852E-02,-3.6820894E-02,        0000043P0000717
+-1.90690583,6.568065618E-02,-8.504079699E-02,-1.8410594,         0000043P0000718
+7.688027919E-02,-7.820730141E-02,-2.010663,2.700662073E-02,      0000043P0000719
+-0.122665714,-1.974311411,9.44204127E-02,-3.1622972E-02,         0000043P0000720
+-1.90690583,6.809584923E-02,-8.185589113E-02,-1.8410594,         0000043P0000721
+7.967292822E-02,-7.472859688E-02,-2.010663,2.933857512E-02,      0000043P0000722
+-0.119793233,-1.974311411,9.974708407E-02,-2.2492018E-02,        0000043P0000723
+-1.90690583,7.235643764E-02,-7.611143423E-02,-1.8410594,         0000043P0000724
+8.456058784E-02,-6.850485914E-02,-2.010663,3.198439543E-02,      0000043P0000725
+-0.116381303,-1.974311411,0.104579552,-1.3852311E-02,            0000043P0000726
+-1.90690583,7.649523602E-02,-7.035513098E-02,-1.8410594,         0000043P0000727
+8.92175475E-02,-6.237714555E-02,-2.010663,3.324359497E-02,       0000043P0000728
+-0.114736043,-1.974311411,0.10662022,-1.0130218E-02,-1.90690583, 0000043P0000729
+7.83162388E-02,-6.779504568E-02,-1.8410594,9.124278252E-02,      0000043P0000730
+-5.967803695E-02,-2.010663,3.649498241E-02,-0.110454568,         0000043P0000731
+-1.974311411,0.111331994,-1.362956E-03,-1.90690583,              0000043P0000732
+8.270262585E-02,-6.157928775E-02,-1.8410594,9.606883409E-02,     0000043P0000733
+-5.318372777E-02,-2.010663,4.020176937E-02,-0.105529255,         0000043P0000734
+-1.974311411,0.11555355,6.859463E-03,-1.90690583,                0000043P0000735
+8.704341603E-02,-5.534237878E-02,-1.8410594,0.1007206,           0000043P0000736
+-4.6794132E-02,-2.010663,4.245514765E-02,-0.102481673,           0000043P0000737
+-1.974311411,0.117933879,1.157127E-02,-1.90690583,               0000043P0000738
+8.959363538E-02,-5.166684727E-02,-1.8410594,0.103426012,         0000043P0000739
+-4.3059129E-02,-2.010663,4.719737423E-02,-9.593294872E-02,       0000043P0000740
+-1.974311411,0.122647085,2.1023064E-02,-1.90690583,              0000043P0000741
+9.478997887E-02,-4.4096449E-02,-1.8410594,0.108916869,           0000043P0000742
+-3.5421098E-02,-2.010663,5.208215231E-02,-8.88424219E-02,        0000043P0000743
+-1.974311411,0.127087526,3.0081826E-02,-1.90690583,              0000043P0000744
+9.992362923E-02,-3.6469226E-02,-1.8410594,0.114288681,           0000043P0000745
+-2.782792E-02,-2.010663,5.460381E-02,-8.507750011E-02,           0000043P0000746
+-1.974311411,0.129307965,3.463375E-02,-1.90690583,0.102534006,   0000043P0000747
+-3.2543443E-02,-1.8410594,0.117013504,-2.3943545E-02,-2.010663,  0000043P0000748
+5.974289917E-02,-7.713985772E-02,-1.974311411,0.133757764,       0000043P0000749
+4.3747821E-02,-1.90690583,0.107815552,-2.4497293E-02,-1.8410594, 0000043P0000750
+0.122515474,-1.6028865E-02,-2.010663,6.481581795E-02,            0000043P0000751
+-6.871139627E-02,-1.974311411,0.138067777,5.2505952E-02,         0000043P0000752
+-1.90690583,0.112984255,-1.6389122E-02,-1.8410594,0.127892135,   0000043P0000753
+-8.144049E-03,-2.010663,6.739620648E-02,-6.429056883E-02,        0000043P0000754
+-1.974311411,0.140224933,5.6884381E-02,-1.90690583,0.115593135,  0000043P0000755
+-1.2237462E-02,-1.8410594,0.130601597,-4.129166E-03,-2.010663,   0000043P0000756
+7.264475388E-02,-5.50632489E-02,-1.974311411,0.144529356,        0000043P0000757
+6.5629024E-02,-1.90690583,0.12084852,-3.75469E-03,-1.8410594,    0000043P0000758
+0.136049947,4.032165E-03,-2.010663,7.790443011E-02,              0000043P0000759
+-4.5424964E-02,-1.974311411,0.148638781,7.4050375E-02,           0000043P0000760
+-1.90690583,0.125988929,4.778376E-03,-1.8410594,0.141354158,     0000043P0000761
+1.2164998E-02,-2.010663,8.059095806E-02,-4.0423136E-02,          0000043P0000762
+-1.974311411,0.150679262,7.8260004E-02,-1.90690583,0.128576489,  0000043P0000763
+9.134522E-03,-1.8410594,0.144016457,1.6298821E-02,-2.010663,     0000043P0000764
+8.606806939E-02,-3.0103057E-02,-1.974311411,0.154705763,         0000043P0000765
+8.6670252E-02,-1.90690583,0.133771161,1.7998931E-02,-1.8410594,  0000043P0000766
+0.149344117,2.46803E-02,-2.010663,9.161316932E-02,               0000043P0000767
+-1.9467868E-02,-1.974311411,0.158525423,9.4826812E-02,           0000043P0000768
+-1.90690583,0.13884714,2.6917274E-02,-1.8410594,0.154516698,     0000043P0000769
+3.3054873E-02,-2.010663,9.444582827E-02,-1.4004167E-02,          0000043P0000770
+-1.974311411,0.160411647,9.8906673E-02,-1.90690583,0.1413959,    0000043P0000771
+3.14531E-02,-1.8410594,0.157101182,3.730256E-02,-2.010663,       0000043P0000772
+0.100168309,-2.879354E-03,-1.974311411,0.164155512,0.107071468,  0000043P0000773
+-1.90690583,0.146486258,4.0637168E-02,-1.8410594,0.162251227,    0000043P0000774
+4.5889693E-02,-2.010663,0.105899822,8.425014E-03,-1.974311411,   0000043P0000775
+0.167787468,0.115111879,-1.90690583,0.151477125,4.9881742E-02,   0000043P0000776
+-1.8410594,0.167271835,5.4512832E-02,-2.010663,0.108786628,      0000043P0000777
+1.4163351E-02,-1.974311411,0.169600463,0.11914576,-1.90690583,   0000043P0000778
+0.153970176,5.4561303E-02,-1.8410594,0.169774209,5.8875125E-02,  0000043P0000779
+-2.010663,0.113846214,2.4300656E-02,-1.974311411,0.172760621,    0000043P0000780
+0.12620004,-1.90690583,0.158308823,6.2811401E-02,-1.8410594,     0000043P0000781
+0.174119176,6.65639E-02,-2.010663,0.118870191,3.4520839E-02,     0000043P0000782
+-1.974311411,0.175896143,0.13320976,-1.90690583,0.162575956,     0000043P0000783
+7.1113263E-02,-1.8410594,0.178377621,7.430147E-02,-2.010663,     0000043P0000784
+0.121026173,3.8937164E-02,-1.974311411,0.177244674,0.136222355,  0000043P0000785
+-1.90690583,0.164400914,7.4699096E-02,-1.8410594,0.180196475,    0000043P0000786
+7.7644473E-02,-2.010663,0.126048143,4.9299837E-02,-1.974311411,  0000043P0000787
+0.180400625,0.143259313,-1.90690583,0.168641715,8.3113576E-02,   0000043P0000788
+-1.8410594,0.184416739,8.549123E-02,-2.010663,0.131002538,       0000043P0000789
+5.9715297E-02,-1.974311411,0.18356894,0.150266588,-1.90690583,   0000043P0000790
+0.17280887,9.1577397E-02,-1.8410594,0.188553015,9.3394207E-02,   0000043P0000791
+-2.010663,0.13381038,6.5695126E-02,-1.974311411,0.185395987,     0000043P0000792
+0.154275596,-1.90690583,0.175172358,9.644217E-02,-1.8410594,     0000043P0000793
+0.190894689,9.7939813E-02,-2.010663,0.139406089,7.771038E-02,    0000043P0000794
+-1.974311411,0.189067896,0.162287058,-1.90690583,0.179866505,    0000043P0000795
+0.106231716,-1.8410594,0.195538041,0.107097605,-2.010663,        0000043P0000796
+0.144935488,8.9750801E-02,-1.974311411,0.192786263,0.170316591,  0000043P0000797
+-1.90690583,0.184474336,0.116069105,-1.8410594,0.200068991,      0000043P0000798
+0.11633135,-2.010663,0.147694038,9.5785175E-02,-1.974311411,     0000043P0000799
+0.194660306,0.174352971,-1.90690583,0.186770053,0.121015529,     0000043P0000800
+-1.8410594,0.202313678,0.120979443,-2.010663,0.153216264,        0000043P0000801
+0.107895475,-1.974311411,0.198451455,0.18250437,-1.90690583,     0000043P0000802
+0.191356643,0.13097983,-1.8410594,0.20678277,0.1303638,          0000043P0000803
+-2.010663,0.158704444,0.119935304,-1.974311411,0.202285883,      0000043P0000804
+0.190753865,-1.90690583,0.195906451,0.140984856,-1.8410594,      0000043P0000805
+0.211177964,0.139827597,-2.010663,0.16145713,0.125960258,        0000043P0000806
+-1.974311411,0.204223538,0.194930948,-1.90690583,0.198187223,    0000043P0000807
+0.146021979,-1.8410594,0.213372722,0.14460442,-2.010663,         0000043P0000808
+0.166999357,0.1380393,-1.974311411,0.208148614,0.203421559,      0000043P0000809
+-1.90690583,0.202778888,0.156187628,-1.8410594,0.21777496,       0000043P0000810
+0.154270896,-2.010663,0.172546846,0.149963785,-1.974311411,      0000043P0000811
+0.212109192,0.212080583,-1.90690583,0.207376334,0.166381465,     0000043P0000812
+-1.8410594,0.222153182,0.164020636,-2.010663,0.17534571,         0000043P0000813
+0.155930209,-1.974311411,0.214112941,0.216487895,-1.90690583,    0000043P0000814
+0.209695467,0.171520553,-1.8410594,0.224356071,0.168951466,      0000043P0000815
+-2.010663,0.1810135,0.167934885,-1.974311411,0.218171715,        0000043P0000816
+0.225454874,-1.90690583,0.214397374,0.181924324,-1.8410594,      0000043P0000817
+0.228808882,0.178952612,-2.010663,0.186703971,0.179832759,       0000043P0000818
+-1.974311411,0.222246014,0.234531461,-1.90690583,0.219117871,    0000043P0000819
+0.192327373,-1.8410594,0.233264857,0.188999438,-2.010663,        0000043P0000820
+0.189584341,0.185821639,-1.974311411,0.224305713,0.239132413,    0000043P0000821
+-1.90690583,0.221515667,0.197595339,-1.8410594,0.23552025,       0000043P0000822
+0.194087774,-2.010663,0.194712178,0.196428819,-1.974311411,      0000043P0000823
+0.227942569,0.247309439,-1.90690583,0.225768873,0.206908735,     0000043P0000824
+-1.8410594,0.23952723,0.203118347,-2.010663,0.199840153,         0000043P0000825
+0.206957809,-1.974311411,0.231664279,0.255588424,-1.90690583,    0000043P0000826
+0.230039519,0.216228441,-1.8410594,0.243543738,0.21214846,       0000043P0000827
+-2.010663,0.202072482,0.211527279,-1.974311411,0.233302168,      0000043P0000828
+0.259208384,-1.90690583,0.231908016,0.220295694,-1.8410594,      0000043P0000829
+0.245300683,0.216095151,-2.010663,0.207403955,0.222418152,       0000043P0000830
+-1.974311411,0.237284221,0.267924415,-1.90690583,0.23639799,     0000043P0000831
+0.230050241,-1.8410594,0.249526309,0.225579079,-2.010663,        0000043P0000832
+0.212701313,0.233179592,-1.974311411,0.241373351,0.276682025,    0000043P0000833
+-1.90690583,0.240919017,0.239819473,-1.8410594,0.253787059,      0000043P0000834
+0.235126076,-2.010663,0.215756708,0.239389757,-1.974311411,      0000043P0000835
+0.243810851,0.281818779,-1.90690583,0.243563468,0.245520889,     0000043P0000836
+-1.8410594,0.256286392,0.240722105,-2.010663,0.222083463,        0000043P0000837
+0.252160531,-1.974311411,0.248834368,0.292315224,-1.90690583,    0000043P0000838
+0.249025536,0.257253633,-1.8410594,0.261440945,0.252256973,      0000043P0000839
+-2.010663,0.228501245,0.264932869,-1.974311411,0.253848058,      0000043P0000840
+0.302634733,-1.90690583,0.25451996,0.268973744,-1.8410594,       0000043P0000841
+0.266606865,0.263807227,-2.010663,0.231834725,0.271513948,       0000043P0000842
+-1.974311411,0.256411782,0.307882038,-1.90690583,0.257352545,    0000043P0000843
+0.274994909,-1.8410594,0.269263041,0.269744245,-2.010663,        0000043P0000844
+0.238710655,0.284997455,-1.974311411,0.261640478,0.318528555,    0000043P0000845
+-1.90690583,0.263162917,0.287310079,-1.8410594,0.274700072,      0000043P0000846
+0.281894155,-2.010663,0.245687148,0.298514533,-1.974311411,      0000043P0000847
+0.266830373,0.328994013,-1.90690583,0.268995261,0.299607933,     0000043P0000848
+-1.8410594,0.280135776,0.294036749,-2.010663,0.24927514,         0000043P0000849
+0.305430764,-1.974311411,0.269478771,0.334310349,-1.90690583,    0000043P0000850
+0.271982913,0.305893815,-1.8410594,0.282915756,0.300246055,      0000043P0000851
+-2.010663,0.256599596,0.319488991,-1.974311411,0.274855231,      0000043P0000852
+0.345056824,-1.90690583,0.278063849,0.318664279,-1.8410594,      0000043P0000853
+0.288566883,0.312867097,-2.010663,0.26397988,0.333549081,        0000043P0000854
+-1.974311411,0.280221275,0.3556955,-1.90690583,0.284159156,      0000043P0000855
+0.331423766,-1.8410594,0.294218347,0.325487115,-2.010663,        0000043P0000856
+0.267739885,0.340689745,-1.974311411,0.282946485,0.361077771,    0000043P0000857
+-1.90690583,0.287258655,0.337903212,-1.8410594,0.297089541,      0000043P0000858
+0.331898334,-2.010663,0.275365647,0.355132896,-1.974311411,      0000043P0000859
+0.288459945,0.371927976,-1.90690583,0.293534861,0.351008153,     0000043P0000860
+-1.8410594,0.302898823,0.344869705,-2.010663,0.283020109,        0000043P0000861
+0.369561637,-1.974311411,0.293977328,0.382712636,-1.90690583,    0000043P0000862
+0.299820091,0.364104913,-1.8410594,0.30870889,0.357842223,       0000043P0000863
+-2.010663,0.286896874,0.376854443,-1.974311411,0.296769405,      0000043P0000864
+0.388152928,-1.90690583,0.303000717,0.370726621,-1.8410594,      0000043P0000865
+0.311647498,0.364403364,-2.010663,0.294726199,0.391556216,       0000043P0000866
+-1.974311411,0.302406646,0.399104516,-1.90690583,0.309420434,    0000043P0000867
+0.384081406,-1.8410594,0.317576144,0.377640396,-2.010663,        0000043P0000868
+0.302569582,0.406237062,-1.974311411,0.308053354,0.410013496,    0000043P0000869
+-1.90690583,0.315845666,0.397429126,-1.8410594,0.323505304,      0000043P0000870
+0.390878549,-2.010663,0.306527711,0.413635185,-1.974311411,      0000043P0000871
+0.310903599,0.415505579,-1.90690583,0.319087069,0.404158688,     0000043P0000872
+-1.8410594,0.32649547,0.397554779,-2.010663,0.310488219,         0000043P0000873
+0.42102837,-1.974311411,0.313756156,0.420988742,-1.90690583,     0000043P0000874
+0.322329415,0.410886534,-1.8410594,0.329485594,0.404230962,      0000043P0000875
+-2.010663,0.314450974,0.428417309,-1.974311411,0.31661061,       0000043P0000876
+0.426463046,-1.90690583,0.3255725,0.417612602,-1.8410594,        0000043P0000877
+0.332475514,0.410906755,0.,1.,0.,1.;                             0000043P0000878
+508,4,0,9,1,0,1,0,47,0,9,5,1,1,0,49,0,9,6,1,1,0,51,0,9,7,0,1,0,  0000045P0000879
+53;                                                              0000045P0000880
+110,0.,1.,0.,0.,0.,0.;                                           0000047P0000881
+110,0.,0.,0.,1.,0.,0.;                                           0000049P0000882
+110,1.,0.,0.,1.,1.,0.;                                           0000051P0000883
+110,1.,1.,0.,0.,1.,0.;                                           0000053P0000884
+510,57,1,1,59;                                                   0000055P0000885
+128,15,9,3,3,0,0,1,0,0,0.,0.,0.,0.,1.,2.,3.,4.,5.,6.,7.,7.5,7.5, 0000057P0000886
+7.5,8.,9.,10.,10.,10.,10.,0.,0.,0.,0.,0.375,1.,2.,3.,4.,5.,6.,   0000057P0000887
+6.,6.,6.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000057P0000888
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000057P0000889
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000057P0000890
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000057P0000891
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000057P0000892
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000057P0000893
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000057P0000894
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,-2.0105912,0.,   0000057P0000895
+-0.15,-1.8035222,0.,-0.149973508,-1.51818,0.,-0.15,-0.954836,0., 0000057P0000896
+-0.15,-0.371762,0.,-0.15,0.190771,0.,-0.15,0.767805,0.,-0.15,    0000057P0000897
+1.337583,0.,-0.15,1.694527,0.,-0.15,1.965682,0.,-0.15,2.055056,  0000057P0000898
+0.,-0.15,2.144462,0.,-0.10152926,2.409698,0.,-2.76261E-02,       0000057P0000899
+2.727355,0.,3.35265E-02,2.915937,0.,5.81277E-02,3.053863,0.,     0000057P0000900
+7.5097E-02,-2.0105912,1.510538E-03,-0.15,-1.8035222,             0000057P0000901
+1.510538E-03,-0.149973508,-1.51818,1.510538E-03,-0.15,-0.954836, 0000057P0000902
+1.510538E-03,-0.15,-0.371762,1.510538E-03,-0.15,0.190771,        0000057P0000903
+1.510538E-03,-0.15,0.767805,1.510538E-03,-0.15,1.33757,          0000057P0000904
+4.028084E-03,-0.15,1.694551,4.028084E-03,-0.15,1.965682,         0000057P0000905
+8.462416E-03,-0.15,2.055056,0.,-0.15,2.144462,1.510538E-03,      0000057P0000906
+-0.10152926,2.409698,1.510538E-03,-2.76261E-02,2.727355,         0000057P0000907
+1.510538E-03,3.35265E-02,2.915937,1.510538E-03,5.81277E-02,      0000057P0000908
+3.053846,1.510538E-03,7.51142E-02,-2.0105945,1.150638E-02,       0000057P0000909
+-0.141159936,-1.8035269,1.531132E-02,-0.142718379,-1.518179,     0000057P0000910
+1.581483E-02,-0.14283847,-0.954845,2.012328E-02,-0.145864042,    0000057P0000911
+-0.371764,2.253783E-02,-0.148507318,0.190766,2.314433E-02,       0000057P0000912
+-0.149272061,0.767796,2.321872E-02,-0.149123268,1.337578,        0000057P0000913
+2.269233E-02,-0.146484564,1.694532,2.181118E-02,-0.141715688,    0000057P0000914
+1.96568,2.17597E-02,-0.140638271,2.055053,2.055241E-02,          0000057P0000915
+-0.11524188,2.144463,2.055241E-02,-0.10112875,2.409701,          0000057P0000916
+1.955683E-02,-2.38326E-02,2.727357,1.861274E-02,3.58667E-02,     0000057P0000917
+2.915938,1.861274E-02,5.94894E-02,3.053355,1.861274E-02,         0000057P0000918
+7.56295E-02,-2.0105982,4.840572E-02,-9.555213E-02,-1.8035284,    0000057P0000919
+6.608011E-02,-0.10081252,-1.518185,7.494875E-02,-0.10581322,     0000057P0000920
+-0.954847,0.1005306,-0.12337196,-0.371767,0.1167516,-0.13971874, 0000057P0000921
+0.190765,0.1209799,-0.144437222,0.767801,0.1212317,-0.143407278, 0000057P0000922
+1.337578,0.1175069,-0.12787182,1.694529,0.1118424,-0.1012574,    0000057P0000923
+1.965662,0.1065899,-6.660494E-02,2.055058,0.1048276,             0000057P0000924
+-5.442574E-02,2.144454,0.1030653,-4.22523E-02,2.409697,          0000057P0000925
+9.774408E-02,-3.8409E-03,2.727357,9.161612E-02,4.77793E-02,      0000057P0000926
+2.915939,9.106682E-02,6.64413E-02,3.047905,9.028867E-02,         0000057P0000927
+7.90676E-02,-2.0106025,7.978361E-02,-4.44286E-02,-1.8035342,     0000057P0000928
+0.1043584,-5.125097E-02,-1.518191,0.1313591,-6.209929E-02,       0000057P0000929
+-0.954854,0.175279,-8.741097E-02,-0.371769,0.2147646,-0.117158,  0000057P0000930
+0.190761,0.2260478,-0.12433681,0.767795,0.2252411,-0.11943328,   0000057P0000931
+1.337572,0.2151708,-9.155607E-02,1.69452,0.2027433,              0000057P0000932
+-5.524906E-02,1.965659,0.1921181,-2.68047E-02,2.055052,0.188542, 0000057P0000933
+-1.72574E-02,2.144451,0.1849659,-7.7102E-03,2.409691,0.1741347,  0000057P0000934
+2.11287E-02,2.727351,0.1603683,6.01211E-02,2.915934,0.1559396,   0000057P0000935
+7.38452E-02,3.039327,0.1539141,8.38246E-02,-2.0106152,0.1208827, 0000057P0000936
+3.49488E-02,-1.8035451,0.161175,2.36921E-02,-1.518195,0.2002601, 0000057P0000937
+8.0147E-03,-0.954862,0.2510288,-2.21376E-02,-0.371778,0.2977695, 0000057P0000938
+-5.872782E-02,0.190755,0.3207365,-8.04169E-02,0.767789,          0000057P0000939
+0.3187225,-7.591389E-02,1.337568,0.2977695,-3.958E-02,1.694513,  0000057P0000940
+0.277961,-7.6329E-03,1.965655,0.2622949,1.21431E-02,2.055051,    0000057P0000941
+0.2570938,1.86177E-02,2.144447,0.2518871,2.50924E-02,2.40969,    0000057P0000942
+0.236324,4.41643E-02,2.72735,0.2171849,7.14043E-02,2.915936,     0000057P0000943
+0.2071089,8.15009E-02,3.031894,0.2026803,8.99651E-02,-2.010625,  0000057P0000944
+0.161175,0.1235954,-1.8035567,0.2083162,0.1042825,-1.518206,     0000057P0000945
+0.258284,8.21567E-02,-0.954868,0.3187225,4.55561E-02,-0.371787,  0000057P0000946
+0.3598215,1.90361E-02,0.190747,0.370298,9.437E-03,0.767776,      0000057P0000947
+0.3670767,1.51473E-02,1.337557,0.3481378,3.53688E-02,1.69451,    0000057P0000948
+0.3323573,5.11921E-02,1.965644,0.3191115,6.22081E-02,2.055043,   0000057P0000949
+0.3143682,6.59363E-02,2.144443,0.3096249,6.96703E-02,2.409683,   0000057P0000950
+0.2944109,8.10351E-02,2.727347,0.2655334,9.92061E-02,2.915934,   0000057P0000951
+0.248208,0.1101095,3.028489,0.235317,0.1205908,-2.0106383,       0000057P0000952
+0.2034814,0.2146566,-1.8035648,0.2429727,0.1884948,-1.518214,    0000057P0000953
+0.2957555,0.1603268,-0.954875,0.3549867,0.1249392,-0.371799,     0000057P0000954
+0.3811807,0.1052681,0.190731,0.3868223,9.76773E-02,0.767767,     0000057P0000955
+0.3856093,9.85585E-02,1.337547,0.3747323,0.104676,1.694502,      0000057P0000956
+0.3633175,0.1107609,1.965638,0.3492135,0.1185041,2.055037,       0000057P0000957
+0.3439724,0.1213226,2.144436,0.338737,0.1241468,2.40968,         0000057P0000958
+0.3214117,0.1333487,2.727342,0.2885061,0.1491682,2.915928,       0000057P0000959
+0.2651329,0.159671,3.036543,0.2490148,0.1675358,-2.0106466,      0000057P0000960
+0.2453872,0.3049167,-1.8035795,0.2812509,0.2719003,-1.518227,    0000057P0000961
+0.3227505,0.2401047,-0.954889,0.3759396,0.1970615,-0.371808,     0000057P0000962
+0.394478,0.1761831,0.190724,0.3956853,0.1710126,0.767759,        0000057P0000963
+0.3920577,0.1706865,1.33754,0.384402,0.1719634,1.694492,         0000057P0000964
+0.3760083,0.1740259,1.96563,0.3619043,0.1778326,2.055028,        0000057P0000965
+0.3566002,0.1792836,2.144425,0.3512962,0.1807289,2.409671,       0000057P0000966
+0.3335646,0.1855938,2.727338,0.3009966,0.1947016,2.915921,       0000057P0000967
+0.2768166,0.2019774,3.042303,0.2590907,0.2088356,-2.010663,      0000057P0000968
+0.313098,0.4298561,-1.8035934,0.3376785,0.4057026,-1.518242,     0000057P0000969
+0.3662699,0.3787191,-0.954904,0.3960858,0.3417409,-0.371823,     0000057P0000970
+0.4105961,0.3148146,0.190709,0.4154309,0.2911115,0.767748,       0000057P0000971
+0.4097893,0.271034,1.337529,0.4045711,0.2586131,1.694481,        0000057P0000972
+0.3921263,0.2552858,1.965624,0.3783256,0.2581369,2.055021,       0000057P0000973
+0.3733477,0.2594849,2.144419,0.3683698,0.2608272,2.409665,       0000057P0000974
+0.3523032,0.2660468,2.727324,0.3247703,0.2785133,2.91591,        0000057P0000975
+0.299383,0.2890105,3.059549,0.2786476,0.2962533,0.296612758,10., 0000057P0000976
+0.,6.;                                                           0000057P0000977
+508,4,0,9,6,0,1,0,61,0,9,8,1,1,0,63,0,9,9,1,1,0,65,0,9,10,0,1,0, 0000059P0000978
+67;                                                              0000059P0000979
+126,275,11,1,0,1,0,0.,0.,0.,0.,0.,0.,0.,0.,0.,0.,0.,0.,0.25,     0000061P0000980
+0.25,0.25,0.25,0.25,0.25,0.25,0.25,0.25,0.25,0.25,0.375,0.375,   0000061P0000981
+0.375,0.375,0.375,0.375,0.375,0.375,0.375,0.375,0.375,0.5,0.5,   0000061P0000982
+0.5,0.5,0.5,0.5,0.5,0.5,0.5,0.5,0.5,0.75,0.75,0.75,0.75,0.75,    0000061P0000983
+0.75,0.75,0.75,0.75,0.75,0.75,0.8125,0.8125,0.8125,0.8125,       0000061P0000984
+0.8125,0.8125,0.8125,0.8125,0.8125,0.8125,0.8125,0.84375,        0000061P0000985
+0.84375,0.84375,0.84375,0.84375,0.84375,0.84375,0.84375,0.84375, 0000061P0000986
+0.84375,0.84375,0.859375,0.859375,0.859375,0.859375,0.859375,    0000061P0000987
+0.859375,0.859375,0.859375,0.859375,0.859375,0.859375,0.8671875, 0000061P0000988
+0.8671875,0.8671875,0.8671875,0.8671875,0.8671875,0.8671875,     0000061P0000989
+0.8671875,0.8671875,0.8671875,0.8671875,0.87109375,0.87109375,   0000061P0000990
+0.87109375,0.87109375,0.87109375,0.87109375,0.87109375,          0000061P0000991
+0.87109375,0.87109375,0.87109375,0.87109375,0.873046875,         0000061P0000992
+0.873046875,0.873046875,0.873046875,0.873046875,0.873046875,     0000061P0000993
+0.873046875,0.873046875,0.873046875,0.873046875,0.873046875,     0000061P0000994
+0.875,0.875,0.875,0.875,0.875,0.875,0.875,0.875,0.875,0.875,     0000061P0000995
+0.875,0.90625,0.90625,0.90625,0.90625,0.90625,0.90625,0.90625,   0000061P0000996
+0.90625,0.90625,0.90625,0.90625,0.9375,0.9375,0.9375,0.9375,     0000061P0000997
+0.9375,0.9375,0.9375,0.9375,0.9375,0.9375,0.9375,0.96875,        0000061P0000998
+0.96875,0.96875,0.96875,0.96875,0.96875,0.96875,0.96875,0.96875, 0000061P0000999
+0.96875,0.96875,0.984375,0.984375,0.984375,0.984375,0.984375,    0000061P0001000
+0.984375,0.984375,0.984375,0.984375,0.984375,0.984375,0.9921875, 0000061P0001001
+0.9921875,0.9921875,0.9921875,0.9921875,0.9921875,0.9921875,     0000061P0001002
+0.9921875,0.9921875,0.9921875,0.9921875,0.99609375,0.99609375,   0000061P0001003
+0.99609375,0.99609375,0.99609375,0.99609375,0.99609375,          0000061P0001004
+0.99609375,0.99609375,0.99609375,0.99609375,0.998046875,         0000061P0001005
+0.998046875,0.998046875,0.998046875,0.998046875,0.998046875,     0000061P0001006
+0.998046875,0.998046875,0.998046875,0.998046875,0.998046875,     0000061P0001007
+0.999023438,0.999023438,0.999023438,0.999023438,0.999023438,     0000061P0001008
+0.999023438,0.999023438,0.999023438,0.999023438,0.999023438,     0000061P0001009
+0.999023438,0.999511719,0.999511719,0.999511719,0.999511719,     0000061P0001010
+0.999511719,0.999511719,0.999511719,0.999511719,0.999511719,     0000061P0001011
+0.999511719,0.999511719,0.999755859,0.999755859,0.999755859,     0000061P0001012
+0.999755859,0.999755859,0.999755859,0.999755859,0.999755859,     0000061P0001013
+0.999755859,0.999755859,0.999755859,0.99987793,0.99987793,       0000061P0001014
+0.99987793,0.99987793,0.99987793,0.99987793,0.99987793,          0000061P0001015
+0.99987793,0.99987793,0.99987793,0.99987793,0.999938965,         0000061P0001016
+0.999938965,0.999938965,0.999938965,0.999938965,0.999938965,     0000061P0001017
+0.999938965,0.999938965,0.999938965,0.999938965,0.999938965,     0000061P0001018
+0.999969482,0.999969482,0.999969482,0.999969482,0.999969482,     0000061P0001019
+0.999969482,0.999969482,0.999969482,0.999969482,0.999969482,     0000061P0001020
+0.999969482,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000061P0001021
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000061P0001022
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000061P0001023
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000061P0001024
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000061P0001025
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000061P0001026
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000061P0001027
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000061P0001028
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000061P0001029
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000061P0001030
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000061P0001031
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000061P0001032
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000061P0001033
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,        0000061P0001034
+0.296749084,5.999999997,0.,0.296746209,5.965878725,0.,           0000061P0001035
+0.296743315,5.930162158,0.,0.296740401,5.892451427,0.,           0000061P0001036
+0.296737464,5.852449663,0.,0.2967345,5.809870249,0.,0.296731508, 0000061P0001037
+5.764345051,0.,0.296728482,5.715332661,0.,0.296725416,           0000061P0001038
+5.662026639,0.,0.296722303,5.603263751,0.,0.296719134,           0000061P0001039
+5.537432211,0.,0.296715899,5.462379921,0.,0.296714282,           0000061P0001040
+5.424738674,0.,0.296712646,5.38515344,0.,0.296710997,            0000061P0001041
+5.342399592,0.,0.296709334,5.296820386,0.,0.296707657,           0000061P0001042
+5.248467734,0.,0.29670597,5.196802979,0.,0.296704285,            0000061P0001043
+5.141278638,0.,0.29670261,5.082122095,0.,0.296700952,            0000061P0001044
+5.020642207,0.,0.296699314,4.9583798,0.,0.296697701,4.894423024, 0000061P0001045
+0.,0.296696096,4.830468588,0.,0.296694514,4.764916985,0.,        0000061P0001046
+0.296692955,4.697844135,0.,0.29669142,4.629345309,0.,            0000061P0001047
+0.296689908,4.559535133,0.,0.296688418,4.488547584,0.,           0000061P0001048
+0.296686945,4.416535993,0.,0.296685486,4.343673044,0.,           0000061P0001049
+0.296684038,4.270150772,0.,0.296682594,4.196180568,0.,           0000061P0001050
+0.296681148,4.121993174,0.,0.296678241,3.973481682,0.,           0000061P0001051
+0.296675344,3.824796809,0.,0.296672382,3.677162865,0.,           0000061P0001052
+0.296669385,3.530006319,0.,0.296666385,3.382710935,0.,           0000061P0001053
+0.296663381,3.235049527,0.,0.296660342,3.086825975,0.,           0000061P0001054
+0.296657248,2.937261138,0.,0.296654106,2.784656303,0.,           0000061P0001055
+0.296650959,2.626867811,0.,0.296647832,2.463126503,0.,           0000061P0001056
+0.296647051,2.422186916,0.,0.296646272,2.38083684,0.,            0000061P0001057
+0.296645496,2.339063054,0.,0.296644721,2.29684229,0.,            0000061P0001058
+0.296643949,2.254141226,0.,0.296643179,2.210916492,0.,           0000061P0001059
+0.296642414,2.167114666,0.,0.296641654,2.122672279,0.,           0000061P0001060
+0.296640903,2.077515807,0.,0.296640161,2.031561678,0.,           0000061P0001061
+0.296639432,1.984716271,0.,0.296639058,1.961314004,0.,           0000061P0001062
+0.296638687,1.937664259,0.,0.296638319,1.913767035,0.,           0000061P0001063
+0.296637953,1.889622335,0.,0.296637589,1.865230156,0.,           0000061P0001064
+0.296637228,1.840590499,0.,0.29663687,1.815703365,0.,            0000061P0001065
+0.296636514,1.790568752,0.,0.296636161,1.765186662,0.,           0000061P0001066
+0.296635811,1.739557094,0.,0.296635462,1.713680048,0.,           0000061P0001067
+0.296635287,1.70072304,0.,0.296635112,1.68771762,0.,0.296634938, 0000061P0001068
+1.67466379,0.,0.296634764,1.661561548,0.,0.296634592,            0000061P0001069
+1.648410896,0.,0.29663442,1.635211832,0.,0.296634249,            0000061P0001070
+1.621964358,0.,0.29663408,1.608668472,0.,0.29663391,1.595324176, 0000061P0001071
+0.,0.296633742,1.581931468,0.,0.296633575,1.56849035,0.,         0000061P0001072
+0.296633491,1.561778658,0.,0.296633407,1.555061321,0.,           0000061P0001073
+0.296633323,1.548338337,0.,0.29663324,1.541609707,0.,            0000061P0001074
+0.296633158,1.53487543,0.,0.296633075,1.528135507,0.,            0000061P0001075
+0.296632993,1.521389938,0.,0.296632911,1.514638722,0.,           0000061P0001076
+0.29663283,1.50788186,0.,0.296632749,1.501119352,0.,0.296632668, 0000061P0001077
+1.494351198,0.,0.296632628,1.49096556,0.,0.296632588,            0000061P0001078
+1.487579923,0.,0.296632548,1.484194285,0.,0.296632509,           0000061P0001079
+1.480808648,0.,0.296632469,1.477423011,0.,0.296632429,           0000061P0001080
+1.474037373,0.,0.296632389,1.470651736,0.,0.296632349,           0000061P0001081
+1.467266099,0.,0.296632309,1.463880461,0.,0.296632269,           0000061P0001082
+1.460494824,0.,0.296632229,1.457109187,0.,0.29663221,            0000061P0001083
+1.455414542,0.,0.29663219,1.453719898,0.,0.29663217,1.452025253, 0000061P0001084
+0.,0.296632151,1.450330609,0.,0.296632131,1.448635964,0.,        0000061P0001085
+0.296632111,1.44694132,0.,0.296632092,1.445246675,0.,            0000061P0001086
+0.296632072,1.443552031,0.,0.296632052,1.441857386,0.,           0000061P0001087
+0.296632033,1.440162742,0.,0.296632013,1.438468097,0.,           0000061P0001088
+0.296631993,1.436795933,0.,0.296631974,1.435182609,0.,           0000061P0001089
+0.296631952,1.432983956,0.,0.296631932,1.431094111,0.,           0000061P0001090
+0.296631913,1.429525474,0.,0.296631894,1.42781402,0.,            0000061P0001091
+0.296631874,1.425877761,0.,0.296631854,1.424107964,0.,           0000061P0001092
+0.296631836,1.422624536,0.,0.296631817,1.420778815,0.,           0000061P0001093
+0.296631798,1.419138817,0.,0.296631491,1.391892467,0.,           0000061P0001094
+0.296631268,1.373014053,0.,0.296630647,1.320201837,0.,           0000061P0001095
+0.29663087,1.338152309,0.,0.296629958,1.257079778,0.,            0000061P0001096
+0.296630219,1.277013655,0.,0.2966296,1.219951022,0.,0.296629495, 0000061P0001097
+1.207242654,0.,0.296629178,1.175788411,0.,0.296628929,1.1501491, 0000061P0001098
+0.,0.29662867,1.123505114,0.,0.296628413,1.096973686,0.,         0000061P0001099
+0.296628157,1.070546927,0.,0.296627903,1.044258697,0.,           0000061P0001100
+0.296627652,1.018126264,0.,0.296627405,0.992150297,0.,           0000061P0001101
+0.296627162,0.96631487,0.,0.296626924,0.94058746,0.,0.296626689, 0000061P0001102
+0.914918948,0.,0.296626457,0.88924362,0.,0.296626226,            0000061P0001103
+0.863479163,0.,0.296625995,0.83752667,0.,0.296625762,            0000061P0001104
+0.811624627,0.,0.29662553,0.785553255,0.,0.296625296,            0000061P0001105
+0.759277042,0.,0.296625057,0.732746028,0.,0.296624808,           0000061P0001106
+0.705895809,0.,0.296624545,0.678647532,0.,0.296624263,           0000061P0001107
+0.650907898,0.,0.296623957,0.622569164,0.,0.296623621,           0000061P0001108
+0.593509137,0.,0.296623247,0.563591181,0.,0.296622831,           0000061P0001109
+0.53266421,0.,0.296622625,0.517219798,0.,0.29662241,0.501461938, 0000061P0001110
+0.,0.296622186,0.485405118,0.,0.296621955,0.469045609,0.,        0000061P0001111
+0.296621718,0.452361471,0.,0.296621476,0.43531255,0.,            0000061P0001112
+0.296621228,0.417840478,0.,0.296620976,0.399868673,0.,           0000061P0001113
+0.296620717,0.381302339,0.,0.296620453,0.362028466,0.,           0000061P0001114
+0.296620181,0.341915833,0.,0.296620045,0.331857813,0.,           0000061P0001115
+0.296619908,0.321610539,0.,0.296619769,0.31118068,0.,            0000061P0001116
+0.296619629,0.30056388,0.,0.296619488,0.289744762,0.,            0000061P0001117
+0.296619345,0.278696929,0.,0.2966192,0.267382961,0.,0.296619053, 0000061P0001118
+0.255754415,0.,0.296618903,0.243751828,0.,0.296618749,           0000061P0001119
+0.231304715,0.,0.29661859,0.218331569,0.,0.296618511,            0000061P0001120
+0.211852429,0.,0.296618431,0.20524614,0.,0.296618349,            0000061P0001121
+0.198500602,0.,0.296618267,0.191603712,0.,0.296618183,           0000061P0001122
+0.184543369,0.,0.296618097,0.17730747,0.,0.29661801,0.169883915, 0000061P0001123
+0.,0.296617921,0.1622606,0.,0.296617831,0.154425425,0.,          0000061P0001124
+0.296617739,0.146366287,0.,0.296617645,0.138071084,0.,           0000061P0001125
+0.296617598,0.133922501,0.,0.29661755,0.129713935,0.,            0000061P0001126
+0.296617502,0.125421016,0.,0.296617453,0.121019374,0.,           0000061P0001127
+0.296617402,0.116484641,0.,0.29661735,0.111792446,0.,            0000061P0001128
+0.296617297,0.106918421,0.,0.296617241,0.101838194,0.,           0000061P0001129
+0.296617184,9.652739831E-02,0.,0.296617124,9.096166252E-02,0.,   0000061P0001130
+0.296617061,8.511661759E-02,0.,0.29661703,8.221493018E-02,0.,    0000061P0001131
+0.296616998,7.923057361E-02,0.,0.296616965,7.616354786E-02,0.,   0000061P0001132
+0.296616932,7.301385295E-02,0.,0.296616898,6.978148887E-02,0.,   0000061P0001133
+0.296616863,6.646645563E-02,0.,0.296616828,6.306875321E-02,0.,   0000061P0001134
+0.296616792,5.958838163E-02,0.,0.296616755,5.602534088E-02,0.,   0000061P0001135
+0.296616717,5.237963096E-02,0.,0.296616679,4.865125188E-02,0.,   0000061P0001136
+0.296616661,4.67524062E-02,0.,0.296616641,4.487816896E-02,0.,    0000061P0001137
+0.29661662,4.300782744E-02,0.,0.296616598,4.112433471E-02,0.,    0000061P0001138
+0.296616576,3.921430967E-02,0.,0.296616554,3.726803705E-02,0.,   0000061P0001139
+0.296616532,3.527946737E-02,0.,0.29661651,3.3246217E-02,0.,      0000061P0001140
+0.296616488,3.116956808E-02,0.,0.296616464,2.905446861E-02,0.,   0000061P0001141
+0.296616438,2.690953238E-02,0.,0.296616426,2.583581956E-02,0.,   0000061P0001142
+0.296616414,2.474865497E-02,0.,0.296616402,2.364803861E-02,0.,   0000061P0001143
+0.296616389,2.253397046E-02,0.,0.296616377,2.140645054E-02,0.,   0000061P0001144
+0.296616364,2.026547884E-02,0.,0.296616351,1.911105537E-02,0.,   0000061P0001145
+0.296616338,1.794318011E-02,0.,0.296616325,1.676185308E-02,0.,   0000061P0001146
+0.296616312,1.556707428E-02,0.,0.296616299,1.43588437E-02,0.,    0000061P0001147
+0.296616292,1.375336426E-02,0.,0.296616284,1.314343992E-02,0.,   0000061P0001148
+0.296616277,1.252907069E-02,0.,0.29661627,1.191025657E-02,0.,    0000061P0001149
+0.296616263,1.128699756E-02,0.,0.296616255,1.065929365E-02,0.,   0000061P0001150
+0.296616248,1.002714485E-02,0.,0.296616241,9.390551161E-03,0.,   0000061P0001151
+0.296616234,8.749512575E-03,0.,0.296616226,8.104029095E-03,0.,   0000061P0001152
+0.296616219,7.454100722E-03,0.,0.296616215,7.131581739E-03,0.,   0000061P0001153
+0.296616212,6.806891697E-03,0.,0.296616208,6.480030596E-03,0.,   0000061P0001154
+0.296616205,6.150998438E-03,0.,0.296616201,5.819795221E-03,0.,   0000061P0001155
+0.296616198,5.486420945E-03,0.,0.296616195,5.150875612E-03,0.,   0000061P0001156
+0.296616191,4.81315922E-03,0.,0.296616188,4.473271769E-03,0.,    0000061P0001157
+0.296616184,4.131213261E-03,0.,0.296616181,3.786983694E-03,0.,   0000061P0001158
+0.296616179,3.623282379E-03,0.,0.296616177,3.459581064E-03,0.,   0000061P0001159
+0.296616175,3.295879749E-03,0.,0.296616173,3.132178434E-03,0.,   0000061P0001160
+0.296616172,2.968477119E-03,0.,0.29661617,2.804775804E-03,0.,    0000061P0001161
+0.296616168,2.641074489E-03,0.,0.296616166,2.477373174E-03,0.,   0000061P0001162
+0.296616164,2.313671859E-03,0.,0.296616162,2.149970544E-03,0.,   0000061P0001163
+0.296616161,1.986269229E-03,0.,0.296616158,1.801648173E-03,0.,   0000061P0001164
+0.296616156,1.583225461E-03,0.,0.296616153,1.551895126E-03,0.,   0000061P0001165
+0.296616152,6.758481977E-04,0.,0.296616141,1.510276037E-03,0.,   0000061P0001166
+0.296616144,4.860934478E-04,0.,0.296616144,-2.920562816E-04,-0., 0000061P0001167
+0.296616125,1.889822088E-03,0.,0.296616142,-4.62599643E-04,-0.,  0000061P0001168
+0.296616136,3.015883212E-04,0.,0.296616137,6.204301683E-08,0.,   0000061P0001169
+0.,1.,0.,0.,1.;                                                  0000061P0001170
+110,0.296616137,0.,0.,10.,0.,0.;                                 0000063P0001171
+110,10.,0.,0.,10.,6.,0.;                                         0000065P0001172
+110,10.,6.,0.,0.296749084,6.,0.;                                 0000067P0001173
+S      1G      4D     68P   1173                                        T0000001
diff --git a/tests/opencascade/iges_files/wigley.iges b/tests/opencascade/iges_files/wigley.iges
new file mode 100644 (file)
index 0000000..fd225ac
--- /dev/null
@@ -0,0 +1,95 @@
+                                                                        S0000001
+,,31HOpen CASCADE IGES processor 6.3,13HFilename.iges,                  G0000001
+16HOpen CASCADE 6.3,31HOpen CASCADE IGES processor 6.3,32,308,15,308,15,G0000002
+,1.,6,1HM,1,0.01,15H20111129.111101,1E-07,1.258933,5Hamola,,11,0,       G0000003
+15H20111129.111101,;                                                    G0000004
+     510       1       0       0       0       0       0       000010000D0000001
+     510       0       0       1       1                               0D0000002
+     128       2       0       0       0       0       0       000010000D0000003
+     128       0       0      29       0                               0D0000004
+     508      31       0       0       0       0       0       000010000D0000005
+     508       0       0       2       1                               0D0000006
+     504      33       0       0       0       0       0       000010001D0000007
+     504       0       0       1       1                               0D0000008
+     126      34       0       0       0       0       0       000010000D0000009
+     126       0       0       7       0                               0D0000010
+     502      41       0       0       0       0       0       000010000D0000011
+     502       0       0       2       1                               0D0000012
+     126      43       0       0       0       0       0       000010000D0000013
+     126       0       0       4       0                               0D0000014
+     126      47       0       0       0       0       0       000010000D0000015
+     126       0       0      10       0                               0D0000016
+     126      57       0       0       0       0       0       000010000D0000017
+     126       0       0       3       0                               0D0000018
+     110      60       0       0       0       0       0       000010000D0000019
+     110       0       0       1       0                               0D0000020
+     110      61       0       0       0       0       0       000010000D0000021
+     110       0       0       1       0                               0D0000022
+     110      62       0       0       0       0       0       000010000D0000023
+     110       0       0       1       0                               0D0000024
+     110      63       0       0       0       0       0       000010000D0000025
+     110       0       0       1       0                               0D0000026
+510,3,1,1,5;                                                     0000001P0000001
+128,3,10,3,4,0,0,1,0,0,0.,0.,0.,0.,1.,1.,1.,1.,0.,0.,0.,0.,0.,   0000003P0000002
+0.434398431,0.434398431,0.434398431,0.67839972,0.67839972,       0000003P0000003
+0.67839972,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,   0000003P0000004
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,  0000003P0000005
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,-1.25,0.,0.15625,-0.427535926,  0000003P0000006
+0.166356581,0.15625,0.427535926,0.166356581,0.15625,1.25,        0000003P0000007
+-3.885780586E-16,0.15625,-1.25,0.,0.1171875,-0.427535926,        0000003P0000008
+0.166356581,0.1171875,0.427535926,0.166356581,0.1171875,1.25,    0000003P0000009
+-3.885780586E-16,0.1171875,-1.25,0.,7.8125E-02,-0.427535926,     0000003P0000010
+0.166356581,7.8125E-02,0.427535926,0.166356581,7.8125E-02,1.25,  0000003P0000011
+-3.885780586E-16,7.8125E-02,-1.25,0.,3.90625E-02,-0.427535926,   0000003P0000012
+0.166356581,3.90625E-02,0.427535926,0.166356581,3.90625E-02,     0000003P0000013
+1.25,-3.885780586E-16,3.90625E-02,-1.25,0.,-2.194137841E-02,     0000003P0000014
+-0.427537148,0.166340839,-2.194137841E-02,0.427537148,           0000003P0000015
+0.166340839,-2.194137841E-02,1.25,-3.885524483E-16,              0000003P0000016
+-2.194137841E-02,-1.25,0.,-4.186850308E-02,-0.426411306,         0000003P0000017
+0.157707663,-4.186850308E-02,0.426411306,0.157707663,            0000003P0000018
+-4.186850308E-02,1.25,-3.683109958E-16,-4.186850308E-02,-1.25,   0000003P0000019
+0.,-6.051483061E-02,-0.424671145,0.14360916,-6.051483061E-02,    0000003P0000020
+0.424671145,0.14360916,-6.051483061E-02,1.25,-3.352606389E-16,   0000003P0000021
+-6.051483061E-02,-1.25,0.,-0.101335678,-0.420417595,0.100130616, 0000003P0000022
+-0.101335678,0.420417595,0.100130616,-0.101335678,1.25,          0000003P0000023
+-2.335884101E-16,-0.101335678,-1.25,0.,-0.121016618,             0000003P0000024
+-0.418058171,6.969502649E-02,-0.121016618,0.418058171,           0000003P0000025
+6.969502649E-02,-0.121016618,1.25,-1.624730779E-16,-0.121016618, 0000003P0000026
+-1.25,0.,-0.139275692,-0.416669646,3.62728606E-02,-0.139275692,  0000003P0000027
+0.416669646,3.62728606E-02,-0.139275692,1.25,-8.457292169E-17,   0000003P0000028
+-0.139275692,-1.25,0.,-0.15625,-0.416666667,0.,-0.15625,         0000003P0000029
+0.416666667,0.,-0.15625,1.25,0.,-0.15625,0.,1.,0.,1.;            0000003P0000030
+508,4,0,7,1,0,1,0,19,0,7,2,1,1,0,21,0,7,3,1,1,0,23,0,7,4,0,1,0,  0000005P0000031
+25;                                                              0000005P0000032
+504,4,9,11,1,11,2,13,11,1,11,3,15,11,3,11,4,17,11,2,11,4;        0000007P0000033
+126,10,4,0,0,1,0,0.,0.,0.,0.,0.,0.434398431,0.434398431,         0000009P0000034
+0.434398431,0.67839972,0.67839972,0.67839972,1.,1.,1.,1.,1.,1.,  0000009P0000035
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,-1.25,0.,0.15625,-1.25,0.,         0000009P0000036
+0.1171875,-1.25,0.,7.8125E-02,-1.25,0.,3.90625E-02,-1.25,0.,     0000009P0000037
+-2.194137841E-02,-1.25,0.,-4.186850308E-02,-1.25,0.,             0000009P0000038
+-6.051483061E-02,-1.25,0.,-0.101335678,-1.25,0.,-0.121016618,    0000009P0000039
+-1.25,0.,-0.139275692,-1.25,0.,-0.15625,0.,1.,0.,0.,1.;          0000009P0000040
+502,4,-1.25,0.,0.15625,-1.25,6.938893904E-18,-0.15625,1.25,      0000011P0000041
+-3.885780586E-16,0.15625,1.25,6.938893904E-18,-0.15625;          0000011P0000042
+126,3,3,1,0,1,0,0.,0.,0.,0.,1.,1.,1.,1.,1.,1.,1.,1.,-1.25,0.,    0000013P0000043
+0.15625,-0.427535926,0.166356581,0.15625,0.427535926,            0000013P0000044
+0.166356581,0.15625,1.25,-3.885780586E-16,0.15625,0.,1.,         0000013P0000045
+-1.684564833E-15,7.459327676E-16,1.;                             0000013P0000046
+126,10,4,0,0,1,0,0.,0.,0.,0.,0.,0.434398431,0.434398431,         0000015P0000047
+0.434398431,0.67839972,0.67839972,0.67839972,1.,1.,1.,1.,1.,1.,  0000015P0000048
+1.,1.,1.,1.,1.,1.,1.,1.,1.,1.,1.25,-3.885780586E-16,0.15625,     0000015P0000049
+1.25,-3.885780586E-16,0.1171875,1.25,-3.885780586E-16,           0000015P0000050
+7.8125E-02,1.25,-3.885780586E-16,3.90625E-02,1.25,               0000015P0000051
+-3.885524483E-16,-2.194137841E-02,1.25,-3.683109958E-16,         0000015P0000052
+-4.186850308E-02,1.25,-3.352606389E-16,-6.051483061E-02,1.25,    0000015P0000053
+-2.335884101E-16,-0.101335678,1.25,-1.624730779E-16,             0000015P0000054
+-0.121016618,1.25,-8.457292169E-17,-0.139275692,1.25,0.,         0000015P0000055
+-0.15625,0.,1.,0.,0.,1.;                                         0000015P0000056
+126,3,3,0,0,1,0,0.,0.,0.,0.,1.,1.,1.,1.,1.,1.,1.,1.,-1.25,0.,    0000017P0000057
+-0.15625,-0.416666667,0.,-0.15625,0.416666667,0.,-0.15625,1.25,  0000017P0000058
+0.,-0.15625,0.,1.,0.,0.,1.;                                      0000017P0000059
+110,0.,1.,0.,0.,0.,0.;                                           0000019P0000060
+110,0.,0.,0.,1.,0.,0.;                                           0000021P0000061
+110,1.,0.,0.,1.,1.,0.;                                           0000023P0000062
+110,1.,1.,0.,0.,1.,0.;                                           0000025P0000063
+S      1G      4D     26P     63                                        T0000001
diff --git a/tests/opencascade/iges_read.cc b/tests/opencascade/iges_read.cc
new file mode 100644 (file)
index 0000000..023749b
--- /dev/null
@@ -0,0 +1,53 @@
+
+//----------------------------  iges_read.cc  ---------------------------
+//    $Id: testsuite.html 13373 2006-07-13 13:12:08Z kanschat $
+//    Version: $Name$ 
+//
+//    Copyright (C) 2005 by the deal.II authors 
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  iges_read.cc  ---------------------------
+
+
+// Read goteborg.iges and dump its topological structure to the logfile.
+
+#include "../tests.h"
+#include <fstream>
+#include <base/logstream.h>
+
+#include <deal.II/grid/occ_utilities.h>
+#include <TopTools.hxx>
+#include <TopoDS_Shape.hxx>
+#include <Standard_Stream.hxx>
+
+using namespace OpenCASCADE;
+
+int main () 
+{
+  std::ofstream logfile("output");
+  deallog.attach(logfile);
+  deallog.depth_console(0);
+  
+  TopoDS_Shape sh = read_IGES(SOURCE_DIR "/iges_files/goteborg.iges");
+  unsigned int nf=0, ne=0, nv=0;
+  count_elements(sh, nf, ne, nv);
+  deallog << "Shape contains " << nf << " faces, "
+         << ne << " edges, and " 
+         << nv << " vertices." << std::endl;
+
+  // try 
+  //   {
+  //     TopoDS_Shape sh_fail = read_IGES("iges_files/nonexistent.iges");
+  //   }
+  // catch(...)
+  //   {
+  //     deallog << "Missing file correctly threw an exception." << std::endl;
+  //   }
+  
+  return 0;
+}
+                  
diff --git a/tests/opencascade/iges_read.output b/tests/opencascade/iges_read.output
new file mode 100644 (file)
index 0000000..8b1892b
--- /dev/null
@@ -0,0 +1,2 @@
+
+DEAL::Shape contains 3 faces, 12 edges, and 24 vertices.

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.