From c36ac19270a1f5a3553c2945f6301db8e642df81 Mon Sep 17 00:00:00 2001 From: Niklas Neher <73897120+LasNikas@users.noreply.github.com> Date: Fri, 17 Jan 2025 19:29:26 +0100 Subject: [PATCH] Particle packing (#529) * visualize signed distances * fix infinite normals * clean up TriangleMesh * clean up TriangleMesh * modify shapes * change ELTYPE in IO * add files and remove `scale_factor` * add shape and `complexShape` tests * remove complex tank example * add docs for `complexShapes` * add docs for the algorithms * add test data * add tests for sampled shapes * data path relative to module * use `Threads.@threads` instead of `threaded` * fix @threaded * fix tests * fix wrong directory * use `@threaded` again * change winding number factor for julia 1.9 * fix tests * modify examples * revise * add docs for `ParticlePackingSystem` * add signed distance docs * add closure for sdf * modify example 3d * add setter for tvf * add trixi2vtk(sdf) * sample boundary in `ComplexShape` * add stl files * add `ComplexShape` structure * fix callback used check * implement suggestions * rename kwargs * add comments * apply formatter * implement suggestion * fix tests * remove abstract type `Shapes` * fix tests * make type stable * implement suggestions * add `unique_soted` * add comment * implement suggestions * RADME and NEWS entry * adapt docs * `for` instead of `while` * rename `shape` to `geometry` * rename again * implement suggestions * fix typo * implement suggestions * adapt example files * sum-init with `zero(eltype))` * implement suggestions * construct hierarchy in constructor * use ASCII characters * minor changes * add 2d hierarchical winding * minor changes * change function name * fix * implement suggestions * fix typo * apply formatter * fix typo * add `deleteat!` * circle example eps() -> 0 * start docs * simplify * implement suggestions * fix docs * fix tests * fix tests * minor changes * typo * fix * fix again * fx * fix tests * fix again * implement suggestions * modify NEWS.md * modify again * remove face nhs * adapt examples * minor changes * clean up * add tgv validation example * add ldc validation * modify validation * increase `maxiters` * remove double velocity initialization * add random displacement * implement suggestions * update `NEWS.md` * remove check for viscosity * fix tests * add short tilde description in docs * remove discarded example from tests * implement suggestions * apply formatter * add boundary compress factor * fix signed distance field * fix io * implement suggestions * add comment * fix test * fix typo * apply formatter * fix unit tests * apply formatter * revise docs * add autodocs * fix tests * implement suggestions * remove dependency * implement suggestions nhs * add `*` * formatting docs * improve `triangle_plane_intersection` * minor changes * implement sdf suggestions * fix kwarg bug * fix sign bit bug * add comment * revise docs * improve API * adapt example files * terminate with steady state callback * fix tests * implement suggestions * add unit test for `SignedDistanceField` * add system tests * apply formatter * remove geometry from system * add `delete_positions_in_empty_cells` * revise face nhs * fix face nhs * add cell intersection tests * fix typos * fix tests * add kwargs for trixi2vtk * resolve dependency error * implement suggestions * implement suggestions * add `neighbors` field in nhs * fix * add example * remove cell intersection check * adapt nhs tests * fix tests * fix doc tests * add comment for update * add whole packing dir to docs * implement suggestions * add comments * fix tests * add comments * fix rounding error for v1.9 * Revert "fix rounding error for v1.9" This reverts commit f026ddc7495cb01d4eefc0beb08c370f9a0e9651. * implement suggestions * Increase Version * Update NEWS.md * Typo * Typo * Update NEWS.md Co-authored-by: Erik Faulhaber <44124897+efaulhaber@users.noreply.github.com> * modify news --------- Co-authored-by: LasNikas Co-authored-by: Sven Berger Co-authored-by: Erik Faulhaber <44124897+efaulhaber@users.noreply.github.com> --- NEWS.md | 36 + Project.toml | 2 +- docs/src/preprocessing/preprocessing.md | 9 + examples/preprocessing/complex_shape_2d.jl | 1 + examples/preprocessing/complex_shape_3d.jl | 7 +- examples/preprocessing/packing_2d.jl | 89 + examples/preprocessing/packing_3d.jl | 24 + src/TrixiParticles.jl | 6 +- src/callbacks/update.jl | 4 + src/general/custom_quantities.jl | 2 +- src/general/initial_condition.jl | 53 +- src/preprocessing/geometries/geometries.jl | 52 +- src/preprocessing/geometries/io.jl | 14 +- src/preprocessing/geometries/polygon.jl | 2 + src/preprocessing/geometries/triangle_mesh.jl | 2 + .../particle_packing/nhs_faces.jl | 93 + .../particle_packing/particle_packing.jl | 4 + src/preprocessing/particle_packing/rhs.jl | 35 + .../particle_packing/signed_distance.jl | 290 + src/preprocessing/particle_packing/system.jl | 298 + .../point_in_poly/winding_number_hormann.jl | 6 +- .../point_in_poly/winding_number_jacobson.jl | 6 +- src/preprocessing/preprocessing.jl | 1 + src/schemes/fluid/transport_velocity.jl | 2 +- src/setups/complex_shape.jl | 142 +- test/examples/examples.jl | 14 + .../data/signed_distances_circle.csv | 501 ++ .../data/signed_distances_hexagon.csv | 475 ++ .../data/signed_distances_sphere.csv | 5246 +++++++++++++++++ test/preprocessing/packing/nhs_faces.jl | 104 + test/preprocessing/packing/packing.jl | 2 + test/preprocessing/packing/signed_distance.jl | 138 + test/preprocessing/preprocessing.jl | 1 + 33 files changed, 7576 insertions(+), 85 deletions(-) create mode 100644 examples/preprocessing/packing_2d.jl create mode 100644 examples/preprocessing/packing_3d.jl create mode 100644 src/preprocessing/particle_packing/nhs_faces.jl create mode 100644 src/preprocessing/particle_packing/particle_packing.jl create mode 100644 src/preprocessing/particle_packing/rhs.jl create mode 100644 src/preprocessing/particle_packing/signed_distance.jl create mode 100644 src/preprocessing/particle_packing/system.jl create mode 100644 test/preprocessing/data/signed_distances_circle.csv create mode 100644 test/preprocessing/data/signed_distances_hexagon.csv create mode 100644 test/preprocessing/data/signed_distances_sphere.csv create mode 100644 test/preprocessing/packing/nhs_faces.jl create mode 100644 test/preprocessing/packing/packing.jl create mode 100644 test/preprocessing/packing/signed_distance.jl diff --git a/NEWS.md b/NEWS.md index e60c63e9f..18159ccc6 100644 --- a/NEWS.md +++ b/NEWS.md @@ -3,24 +3,52 @@ TrixiParticles.jl follows the interpretation of [semantic versioning (semver)](https://julialang.github.io/Pkg.jl/dev/compatibility/#Version-specifier-format-1) used in the Julia ecosystem. Notable changes will be documented in this file for human readability. +## Version 0.2.5 + +### Features +- Add particle packing for 2D (.asc) and 3D (.stl) geometries (#529) + +### Compatibility Changes +- Dropped support for Julia 1.9 + +## Version 0.2.4 + +### Features + +- A method to prevent penetration of fast moving particles with solids was added (#498) +- Added the callback `SteadyStateReachedCallback` to detect convergence of static simulations (#601) +- Added ideal gas state equation (#607) +- Simulations can be run with `Float32` (#662) + +### Documentation + +- Documentation for GPU support was added (#660) +- A new user tutorial was added (#514) +- Several docs fixes (#663, #659, #637, #658, #664) + + ## Version 0.2.3 ### Highlights + Transport Velocity Formulation (TVF) based on the work of Ramachandran et al. "Entropically damped artificial compressibility for SPH" (2019) was added. ## Version 0.2.2 ### Highlights + Hotfix for threaded sampling of complex geometries. ## Version 0.2.1 ### Highlights + Particle sampling of complex geometries from `.stl` and `.asc` files. ## Version 0.2.0 ### Removed + Use of the internal neighborhood search has been removed and replaced with PointNeighbors.jl. ## Development Cycle 0.1 @@ -28,26 +56,33 @@ Use of the internal neighborhood search has been removed and replaced with Point ### Highlights #### Discrete Element Method + A basic implementation of the discrete element method was added. #### Surface Tension and Adhesion Model + A surface tension and adhesion model based on the work by Akinci et al., "Versatile Surface Tension and Adhesion for SPH Fluids" (2013) was added to WCSPH. #### Support for Open Boundaries + Open boundaries using the method of characteristics based on the work of Lastiwka et al., "Permeable and non-reflecting boundary conditions in SPH" (2009) were added for WCSPH and EDAC. ## Pre Initial Release (v0.1.0) + This section summarizes the initial features that TrixiParticles.jl was released with. ### Highlights #### EDAC + An implementation of EDAC (Entropically Damped Artificial Compressibility) was added, which allows for more stable simulations compared to basic WCSPH and reduces spurious pressure oscillations. #### WCSPH + An implementation of WCSPH (Weakly Compressible Smoothed Particle Hydrodynamics), which is the classical SPH approach. Features: + - Correction schemes (Shepard (0. Order) ... MixedKernelGradient (1. Order)) - Density reinitialization - Kernel summation and Continuity equation density formulations @@ -57,4 +92,5 @@ Features: #### TLSPH + An implementation of TLSPH (Total Lagrangian Smoothed Particle Hydrodynamics) for solid bodies enabling FSI (Fluid Structure Interactions). diff --git a/Project.toml b/Project.toml index 45f335178..89c2fcba0 100644 --- a/Project.toml +++ b/Project.toml @@ -1,7 +1,7 @@ name = "TrixiParticles" uuid = "66699cd8-9c01-4e9d-a059-b96c86d16b3a" authors = ["erik.faulhaber <44124897+efaulhaber@users.noreply.github.com>"] -version = "0.2.5-dev" +version = "0.2.5" [deps] Adapt = "79e6a3ab-5dfb-504d-930d-738a2a938a0e" diff --git a/docs/src/preprocessing/preprocessing.md b/docs/src/preprocessing/preprocessing.md index 2f6cb7054..a1a7ccd30 100644 --- a/docs/src/preprocessing/preprocessing.md +++ b/docs/src/preprocessing/preprocessing.md @@ -255,3 +255,12 @@ Pages = [joinpath("preprocessing", "point_in_poly", "winding_number_jacobson.jl" Modules = [TrixiParticles] Pages = [joinpath("preprocessing", "geometries", "io.jl")] ``` + +# Particle Packing + +TODO + +```@autodocs +Modules = [TrixiParticles] +Pages = map(file -> joinpath("preprocessing", "particle_packing", file), readdir(joinpath("..", "src", "preprocessing", "particle_packing"))) +``` diff --git a/examples/preprocessing/complex_shape_2d.jl b/examples/preprocessing/complex_shape_2d.jl index 4f5971109..d8e712738 100644 --- a/examples/preprocessing/complex_shape_2d.jl +++ b/examples/preprocessing/complex_shape_2d.jl @@ -21,6 +21,7 @@ shape_sampled = ComplexShape(geometry; particle_spacing, density=1.0, trixi2vtk(shape_sampled.initial_condition) +# trixi2vtk(shape_sampled.signed_distance_field) # trixi2vtk(shape_sampled.grid, w=shape_sampled.winding_numbers) # Plot the winding number field diff --git a/examples/preprocessing/complex_shape_3d.jl b/examples/preprocessing/complex_shape_3d.jl index a0fa1e1ab..e8542a729 100644 --- a/examples/preprocessing/complex_shape_3d.jl +++ b/examples/preprocessing/complex_shape_3d.jl @@ -13,6 +13,9 @@ point_in_geometry_algorithm = WindingNumberJacobson(; geometry, # Returns `InitialCondition` shape_sampled = ComplexShape(geometry; particle_spacing, density=1.0, - point_in_geometry_algorithm) + boundary_thickness=5 * particle_spacing, + create_signed_distance_field=true, + sample_boundary=false, point_in_geometry_algorithm) -trixi2vtk(shape_sampled) +trixi2vtk(shape_sampled.initial_condition, filename="initial_condition_fluid") +trixi2vtk(shape_sampled.signed_distance_field) diff --git a/examples/preprocessing/packing_2d.jl b/examples/preprocessing/packing_2d.jl new file mode 100644 index 000000000..11f64c2a7 --- /dev/null +++ b/examples/preprocessing/packing_2d.jl @@ -0,0 +1,89 @@ +using TrixiParticles +using OrdinaryDiffEq + +filename = "circle" +file = pkgdir(TrixiParticles, "examples", "preprocessing", "data", filename * ".asc") + +# ========================================================================================== +# ==== Packing parameters +save_intervals = false +tlsph = true + +# ========================================================================================== +# ==== Resolution +particle_spacing = 0.03 + +# The following depends on the sampling of the particles. In this case `boundary_thickness` +# means literally the thickness of the boundary packed with boundary particles and *not* +# how many rows of boundary particles will be sampled. +boundary_thickness = 8particle_spacing + +# ========================================================================================== +# ==== Load complex geometry +density = 1000.0 + +geometry = load_geometry(file) + +signed_distance_field = SignedDistanceField(geometry, particle_spacing; + use_for_boundary_packing=true, + max_signed_distance=boundary_thickness) + +point_in_geometry_algorithm = WindingNumberJacobson(; geometry, + winding_number_factor=0.4, + hierarchical_winding=true) +# Returns `InitialCondition` +shape_sampled = ComplexShape(geometry; particle_spacing, density, + point_in_geometry_algorithm) + +# Returns `InitialCondition` +boundary_sampled = sample_boundary(signed_distance_field; boundary_density=density, + boundary_thickness, tlsph) + +trixi2vtk(shape_sampled) +trixi2vtk(boundary_sampled, filename="boundary") + +# ========================================================================================== +# ==== Packing + +# Large `background_pressure` can cause high accelerations. That is, the adaptive +# time-stepsize will be adjusted properly. We found that the following order of +# `background_pressure` result in appropriate stepsizes. +background_pressure = 1e6 * particle_spacing^ndims(geometry) + +packing_system = ParticlePackingSystem(shape_sampled; + signed_distance_field, tlsph=tlsph, + background_pressure) + +boundary_system = ParticlePackingSystem(boundary_sampled; + is_boundary=true, signed_distance_field, + tlsph=tlsph, boundary_compress_factor=0.8, + background_pressure) + +# ========================================================================================== +# ==== Simulation +semi = Semidiscretization(packing_system, boundary_system) + +# Use a high `tspan` to guarantee that the simulation runs at least for `maxiters` +tspan = (0, 10.0) +ode = semidiscretize(semi, tspan) + +# Use this callback to stop the simulation when it is sufficiently close to a steady state +steady_state = SteadyStateReachedCallback(; interval=1, interval_size=10, + abstol=1.0e-5, reltol=1.0e-3) + +info_callback = InfoCallback(interval=50) + +saving_callback = save_intervals ? + SolutionSavingCallback(interval=10, prefix="", ekin=kinetic_energy) : + nothing + +callbacks = CallbackSet(UpdateCallback(), saving_callback, info_callback, steady_state) + +sol = solve(ode, RDPK3SpFSAL35(); + save_everystep=false, maxiters=1000, callback=callbacks, dtmax=1e-2) + +packed_ic = InitialCondition(sol, packing_system, semi) +packed_boundary_ic = InitialCondition(sol, boundary_system, semi) + +trixi2vtk(packed_ic, filename="initial_condition_packed") +trixi2vtk(packed_boundary_ic, filename="initial_condition_boundary_packed") diff --git a/examples/preprocessing/packing_3d.jl b/examples/preprocessing/packing_3d.jl new file mode 100644 index 000000000..3864b8b45 --- /dev/null +++ b/examples/preprocessing/packing_3d.jl @@ -0,0 +1,24 @@ +using TrixiParticles +using OrdinaryDiffEq + +filename = "sphere" +file = pkgdir(TrixiParticles, "examples", "preprocessing", "data", filename * ".stl") + +# ========================================================================================== +# ==== Packing parameters +tlsph = true +save_intervals = false + +# ========================================================================================== +# ==== Resolution +particle_spacing = 0.1 + +# The following depends on the sampling of the particles. In this case `boundary_thickness` +# means literally the thickness of the boundary packed with boundary particles and *not* +# how many rows of boundary particles will be sampled. +boundary_thickness = 8particle_spacing + +trixi_include(joinpath(examples_dir(), "preprocessing", "packing_2d.jl"), + density=1000.0, particle_spacing=particle_spacing, file=file, + boundary_thickness=boundary_thickness, tlsph=tlsph, + save_intervals=save_intervals) diff --git a/src/TrixiParticles.jl b/src/TrixiParticles.jl index d85096860..a50f59ead 100644 --- a/src/TrixiParticles.jl +++ b/src/TrixiParticles.jl @@ -40,7 +40,6 @@ using WriteVTK: vtk_grid, MeshCell, VTKCellTypes, paraview_collection, vtk_save include("general/system.jl") # `util.jl` needs to be next because of the macros `@trixi_timeit` and `@threaded` include("util.jl") -include("preprocessing/preprocessing.jl") include("callbacks/callbacks.jl") include("general/general.jl") include("setups/setups.jl") @@ -52,6 +51,7 @@ include("general/semidiscretization.jl") include("general/gpu.jl") include("visualization/write2vtk.jl") include("visualization/recipes_plots.jl") +include("preprocessing/preprocessing.jl") export Semidiscretization, semidiscretize, restart_with! export InitialCondition @@ -77,8 +77,10 @@ export BoundaryMovement export examples_dir, validation_dir, trixi_include export trixi2vtk export RectangularTank, RectangularShape, SphereShape, ComplexShape +export ParticlePackingSystem, SignedDistanceField export WindingNumberHormann, WindingNumberJacobson -export VoxelSphere, RoundSphere, reset_wall!, extrude_geometry, load_geometry +export VoxelSphere, RoundSphere, reset_wall!, extrude_geometry, load_geometry, + sample_boundary export SourceTermDamping export ShepardKernelCorrection, KernelCorrection, AkinciFreeSurfaceCorrection, GradientCorrection, BlendedGradientCorrection, MixedKernelGradientCorrection diff --git a/src/callbacks/update.jl b/src/callbacks/update.jl index d22622c3d..3ca777e4a 100644 --- a/src/callbacks/update.jl +++ b/src/callbacks/update.jl @@ -85,6 +85,10 @@ function (update_callback!::UpdateCallback)(integrator) update_open_boundary_eachstep!(system, v_ode, u_ode, semi, t) end + @trixi_timeit timer() "update particle packing" foreach_system(semi) do system + update_particle_packing(system, v_ode, u_ode, semi, integrator) + end + @trixi_timeit timer() "update TVF" foreach_system(semi) do system update_transport_velocity!(system, v_ode, semi) end diff --git a/src/general/custom_quantities.jl b/src/general/custom_quantities.jl index ea357b065..c0ec608b1 100644 --- a/src/general/custom_quantities.jl +++ b/src/general/custom_quantities.jl @@ -5,7 +5,7 @@ Returns the total kinetic energy of all particles in a system. """ function kinetic_energy(v, u, t, system) # If `each_moving_particle` is empty (no moving particles), return zero - return sum(each_moving_particle(system), init=0.0) do particle + return sum(each_moving_particle(system), init=zero(eltype(system))) do particle velocity = current_velocity(v, system, particle) return 0.5 * system.mass[particle] * dot(velocity, velocity) end diff --git a/src/general/initial_condition.jl b/src/general/initial_condition.jl index adcc58397..f333da9fd 100644 --- a/src/general/initial_condition.jl +++ b/src/general/initial_condition.jl @@ -326,6 +326,37 @@ end Base.intersect(initial_condition::InitialCondition) = initial_condition +function InitialCondition(sol::ODESolution, system, semi; use_final_velocity=false, + min_particle_distance=system.initial_condition.particle_spacing / + 4) + ic = system.initial_condition + + v_ode, u_ode = sol.u[end].x + + u = wrap_u(u_ode, system, semi) + v = wrap_u(v_ode, system, semi) + + # Check if particles come too close especially when the surface exhibits large curvature + too_close = find_too_close_particles(u, min_particle_distance) + + velocity_ = use_final_velocity ? view(v, 1:ndims(system), :) : ic.velocity + + not_too_close = setdiff(eachparticle(system), too_close) + + coordinates = u[:, not_too_close] + velocity = velocity_[:, not_too_close] + mass = ic.mass[not_too_close] + density = ic.density[not_too_close] + pressure = ic.pressure[not_too_close] + + if length(too_close) > 0 + @info "Removed $(length(too_close)) particles that are too close together" + end + + return InitialCondition{ndims(ic)}(coordinates, velocity, mass, density, pressure, + ic.particle_spacing) +end + # Find particles in `coords1` that are closer than `max_distance` to any particle in `coords2` function find_too_close_particles(coords1, coords2, max_distance) NDIMS = size(coords1, 1) @@ -338,7 +369,27 @@ function find_too_close_particles(coords1, coords2, max_distance) # We are modifying the vector `result`, so this cannot be parallel foreach_point_neighbor(coords1, coords2, nhs, parallel=false) do particle, _, _, _ if !(particle in result) - append!(result, particle) + push!(result, particle) + end + end + + return result +end + +# Find particles in `coords` that are closer than `min_distance` to any other particle in `coords` +function find_too_close_particles(coords, min_distance) + NDIMS = size(coords, 1) + result = Int[] + + nhs = GridNeighborhoodSearch{NDIMS}(search_radius=min_distance, + n_points=size(coords, 2)) + TrixiParticles.initialize!(nhs, coords) + + # We are modifying the vector `result`, so this cannot be parallel + foreach_point_neighbor(coords, coords, nhs, parallel=false) do particle, neighbor, _, _ + # Only consider particles with neighbors that are not to be removed + if particle != neighbor && !(particle in result) && !(neighbor in result) + push!(result, particle) end end diff --git a/src/preprocessing/geometries/geometries.jl b/src/preprocessing/geometries/geometries.jl index dd22de2fe..f18e34418 100644 --- a/src/preprocessing/geometries/geometries.jl +++ b/src/preprocessing/geometries/geometries.jl @@ -4,4 +4,54 @@ include("io.jl") @inline eachface(mesh) = Base.OneTo(nfaces(mesh)) -@inline point_position(A, geometry, i) = extract_svector(A, Val(ndims(geometry)), i) +function Base.setdiff(initial_condition::InitialCondition, + geometries::Union{Polygon, TriangleMesh}...) + geometry = first(geometries) + + if ndims(geometry) != ndims(initial_condition) + throw(ArgumentError("all passed geometries must have the same dimensionality as the initial condition")) + end + + coords = reinterpret(reshape, SVector{ndims(geometry), eltype(geometry)}, + initial_condition.coordinates) + + delete_indices, _ = WindingNumberJacobson(; geometry)(geometry, coords) + + coordinates = initial_condition.coordinates[:, .!delete_indices] + velocity = initial_condition.velocity[:, .!delete_indices] + mass = initial_condition.mass[.!delete_indices] + density = initial_condition.density[.!delete_indices] + pressure = initial_condition.pressure[.!delete_indices] + + result = InitialCondition{ndims(initial_condition)}(coordinates, velocity, mass, + density, pressure, + initial_condition.particle_spacing) + + return setdiff(result, Base.tail(geometries)...) +end + +function Base.intersect(initial_condition::InitialCondition, + geometries::Union{Polygon, TriangleMesh}...) + geometry = first(geometries) + + if ndims(geometry) != ndims(initial_condition) + throw(ArgumentError("all passed geometries must have the same dimensionality as the initial condition")) + end + + coords = reinterpret(reshape, SVector{ndims(geometry), eltype(geometry)}, + initial_condition.coordinates) + + keep_indices, _ = WindingNumberJacobson(; geometry)(geometry, coords) + + coordinates = initial_condition.coordinates[:, keep_indices] + velocity = initial_condition.velocity[:, keep_indices] + mass = initial_condition.mass[keep_indices] + density = initial_condition.density[keep_indices] + pressure = initial_condition.pressure[keep_indices] + + result = InitialCondition{ndims(initial_condition)}(coordinates, velocity, mass, + density, pressure, + initial_condition.particle_spacing) + + return intersect(result, Base.tail(geometries)...) +end diff --git a/src/preprocessing/geometries/io.jl b/src/preprocessing/geometries/io.jl index 964d8d6fc..b08ca002a 100644 --- a/src/preprocessing/geometries/io.jl +++ b/src/preprocessing/geometries/io.jl @@ -88,9 +88,19 @@ end function trixi2vtk(geometry::Polygon; output_directory="out", prefix="", filename="points", custom_quantities...) - vertex_normals = stack([geometry.vertex_normals[edge][1] for edge in eachface(geometry)]) + vertex_normals = Vector{SVector{2, eltype(geometry)}}() + vertices = Vector{SVector{2, eltype(geometry)}}() + + # Add each vertex twice (once at the end of an edge and once at the start of the next edge) + # with corresponding normals to make ParaView work. + for edge in eachface(geometry) + push!(vertex_normals, geometry.vertex_normals[edge][1]) + push!(vertex_normals, geometry.vertex_normals[edge][2]) + push!(vertices, geometry.vertices[geometry.edge_vertices_ids[edge][1]]) + push!(vertices, geometry.vertices[geometry.edge_vertices_ids[edge][2]]) + end - return trixi2vtk(stack(geometry.vertices); output_directory, filename, prefix, + return trixi2vtk(stack(vertices); output_directory, filename, prefix, vertex_normals=vertex_normals, custom_quantities...) end diff --git a/src/preprocessing/geometries/polygon.jl b/src/preprocessing/geometries/polygon.jl index 501584ac7..5c594cc1d 100644 --- a/src/preprocessing/geometries/polygon.jl +++ b/src/preprocessing/geometries/polygon.jl @@ -137,3 +137,5 @@ end return v1, v2 end + +@inline face_normal(edge, geometry::Polygon) = geometry.edge_normals[edge] diff --git a/src/preprocessing/geometries/triangle_mesh.jl b/src/preprocessing/geometries/triangle_mesh.jl index afb362c38..e102f7247 100644 --- a/src/preprocessing/geometries/triangle_mesh.jl +++ b/src/preprocessing/geometries/triangle_mesh.jl @@ -159,6 +159,8 @@ end @inline Base.eltype(::TriangleMesh{NDIMS, ELTYPE}) where {NDIMS, ELTYPE} = ELTYPE +@inline face_normal(triangle, geometry::TriangleMesh) = geometry.face_normals[triangle] + @inline function Base.deleteat!(mesh::TriangleMesh, indices) (; face_vertices, face_vertices_ids, face_edges_ids, face_normals) = mesh diff --git a/src/preprocessing/particle_packing/nhs_faces.jl b/src/preprocessing/particle_packing/nhs_faces.jl new file mode 100644 index 000000000..62c3e54a6 --- /dev/null +++ b/src/preprocessing/particle_packing/nhs_faces.jl @@ -0,0 +1,93 @@ +struct FaceNeighborhoodSearch{NDIMS, CL, ELTYPE} <: + PointNeighbors.AbstractNeighborhoodSearch + cell_list :: CL + neighbors :: CL + search_radius :: ELTYPE + periodic_box :: Nothing # Required by internals of PointNeighbors.jl + n_cells :: NTuple{NDIMS, Int} + cell_size :: NTuple{NDIMS, ELTYPE} # Required to calculate cell index +end + +function FaceNeighborhoodSearch{NDIMS}(; search_radius, + cell_list=PointNeighbors.DictionaryCellList{NDIMS}()) where {NDIMS} + cell_size = ntuple(_ -> search_radius, Val(NDIMS)) + n_cells = ntuple(_ -> -1, Val(NDIMS)) + neighbors = PointNeighbors.copy_cell_list(cell_list, search_radius, nothing) + + return FaceNeighborhoodSearch(cell_list, neighbors, search_radius, nothing, n_cells, + cell_size) +end + +@inline Base.ndims(::FaceNeighborhoodSearch{NDIMS}) where {NDIMS} = NDIMS + +function faces_in_cell(cell, neighborhood_search) + return PointNeighbors.points_in_cell(cell, neighborhood_search) +end + +@inline function eachneighbor(coords, neighborhood_search::FaceNeighborhoodSearch) + cell = PointNeighbors.cell_coords(coords, neighborhood_search) + return neighborhood_search.neighbors[cell] +end + +function initialize!(neighborhood_search::FaceNeighborhoodSearch, geometry; + pad=ntuple(_ -> 1, ndims(geometry))) + (; cell_list, neighbors) = neighborhood_search + + empty!(cell_list) + + # Fill cells with intersecting faces + for face in eachface(geometry) + + # Add face to cells in the face-embedding cell grid + for cell in bounding_box(face, geometry, neighborhood_search) + PointNeighbors.push_cell!(cell_list, Tuple(cell), face) + end + end + + empty!(neighbors) + min_cell = PointNeighbors.cell_coords(geometry.min_corner, neighborhood_search) .- pad + max_cell = PointNeighbors.cell_coords(geometry.max_corner, neighborhood_search) .+ pad + + # Merge all lists of faces in the neighboring cells into one iterator + face_ids = Int[] + for cell_runner in meshgrid(min_cell, max_cell) + resize!(face_ids, 0) + for neighbor in PointNeighbors.neighboring_cells(cell_runner, neighborhood_search) + append!(face_ids, faces_in_cell(Tuple(neighbor), neighborhood_search)) + end + + if isempty(face_ids) + continue + end + + unique!(face_ids) + + for i in face_ids + PointNeighbors.push_cell!(neighbors, Tuple(cell_runner), i) + end + end + + empty!(cell_list) + + return neighborhood_search +end + +@inline function bounding_box(face, geometry, + neighborhood_search::FaceNeighborhoodSearch{NDIMS}) where {NDIMS} + vertices = face_vertices(face, geometry) + + # Compute the cell coordinates for each vertex + cells = (PointNeighbors.cell_coords(v, neighborhood_search) for v in vertices) + + # Compute the element-wise minimum and maximum cell coordinates across all vertices + mins = reduce((a, b) -> min.(a, b), cells) + maxs = reduce((a, b) -> max.(a, b), cells) + + return meshgrid(mins, maxs) +end + +@inline function meshgrid(min_corner::NTuple{NDIMS}, max_corner) where {NDIMS} + # In 2D, this returns Cartesian indices + # {min_corner[1], ..., max_corner[1]} × {min_corner[2], ..., max_corner[2]}. + return CartesianIndices(ntuple(i -> (min_corner[i]):(max_corner[i]), NDIMS)) +end diff --git a/src/preprocessing/particle_packing/particle_packing.jl b/src/preprocessing/particle_packing/particle_packing.jl new file mode 100644 index 000000000..c0ffd2b8d --- /dev/null +++ b/src/preprocessing/particle_packing/particle_packing.jl @@ -0,0 +1,4 @@ +include("nhs_faces.jl") +include("signed_distance.jl") +include("system.jl") +include("rhs.jl") diff --git a/src/preprocessing/particle_packing/rhs.jl b/src/preprocessing/particle_packing/rhs.jl new file mode 100644 index 000000000..4f588f3df --- /dev/null +++ b/src/preprocessing/particle_packing/rhs.jl @@ -0,0 +1,35 @@ +function interact!(dv, v_particle_system, u_particle_system, + v_neighbor_system, u_neighbor_system, neighborhood_search, + system::ParticlePackingSystem, neighbor_system::ParticlePackingSystem) + system_coords = current_coordinates(u_particle_system, system) + neighbor_coords = current_coordinates(u_neighbor_system, neighbor_system) + + # Loop over all pairs of particles and neighbors within the kernel cutoff + foreach_point_neighbor(system, neighbor_system, system_coords, neighbor_coords, + neighborhood_search) do particle, neighbor, pos_diff, distance + # Only consider particles with a distance > 0 + distance < sqrt(eps()) && return + + rho_a = system.initial_condition.density[particle] + rho_b = neighbor_system.initial_condition.density[neighbor] + + m_a = system.initial_condition.mass[particle] + m_b = neighbor_system.initial_condition.mass[neighbor] + + V_a = m_a / rho_a + V_b = m_b / rho_b + + p_b = system.background_pressure + + grad_kernel = smoothing_kernel_grad(system, pos_diff, distance) + + # This vanishes for uniform particle distributions + dv_repulsive_pressure = -(2 / m_a) * V_a * V_b * p_b * grad_kernel + + for i in 1:ndims(system) + dv[i, particle] += dv_repulsive_pressure[i] + end + end + + return dv +end diff --git a/src/preprocessing/particle_packing/signed_distance.jl b/src/preprocessing/particle_packing/signed_distance.jl new file mode 100644 index 000000000..0a48de208 --- /dev/null +++ b/src/preprocessing/particle_packing/signed_distance.jl @@ -0,0 +1,290 @@ +""" + SignedDistanceField(geometry, particle_spacing; + points=nothing, + max_signed_distance=4 * particle_spacing, + use_for_boundary_packing=false) + +Generate particles along a surface of a complex geometry storing the signed distances and normals +to this surface. + +# Arguments +- `geometry`: Geometry returned by [`load_geometry`](@ref). +- `particle_spacing`: Spacing between the particles. + +# Keywords +- `max_signed_distance`: Maximum signed distance to be stored. That is, only particles with a + distance of `abs(max_signed_distance)` to the surface of the shape + will be sampled. +- `points`: Points on which the signed distance is computed. + When set to `nothing` (default), the bounding box of the shape will be + sampled with a uniform grid of points. +- `use_for_boundary_packing`: Set to `true` if [`SignedDistanceField`] is used to pack + a boundary [`ParticlePackingSystem`](@ref). + Use the default of `false` when packing without a boundary. +""" +struct SignedDistanceField{NDIMS, ELTYPE} + positions :: Vector{SVector{NDIMS, ELTYPE}} + normals :: Vector{SVector{NDIMS, ELTYPE}} + distances :: Vector{ELTYPE} + max_signed_distance :: ELTYPE + boundary_packing :: Bool + particle_spacing :: ELTYPE + + function SignedDistanceField(geometry, particle_spacing; + points=nothing, + max_signed_distance=4 * particle_spacing, + use_for_boundary_packing=false) + NDIMS = ndims(geometry) + ELTYPE = eltype(max_signed_distance) + + sdf_factor = use_for_boundary_packing ? 2 : 1 + + search_radius = sdf_factor * max_signed_distance + + nhs = FaceNeighborhoodSearch{NDIMS}(; search_radius) + + initialize!(nhs, geometry) + + if isnothing(points) + min_corner = geometry.min_corner .- search_radius + max_corner = geometry.max_corner .+ search_radius + + n_particles_per_dimension = Tuple(ceil.(Int, + (max_corner .- min_corner) ./ + particle_spacing)) + + grid = rectangular_shape_coords(particle_spacing, n_particles_per_dimension, + min_corner; tlsph=true) + + points = reinterpret(reshape, SVector{NDIMS, ELTYPE}, grid) + end + + positions = copy(points) + + # This gives a performance boost for large geometries + delete_positions_in_empty_cells!(positions, nhs) + + normals = fill(SVector(ntuple(dim -> Inf, NDIMS)), length(positions)) + distances = fill(Inf, length(positions)) + + calculate_signed_distances!(positions, distances, normals, + geometry, sdf_factor, max_signed_distance, nhs) + + return new{NDIMS, ELTYPE}(positions, normals, distances, max_signed_distance, + use_for_boundary_packing, particle_spacing) + end +end + +@inline Base.ndims(::SignedDistanceField{NDIMS}) where {NDIMS} = NDIMS + +function Base.show(io::IO, system::SignedDistanceField) + @nospecialize system # reduce precompilation time + + print(io, "SignedDistanceField{", ndims(system), "}()") +end + +function Base.show(io::IO, ::MIME"text/plain", system::SignedDistanceField) + @nospecialize system # reduce precompilation time + + if get(io, :compact, false) + show(io, system) + else + summary_header(io, "SignedDistanceField{$(ndims(system))}") + summary_line(io, "#particles", length(system.distances)) + summary_line(io, "max signed distance", system.max_signed_distance) + summary_footer(io) + end +end + +function trixi2vtk(signed_distance_field::SignedDistanceField; + filename="signed_distance_field", output_directory="out") + (; positions, distances, normals) = signed_distance_field + positions = stack(signed_distance_field.positions) + + trixi2vtk(positions, signed_distances=distances, normals=normals, + filename=filename, output_directory=output_directory) +end + +function delete_positions_in_empty_cells!(positions, nhs::FaceNeighborhoodSearch) + delete_positions = fill(false, length(positions)) + + @threaded positions for point in eachindex(positions) + if isempty(eachneighbor(positions[point], nhs)) + delete_positions[point] = true + end + end + + deleteat!(positions, delete_positions) + + return positions +end + +function calculate_signed_distances!(positions, distances, normals, + boundary, sdf_factor, max_signed_distance, nhs) + @threaded positions for point in eachindex(positions) + point_coords = positions[point] + + for face in eachneighbor(point_coords, nhs) + sign_bit, distance, normal = signed_point_face_distance(point_coords, boundary, + face) + + if distance < distances[point]^2 + # Found a face closer than the previous closest face + distances[point] = sign_bit ? -sqrt(distance) : sqrt(distance) + normals[point] = normal + end + end + end + + # Keep "larger" signed distance field outside `boundary` to guarantee + # compact support for boundary particles. + keep = -max_signed_distance .< distances .< sdf_factor * max_signed_distance + delete_indices = .!keep + + deleteat!(distances, delete_indices) + deleteat!(normals, delete_indices) + deleteat!(positions, delete_indices) + + return positions +end + +function signed_point_face_distance(p::SVector{2}, boundary, edge_index) + (; edge_vertices, vertex_normals, edge_normals) = boundary + + n = edge_normals[edge_index] + + a = edge_vertices[edge_index][1] + b = edge_vertices[edge_index][2] + + ab = b - a + ap = p - a + + na = vertex_normals[edge_index][1] + nb = vertex_normals[edge_index][2] + + dot1 = dot(ab, ab) + dot2 = dot(ap, ab) + + # Calculate projection of `ap` to `ab` + proj = dot2 / dot1 + + if proj <= 0 + # Closest point is `a` + return signbit(dot(ap, na)), dot(ap, ap), na + end + + if proj >= 1 + bp = p - b + # Closest point is `b` + return signbit(dot(bp, nb)), dot(bp, bp), nb + end + + # Closest point is on `ab` + v = p - (a + proj * ab) + + return signbit(dot(v, n)), dot(v, v), n +end + +# Reference: +# Christer Ericson’s Real-time Collision Detection book +# https://www.r-5.org/files/books/computers/algo-list/realtime-3d/Christer_Ericson-Real-Time_Collision_Detection-EN.pdf +# +# Andreas Bærentzen et al (2002): Generating signed distance fields from triangle meshes +# https://www.researchgate.net/publication/251839082_Generating_Signed_Distance_Fields_From_Triangle_Meshes +# +# Inspired by https://github.com/embree/embree/blob/master/tutorials/common/math/closest_point.h +function signed_point_face_distance(p::SVector{3}, boundary, face_index) + (; face_vertices, face_vertices_ids, edge_normals, + face_edges_ids, face_normals, vertex_normals) = boundary + + a = face_vertices[face_index][1] + b = face_vertices[face_index][2] + c = face_vertices[face_index][3] + + n = face_normals[face_index] + + v1 = face_vertices_ids[face_index][1] + v2 = face_vertices_ids[face_index][2] + v3 = face_vertices_ids[face_index][3] + + e1 = face_edges_ids[face_index][1] + e2 = face_edges_ids[face_index][2] + e3 = face_edges_ids[face_index][3] + + na = vertex_normals[v1] + nb = vertex_normals[v2] + nc = vertex_normals[v3] + + nab = edge_normals[e1] + nbc = edge_normals[e2] + nac = edge_normals[e3] + + ab = b - a + ac = c - a + ap = p - a + + dot1 = dot(ab, ap) + dot2 = dot(ac, ap) + + # Region 1: point `a` + (dot1 <= 0 && dot2 <= 0) && return signbit(dot(ap, na)), dot(ap, ap), na + + bp = p - b + + dot3 = dot(ab, bp) + dot4 = dot(ac, bp) + + # Region 2: point `b` + (dot3 >= 0 && dot4 <= dot3) && return signbit(dot(bp, nb)), dot(bp, bp), nb + + cp = p - c + + dot5 = dot(ab, cp) + dot6 = dot(ac, cp) + + # Region 3: point `c` + (dot6 >= 0 && dot5 <= dot6) && return signbit(dot(cp, nc)), dot(cp, cp), nc + + vc = dot1 * dot4 - dot3 * dot2 + + if vc <= 0 && dot1 >= 0 && dot3 <= 0 + t = dot1 / (dot1 - dot3) + + v = p - (a + t * ab) + + # Region 4: edge `ab` + return signbit(dot(v, nab)), dot(v, v), nab + end + + vb = dot5 * dot2 - dot1 * dot6 + + if vb <= 0 && dot2 >= 0 && dot6 <= 0 + t = dot2 / (dot2 - dot6) + + v = p - (a + t * ac) + + # Region 5: edge `ac` + return signbit(dot(v, nac)), dot(v, v), nac + end + + va = dot3 * dot6 - dot5 * dot4 + + if va <= 0 && (dot4 - dot3) >= 0 && (dot5 - dot6) >= 0 + t = (dot4 - dot3) / ((dot4 - dot3) + (dot5 - dot6)) + + v = p - (b + t * (c - b)) + + # Region 6: edge `bc` + return signbit(dot(v, nbc)), dot(v, v), nbc + end + + # Region 0: triangle + denom = 1 / (va + vb + vc) + + u = vb * denom + w = vc * denom + + d = p - (a + u * ab + w * ac) + + return signbit(dot(d, n)), dot(d, d), n +end diff --git a/src/preprocessing/particle_packing/system.jl b/src/preprocessing/particle_packing/system.jl new file mode 100644 index 000000000..efdd4cdcc --- /dev/null +++ b/src/preprocessing/particle_packing/system.jl @@ -0,0 +1,298 @@ +""" + ParticlePackingSystem(shape::InitialCondition; + signed_distance_field::SignedDistanceField, + smoothing_kernel=SchoenbergCubicSplineKernel{ndims(shape)}(), + smoothing_length=1.2 * shape.particle_spacing, + is_boundary=false, boundary_compress_factor=1.0, + neighborhood_search=GridNeighborhoodSearch{ndims(shape)}(), + background_pressure, tlsph=true) + +System to generate body-fitted particles for complex shapes. +For more information on the methods, see description below. + +# Arguments +- `shape`: [`InitialCondition`](@ref) to be packed. + +# Keywords +- `background_pressure`: Constant background pressure to physically pack the particles. + A large `background_pressure` can cause high accelerations + which requires a properly adjusted time step. +- `tlsph`: With the [`TotalLagrangianSPHSystem`](@ref), particles need to be placed + on the boundary of the shape and not half a particle spacing away, + as for fluids. When `tlsph=true`, particles will be placed + on the boundary of the shape. +- `is_boundary`: When `shape` is inside the geometry that was used to create + `signed_distance_field, set `is_boundary=false`. + Otherwise (`shape` is the sampled boundary), set `is_boundary=true`. + The thickness of the boundary is specified by creating + `signed_distance_field` with: + - `use_for_boundary_packing=true` + - `max_signed_distance=boundary_thickness` + See [`SignedDistanceField`](@ref). +- `signed_distance_field`: To constrain particles onto the surface, the information about + the signed distance from a particle to a face is required. + The precalculated signed distances will be interpolated + to each particle during the packing procedure. +- `smoothing_kernel`: Smoothing kernel to be used for this system. + See [Smoothing Kernels](@ref smoothing_kernel). +- `smoothing_length`: Smoothing length to be used for this system. + See [Smoothing Kernels](@ref smoothing_kernel). +""" +struct ParticlePackingSystem{NDIMS, ELTYPE <: Real, IC, K, + S, N} <: FluidSystem{NDIMS, IC} + initial_condition :: IC + smoothing_kernel :: K + smoothing_length :: ELTYPE + background_pressure :: ELTYPE + tlsph :: Bool + signed_distance_field :: S + is_boundary :: Bool + shift_length :: ELTYPE + neighborhood_search :: N + signed_distances :: Vector{ELTYPE} # Only for visualization + buffer :: Nothing + update_callback_used :: Ref{Bool} + + function ParticlePackingSystem(shape::InitialCondition; + signed_distance_field::SignedDistanceField, + smoothing_kernel=SchoenbergCubicSplineKernel{ndims(shape)}(), + smoothing_length=1.2 * shape.particle_spacing, + is_boundary=false, boundary_compress_factor=1.0, + neighborhood_search=GridNeighborhoodSearch{ndims(shape)}(), + background_pressure, tlsph=true) + NDIMS = ndims(shape) + ELTYPE = eltype(shape) + + if ndims(smoothing_kernel) != NDIMS + throw(ArgumentError("smoothing kernel dimensionality must be $NDIMS for a $(NDIMS)D problem")) + end + + # TODO: Let `Semidiscretization` handle this? + # Create neighborhood search + nhs_ = isnothing(neighborhood_search) ? TrivialNeighborhoodSearch{NDIMS}() : + neighborhood_search + nhs = copy_neighborhood_search(nhs_, + compact_support(smoothing_kernel, smoothing_length), + length(signed_distance_field.positions)) + + # Initialize neighborhood search with signed distances + PointNeighbors.initialize_grid!(nhs, stack(signed_distance_field.positions)) + + # If `distance_signed >= -shift_length`, the particle position is modified + # by a surface bounding: + # `particle_position -= (distance_signed + shift_length) * normal_vector`, + # where `normal_vector` is the normal vector to the surface of the geometry + # and `distance_signed` is the level-set value at the particle position, + # which means the signed distance to the surface. + # Its value is negative if the particle is inside the geometry. + # Otherwise (if outside), the value is positive. + shift_length = if is_boundary + -boundary_compress_factor * signed_distance_field.max_signed_distance + else + tlsph ? zero(ELTYPE) : 0.5shape.particle_spacing + end + + return new{NDIMS, ELTYPE, typeof(shape), typeof(smoothing_kernel), + typeof(signed_distance_field), + typeof(nhs)}(shape, smoothing_kernel, smoothing_length, + background_pressure, tlsph, signed_distance_field, + is_boundary, shift_length, nhs, + fill(zero(ELTYPE), nparticles(shape)), nothing, false) + end +end + +function Base.show(io::IO, system::ParticlePackingSystem) + @nospecialize system # reduce precompilation time + + print(io, "ParticlePackingSystem{", ndims(system), "}(") + print(io, ", ", system.smoothing_kernel) + print(io, ") with ", nparticles(system), " particles") +end + +function Base.show(io::IO, ::MIME"text/plain", system::ParticlePackingSystem) + @nospecialize system # reduce precompilation time + + if get(io, :compact, false) + show(io, system) + else + summary_header(io, "ParticlePackingSystem{$(ndims(system))}") + summary_line(io, "neighborhood search", + system.neighborhood_search |> typeof |> nameof) + summary_line(io, "#particles", nparticles(system)) + summary_line(io, "smoothing kernel", system.smoothing_kernel |> typeof |> nameof) + summary_line(io, "tlsph", system.tlsph ? "yes" : "no") + summary_line(io, "boundary", system.is_boundary ? "yes" : "no") + summary_footer(io) + end +end + +@inline function v_nvariables(system::ParticlePackingSystem) + return ndims(system) * 2 +end + +function reset_callback_flag!(system::ParticlePackingSystem) + system.update_callback_used[] = false + + return system +end + +update_callback_used!(system::ParticlePackingSystem) = system.update_callback_used[] = true + +function write2vtk!(vtk, v, u, t, system::ParticlePackingSystem; write_meta_data=true) + if write_meta_data + vtk["signed_distances"] = system.signed_distances + end +end + +write_v0!(v0, system::ParticlePackingSystem) = v0 .= zero(eltype(system)) + +function kinetic_energy(v, u, t, system::ParticlePackingSystem) + (; initial_condition, is_boundary) = system + + # Exclude boundary packing system + is_boundary && return zero(eltype(system)) + + # If `each_moving_particle` is empty (no moving particles), return zero + return sum(each_moving_particle(system), init=zero(eltype(system))) do particle + velocity = advection_velocity(v, system, particle) + return initial_condition.mass[particle] * dot(velocity, velocity) / 2 + end +end + +@inline source_terms(system::ParticlePackingSystem) = nothing +@inline add_acceleration!(dv, particle, system::ParticlePackingSystem) = dv + +# Number of particles in the system +@inline nparticles(system::ParticlePackingSystem) = length(system.initial_condition.mass) + +@inline function hydrodynamic_mass(system::ParticlePackingSystem, particle) + return system.initial_condition.mass[particle] +end + +# Update from `UpdateCallback` (between time steps) +update_particle_packing(system, v_ode, u_ode, semi, integrator) = system + +# Update from `UpdateCallback` (between time steps) +function update_particle_packing(system::ParticlePackingSystem, v_ode, u_ode, + semi, integrator) + u = wrap_u(u_ode, system, semi) + + update_position!(u, system) +end + +function update_position!(u, system::ParticlePackingSystem) + func_name = "constrain outside particles onto surface" + @trixi_timeit timer() func_name constrain_particles_onto_surface!(u, system) + + return u +end + +function update_final!(system::ParticlePackingSystem, v, u, v_ode, u_ode, semi, t; + update_from_callback=false) + if !update_from_callback && !(system.update_callback_used[]) + throw(ArgumentError("`UpdateCallback` is required when using `ParticlePackingSystem`")) + end + + return system +end + +function constrain_particles_onto_surface!(u, system::ParticlePackingSystem) + (; neighborhood_search, signed_distance_field) = system + (; positions, distances, normals) = signed_distance_field + + search_radius2 = compact_support(system, system)^2 + + @threaded system for particle in eachparticle(system) + particle_position = current_coords(u, system, particle) + + volume = zero(eltype(system)) + distance_signed = zero(eltype(system)) + normal_vector = fill(volume, SVector{ndims(system), eltype(system)}) + + # Interpolate signed distances and normals + for neighbor in PointNeighbors.eachneighbor(particle_position, neighborhood_search) + pos_diff = positions[neighbor] - particle_position + distance2 = dot(pos_diff, pos_diff) + distance2 > search_radius2 && continue + + distance = sqrt(distance2) + kernel_weight = smoothing_kernel(system, distance) + + distance_signed += distances[neighbor] * kernel_weight + + normal_vector += normals[neighbor] * kernel_weight + + volume += kernel_weight + end + + if volume > eps() + distance_signed /= volume + normal_vector /= volume + + # Store signed distance for visualization + system.signed_distances[particle] = distance_signed + + constrain_particle!(u, system, particle, distance_signed, normal_vector) + end + end + + return u +end + +function constrain_particle!(u, system, particle, distance_signed, normal_vector) + (; shift_length) = system + + # For fluid particles: + # - `tlsph = true`: `shift_length = 0.0` + # - `tlsph = false`: `shift_length = 0.5 * particle_spacing` + # For boundary particles: + # `shift_length` is the thickness of the boundary. + if distance_signed >= -shift_length + # Constrain outside particles onto surface + shift = (distance_signed + shift_length) * normal_vector + + for dim in 1:ndims(system) + u[dim, particle] -= shift[dim] + end + end + + system.is_boundary || return u + + particle_spacing = system.initial_condition.particle_spacing + shift_length_inner = system.tlsph ? particle_spacing : 0.5 * particle_spacing + + if distance_signed < shift_length_inner + shift = (distance_signed - shift_length_inner) * normal_vector + + for dim in 1:ndims(system) + u[dim, particle] -= shift[dim] + end + end + + return u +end + +# Update from `UpdateCallback` (between time steps) +@inline function update_transport_velocity!(system::ParticlePackingSystem, v_ode, semi) + v = wrap_v(v_ode, system, semi) + @threaded system for particle in each_moving_particle(system) + for i in 1:ndims(system) + v[ndims(system) + i, particle] = v[i, particle] + + # The particle velocity is set to zero at the beginning of each time step to + # achieve a fully stationary state. + v[i, particle] = zero(eltype(system)) + end + end + + return system +end + +# Add advection velocity. +@inline function add_velocity!(du, v, particle, system::ParticlePackingSystem) + for i in 1:ndims(system) + du[i, particle] = v[ndims(system) + i, particle] + end + + return du +end diff --git a/src/preprocessing/point_in_poly/winding_number_hormann.jl b/src/preprocessing/point_in_poly/winding_number_hormann.jl index 9d87cfdc5..a034bbc16 100644 --- a/src/preprocessing/point_in_poly/winding_number_hormann.jl +++ b/src/preprocessing/point_in_poly/winding_number_hormann.jl @@ -16,7 +16,7 @@ function (point_in_poly::WindingNumberHormann)(geometry, points; store_winding_n (; edge_vertices) = geometry # We cannot use a `BitVector` here, as writing to a `BitVector` is not thread-safe - inpoly = fill(false, size(points, 2)) + inpoly = fill(false, length(points)) winding_numbers = Float64[] store_winding_number && (winding_numbers = resize!(winding_numbers, length(inpoly))) @@ -28,9 +28,9 @@ function (point_in_poly::WindingNumberHormann)(geometry, points; store_winding_n (v[1] >= p[1] && v[2] < p[2]) && return 3 end - @threaded points for query_point in axes(points, 2) + @threaded points for query_point in eachindex(points) + v_query = points[query_point] winding_number = 0 - v_query = point_position(points, geometry, query_point) for edge in eachface(geometry) v1 = edge_vertices[edge][1] diff --git a/src/preprocessing/point_in_poly/winding_number_jacobson.jl b/src/preprocessing/point_in_poly/winding_number_jacobson.jl index 2a1a91200..d44e61634 100644 --- a/src/preprocessing/point_in_poly/winding_number_jacobson.jl +++ b/src/preprocessing/point_in_poly/winding_number_jacobson.jl @@ -106,15 +106,15 @@ function (point_in_poly::WindingNumberJacobson)(geometry, points; (; winding_number_factor, winding) = point_in_poly # We cannot use a `BitVector` here, as writing to a `BitVector` is not thread-safe - inpoly = fill(false, size(points, 2)) + inpoly = fill(false, length(points)) winding_numbers = Float64[] store_winding_number && (winding_numbers = resize!(winding_numbers, length(inpoly))) divisor = ndims(geometry) == 2 ? 2pi : 4pi - @threaded points for query_point in axes(points, 2) - p = point_position(points, geometry, query_point) + @threaded points for query_point in eachindex(points) + p = points[query_point] winding_number = winding(geometry, p) / divisor diff --git a/src/preprocessing/preprocessing.jl b/src/preprocessing/preprocessing.jl index f575048b4..c538280bb 100644 --- a/src/preprocessing/preprocessing.jl +++ b/src/preprocessing/preprocessing.jl @@ -1,2 +1,3 @@ include("geometries/geometries.jl") include("point_in_poly/point_in_poly.jl") +include("particle_packing/particle_packing.jl") diff --git a/src/schemes/fluid/transport_velocity.jl b/src/schemes/fluid/transport_velocity.jl index bc8fdf005..70007b328 100644 --- a/src/schemes/fluid/transport_velocity.jl +++ b/src/schemes/fluid/transport_velocity.jl @@ -32,7 +32,7 @@ end @inline function update_transport_velocity!(system, v_ode, semi, ::TransportVelocityAdami) v = wrap_v(v_ode, system, semi) - for particle in each_moving_particle(system) + @threaded system for particle in each_moving_particle(system) for i in 1:ndims(system) v[ndims(system) + i, particle] = v[i, particle] end diff --git a/src/setups/complex_shape.jl b/src/setups/complex_shape.jl index e85065988..72ad79010 100644 --- a/src/setups/complex_shape.jl +++ b/src/setups/complex_shape.jl @@ -41,7 +41,7 @@ For more information about the method see [`WindingNumberJacobson`](@ref) or [`W !!! warning "Experimental Implementation" This is an experimental feature and may change in any future releases. """ -function ComplexShape(geometry::Union{TriangleMesh, Polygon}; particle_spacing, density, +function ComplexShape(geometry; particle_spacing, density, pressure=0.0, mass=nothing, velocity=zeros(ndims(geometry)), point_in_geometry_algorithm=WindingNumberJacobson(; geometry, hierarchical_winding=true, @@ -56,33 +56,86 @@ function ComplexShape(geometry::Union{TriangleMesh, Polygon}; particle_spacing, throw(ArgumentError("only a positive `grid_offset` is supported")) end - return sample(geometry; particle_spacing, density, pressure, mass, velocity, - point_in_geometry_algorithm, store_winding_number, grid_offset, - max_nparticles, padding=pad_initial_particle_grid) -end - -function sample(geometry; particle_spacing, density, pressure=0.0, mass=nothing, - velocity=zeros(ndims(geometry)), - point_in_geometry_algorithm=WindingNumberJacobson(; geometry, - hierarchical_winding=false, - winding_number_factor=sqrt(eps())), - store_winding_number=false, grid_offset::Real=0.0, max_nparticles=10^7, - padding=2particle_spacing) - grid = particle_grid(geometry, particle_spacing; padding, grid_offset, max_nparticles) + grid = particle_grid(geometry, particle_spacing; padding=pad_initial_particle_grid, + grid_offset, max_nparticles) inpoly, winding_numbers = point_in_geometry_algorithm(geometry, grid; store_winding_number) - coordinates = grid[:, inpoly] - ic = InitialCondition(; coordinates, density, mass, velocity, pressure, - particle_spacing) + coordinates = stack(grid[inpoly]) + + initial_condition = InitialCondition(; coordinates, density, mass, velocity, pressure, + particle_spacing) # This is most likely only useful for debugging. Note that this is not public API. if store_winding_number - return (initial_condition=ic, winding_numbers=winding_numbers, grid=grid) + return (initial_condition=initial_condition, winding_numbers=winding_numbers, + grid=stack(grid)) + end + + return initial_condition +end + +""" + sample_boundary(signed_distance_field::SignedDistanceField; + boundary_thickness::Real, tlsph=true) + +Sample boundary particles of a complex geometry by using the [`SignedDistanceField`](@ref) +of the geometry. + +# Arguments +- `signed_distance_field`: The signed distance field of a geometry (see [`SignedDistanceField`](@ref)). + +# Keywords +- `boundary_thickness`: Thickness of the boundary +- `tlsph` : When `tlsph=true`, boundary particles will be placed + one particle spacing from the surface of the geometry. + Otherwise when `tlsph=true` (simulating fluid particles), + boundary particles will be placed half particle spacing away from the surface. + + +# Examples +```jldoctest; output = false, setup = :(particle_spacing = 0.03; boundary_thickness = 4 * particle_spacing; file = joinpath(pkgdir(TrixiParticles, "examples", "preprocessing", "data"), "circle.asc")) +geometry = load_geometry(file) + +signed_distance_field = SignedDistanceField(geometry, particle_spacing; + use_for_boundary_packing=true, + max_signed_distance=boundary_thickness) + +boundary_sampled = sample_boundary(signed_distance_field; boundary_density=1.0, + boundary_thickness) + +# output +┌──────────────────────────────────────────────────────────────────────────────────────────────────┐ +│ InitialCondition{Float64} │ +│ ═════════════════════════ │ +│ #dimensions: ……………………………………………… 2 │ +│ #particles: ………………………………………………… 677 │ +│ particle spacing: ………………………………… 0.03 │ +└──────────────────────────────────────────────────────────────────────────────────────────────────┘ +``` +""" +function sample_boundary(signed_distance_field; + boundary_density, boundary_thickness, tlsph=true) + (; max_signed_distance, boundary_packing, + positions, distances, particle_spacing) = signed_distance_field + + if !(boundary_packing) + throw(ArgumentError("`SignedDistanceField` was not generated with `use_for_boundary_packing`")) + end + + if boundary_thickness > max_signed_distance + throw(ArgumentError("`boundary_thickness` is greater than `max_signed_distance` of `SignedDistanceField`. " * + "Please generate a `SignedDistanceField` with higher `max_signed_distance`.")) end - return ic + # Only keep the required part of the signed distance field + distance_to_boundary = tlsph ? particle_spacing : 0.5 * particle_spacing + keep_indices = (distance_to_boundary .< distances .<= max_signed_distance) + + boundary_coordinates = stack(positions[keep_indices]) + return InitialCondition(; coordinates=boundary_coordinates, density=boundary_density, + particle_spacing) end function particle_grid(geometry, particle_spacing; @@ -102,54 +155,7 @@ function particle_grid(geometry, particle_spacing; "`max_nparticles` = $max_nparticles")) end - return rectangular_shape_coords(particle_spacing, n_particles_per_dimension, + grid = rectangular_shape_coords(particle_spacing, n_particles_per_dimension, min_corner; tlsph=true) -end - -function Base.setdiff(initial_condition::InitialCondition, - geometries::Union{Polygon, TriangleMesh}...) - geometry = first(geometries) - - if ndims(geometry) != ndims(initial_condition) - throw(ArgumentError("all passed geometries must have the same dimensionality as the initial condition")) - end - - delete_indices, _ = WindingNumberJacobson(; geometry)(geometry, - initial_condition.coordinates) - - coordinates = initial_condition.coordinates[:, .!delete_indices] - velocity = initial_condition.velocity[:, .!delete_indices] - mass = initial_condition.mass[.!delete_indices] - density = initial_condition.density[.!delete_indices] - pressure = initial_condition.pressure[.!delete_indices] - - result = InitialCondition{ndims(initial_condition)}(coordinates, velocity, mass, - density, pressure, - initial_condition.particle_spacing) - - return setdiff(result, Base.tail(geometries)...) -end - -function Base.intersect(initial_condition::InitialCondition, - geometries::Union{Polygon, TriangleMesh}...) - geometry = first(geometries) - - if ndims(geometry) != ndims(initial_condition) - throw(ArgumentError("all passed geometries must have the same dimensionality as the initial condition")) - end - - keep_indices, _ = WindingNumberJacobson(; geometry)(geometry, - initial_condition.coordinates) - - coordinates = initial_condition.coordinates[:, keep_indices] - velocity = initial_condition.velocity[:, keep_indices] - mass = initial_condition.mass[keep_indices] - density = initial_condition.density[keep_indices] - pressure = initial_condition.pressure[keep_indices] - - result = InitialCondition{ndims(initial_condition)}(coordinates, velocity, mass, - density, pressure, - initial_condition.particle_spacing) - - return intersect(result, Base.tail(geometries)...) + return reinterpret(reshape, SVector{ndims(geometry), eltype(geometry)}, grid) end diff --git a/test/examples/examples.jl b/test/examples/examples.jl index b80e18353..b6d3b9f2e 100644 --- a/test/examples/examples.jl +++ b/test/examples/examples.jl @@ -479,6 +479,20 @@ @test sol.retcode == ReturnCode.Success end end + + @testset verbose=true "Preprocessing" begin + @trixi_testset "preprocessing/packing_2d.jl" begin + @test_nowarn_mod trixi_include(@__MODULE__, + joinpath(examples_dir(), "preprocessing", + "packing_2d.jl")) + @test sol.retcode == ReturnCode.Terminated + end + @trixi_testset "preprocessing/packing_3d.jl" begin + @test_nowarn_mod trixi_include(@__MODULE__, + joinpath(examples_dir(), "preprocessing", + "packing_3d.jl")) + end + end end @testset verbose=true "DEM" begin diff --git a/test/preprocessing/data/signed_distances_circle.csv b/test/preprocessing/data/signed_distances_circle.csv new file mode 100644 index 000000000..391fa0ac3 --- /dev/null +++ b/test/preprocessing/data/signed_distances_circle.csv @@ -0,0 +1,501 @@ +"signed_distances","normals:0","normals:1","Points:0","Points:1","Points:2" +0.39369,-0.35451,-0.93505,-0.49913,-1.2999,0 +0.36021,-0.25939,-0.96577,-0.39914,-1.2999,0 +0.33427,-0.25939,-0.96577,-0.29913,-1.2999,0 +0.31627,-0.16168,-0.98684,-0.19914,-1.2999,0 +0.30482,-0.062346,-0.99805,-0.099135,-1.2999,0 +0.30029,0.037596,-0.99929,0.000865,-1.2999,0 +0.30405,0.087496,-0.99616,0.10086,-1.2999,0 +0.31644,0.13718,-0.99055,0.20087,-1.2999,0 +0.33547,0.23539,-0.9719,0.30086,-1.2999,0 +0.36058,0.28366,-0.95892,0.40087,-1.2999,0 +0.39369,0.33123,-0.94355,0.50087,-1.2999,0 +0.38915,-0.53321,-0.84598,-0.69914,-1.1999,0 +0.34243,-0.44608,-0.89499,-0.59913,-1.1999,0 +0.30019,-0.35451,-0.93505,-0.49913,-1.1999,0 +0.26475,-0.30733,-0.9516,-0.39914,-1.1999,0 +0.2377,-0.25939,-0.96577,-0.29913,-1.1999,0 +0.21758,-0.16168,-0.98684,-0.19914,-1.1999,0 +0.20502,-0.062346,-0.99805,-0.099135,-1.1999,0 +0.20036,0.037596,-0.99929,0.000865,-1.1999,0 +0.2042,0.087496,-0.99616,0.10086,-1.1999,0 +0.21738,0.13718,-0.99055,0.20087,-1.1999,0 +0.23828,0.23539,-0.9719,0.30086,-1.1999,0 +0.26622,0.33123,-0.94355,0.40087,-1.1999,0 +0.30039,0.37797,-0.92582,0.50087,-1.1999,0 +0.34273,0.42378,-0.90577,0.60087,-1.1999,0 +0.39081,0.51209,-0.85893,0.70086,-1.1999,0 +0.36004,-0.615,-0.78853,-0.79914,-1.0999,0 +0.30455,-0.53321,-0.84598,-0.69914,-1.0999,0 +0.25294,-0.44608,-0.89499,-0.59913,-1.0999,0 +0.20833,-0.44608,-0.89499,-0.49913,-1.0999,0 +0.17123,-0.35451,-0.93505,-0.39914,-1.0999,0 +0.14112,-0.25939,-0.96577,-0.29913,-1.0999,0 +0.1189,-0.16168,-0.98684,-0.19914,-1.0999,0 +0.10521,-0.062346,-0.99805,-0.099135,-1.0999,0 +0.10043,0.037596,-0.99929,0.000865,-1.0999,0 +0.10462,0.087496,-0.99616,0.10086,-1.0999,0 +0.11833,0.13718,-0.99055,0.20087,-1.0999,0 +0.14109,0.23539,-0.9719,0.30086,-1.0999,0 +0.17186,0.33123,-0.94355,0.40087,-1.0999,0 +0.20978,0.42378,-0.90577,0.50087,-1.0999,0 +0.25371,0.51209,-0.85893,0.60087,-1.0999,0 +0.30491,0.51209,-0.85893,0.70086,-1.0999,0 +0.3618,0.59528,-0.80352,0.80086,-1.0999,0 +0.34537,-0.69066,-0.72318,-0.89914,-0.99992,0 +0.28118,-0.615,-0.78853,-0.79914,-0.99992,0 +0.22011,-0.57482,-0.81828,-0.69914,-0.99992,0 +0.16663,-0.53321,-0.84598,-0.59913,-0.99992,0 +0.11883,-0.44608,-0.89499,-0.49913,-0.99992,0 +0.077727,-0.35451,-0.93505,-0.39914,-0.99992,0 +0.044541,-0.25939,-0.96577,-0.29913,-0.99992,0 +0.020213,-0.16168,-0.98684,-0.19914,-0.99992,0 +0.0054083,-0.062346,-0.99805,-0.099135,-0.99992,0 +0.00049828,0.037596,-0.99929,0.000865,-0.99992,0 +0.005556,0.13718,-0.99055,0.10086,-0.99992,0 +0.020358,0.23539,-0.9719,0.20087,-0.99992,0 +0.044383,0.33123,-0.94355,0.30086,-0.99992,0 +0.077505,0.33123,-0.94355,0.40087,-0.99992,0 +0.1192,0.42378,-0.90577,0.50087,-0.99992,0 +0.16781,0.51209,-0.85893,0.60087,-0.99992,0 +0.22192,0.59528,-0.80352,0.70086,-0.99992,0 +0.28145,0.59528,-0.80352,0.80086,-0.99992,0 +0.34712,0.67252,-0.74008,0.90087,-0.99992,0 +0.3455,-0.75939,-0.65063,-0.99914,-0.89992,0 +0.27305,-0.69066,-0.72318,-0.89914,-0.89992,0 +0.20399,-0.69066,-0.72318,-0.79914,-0.89992,0 +0.14083,-0.615,-0.78853,-0.69914,-0.89992,0 +0.082034,-0.53321,-0.84598,-0.59913,-0.89992,0 +0.029329,-0.44608,-0.89499,-0.49913,-0.89992,0 +-0.01528,-0.44608,-0.89499,-0.39914,-0.89992,0 +-0.051229,-0.35451,-0.93505,-0.29913,-0.89992,0 +-0.077975,-0.25939,-0.96577,-0.19914,-0.89992,0 +-0.094397,-0.062346,-0.99805,-0.099135,-0.89992,0 +-0.099431,0.037596,-0.99929,0.000865,-0.89992,0 +-0.093499,0.13718,-0.99055,0.10086,-0.89992,0 +-0.076833,0.23539,-0.9719,0.20087,-0.89992,0 +-0.049972,0.33123,-0.94355,0.30086,-0.89992,0 +-0.013753,0.42378,-0.90577,0.40087,-0.89992,0 +0.03071,0.51209,-0.85893,0.50087,-0.89992,0 +0.08209,0.55438,-0.83227,0.60087,-0.89992,0 +0.14157,0.59528,-0.80352,0.70086,-0.89992,0 +0.20586,0.67252,-0.74008,0.80086,-0.89992,0 +0.27336,0.70867,-0.70554,0.90087,-0.89992,0 +0.3472,0.74304,-0.66924,1.0009,-0.89992,0 +0.36036,-0.82056,-0.57156,-1.0991,-0.79992,0 +0.28044,-0.75939,-0.65063,-0.99914,-0.79992,0 +0.2045,-0.75939,-0.65063,-0.89914,-0.79992,0 +0.13167,-0.69066,-0.72318,-0.79914,-0.79992,0 +0.062602,-0.69066,-0.72318,-0.69914,-0.79992,0 +0.00047852,-0.615,-0.78853,-0.59913,-0.79992,0 +-0.055885,-0.53321,-0.84598,-0.49913,-0.79992,0 +-0.10478,-0.44608,-0.89499,-0.39914,-0.79992,0 +-0.14473,-0.35451,-0.93505,-0.29913,-0.79992,0 +-0.17455,-0.25939,-0.96577,-0.19914,-0.79992,0 +-0.19332,-0.16168,-0.98684,-0.099135,-0.79992,0 +-0.19936,0.037596,-0.99929,0.000865,-0.79992,0 +-0.19255,0.13718,-0.99055,0.10086,-0.79992,0 +-0.17402,0.23539,-0.9719,0.20087,-0.79992,0 +-0.14433,0.33123,-0.94355,0.30086,-0.79992,0 +-0.10433,0.42378,-0.90577,0.40087,-0.79992,0 +-0.055183,0.51209,-0.85893,0.50087,-0.79992,0 +0.0016859,0.59528,-0.80352,0.60087,-0.79992,0 +0.064602,0.67252,-0.74008,0.70086,-0.79992,0 +0.13194,0.70867,-0.70554,0.80086,-0.79992,0 +0.20597,0.74304,-0.66924,0.90087,-0.79992,0 +0.28143,0.77557,-0.63127,1.0009,-0.79992,0 +0.36204,0.80615,-0.59171,1.1009,-0.79992,0 +0.38943,-0.87352,-0.48678,-1.1991,-0.69992,0 +0.30323,-0.8481,-0.52983,-1.0991,-0.69992,0 +0.22115,-0.82056,-0.57156,-0.99914,-0.69992,0 +0.13948,-0.79097,-0.61186,-0.89914,-0.69992,0 +0.0635,-0.75939,-0.65063,-0.79914,-0.69992,0 +-0.0097158,-0.69066,-0.72318,-0.69914,-0.69992,0 +-0.078374,-0.615,-0.78853,-0.59913,-0.69992,0 +-0.13987,-0.615,-0.78853,-0.49913,-0.69992,0 +-0.1938,-0.53321,-0.84598,-0.39914,-0.69992,0 +-0.23824,-0.35451,-0.93505,-0.29913,-0.69992,0 +-0.27113,-0.25939,-0.96577,-0.19914,-0.69992,0 +-0.29201,-0.16168,-0.98684,-0.099135,-0.69992,0 +-0.29929,0.037596,-0.99929,0.000865,-0.69992,0 +-0.29161,0.13718,-0.99055,0.10086,-0.69992,0 +-0.27121,0.23539,-0.9719,0.20087,-0.69992,0 +-0.23728,0.42378,-0.90577,0.30086,-0.69992,0 +-0.19229,0.51209,-0.85893,0.40087,-0.69992,0 +-0.13819,0.59528,-0.80352,0.50087,-0.69992,0 +-0.076658,0.67252,-0.74008,0.60087,-0.69992,0 +-0.009406,0.67252,-0.74008,0.70086,-0.69992,0 +0.064746,0.74304,-0.66924,0.80086,-0.69992,0 +0.14163,0.80615,-0.59171,0.90087,-0.69992,0 +0.22225,0.80615,-0.59171,1.0009,-0.69992,0 +0.30506,0.86119,-0.50828,1.1009,-0.69992,0 +0.39118,0.86119,-0.50828,1.2009,-0.69992,0 +0.34089,-0.89676,-0.44252,-1.1991,-0.59992,0 +0.2534,-0.87352,-0.48678,-1.0991,-0.59992,0 +0.16605,-0.87352,-0.48678,-0.99914,-0.59992,0 +0.081936,-0.82056,-0.57156,-0.89914,-0.59992,0 +-0.00012002,-0.82056,-0.57156,-0.79914,-0.59992,0 +-0.077503,-0.75939,-0.65063,-0.69914,-0.59992,0 +-0.1511,-0.69066,-0.72318,-0.59913,-0.59992,0 +-0.21873,-0.615,-0.78853,-0.49913,-0.59992,0 +-0.2784,-0.53321,-0.84598,-0.39914,-0.59992,0 +-0.32839,-0.44608,-0.89499,-0.29913,-0.59992,0 +-0.3672,-0.35451,-0.93505,-0.19914,-0.59992,0 +-0.39069,-0.16168,-0.98684,-0.099135,-0.59992,0 +-0.39922,0.037596,-0.99929,0.000865,-0.59992,0 +-0.39066,0.13718,-0.99055,0.10086,-0.59992,0 +-0.36616,0.33123,-0.94355,0.20087,-0.59992,0 +-0.32786,0.42378,-0.90577,0.30086,-0.59992,0 +-0.27807,0.59528,-0.80352,0.40087,-0.59992,0 +-0.21792,0.67252,-0.74008,0.50087,-0.59992,0 +-0.15067,0.67252,-0.74008,0.60087,-0.59992,0 +-0.076483,0.74304,-0.66924,0.70086,-0.59992,0 +0.0018482,0.80615,-0.59171,0.80086,-0.59992,0 +0.082463,0.80615,-0.59171,0.90087,-0.59992,0 +0.16812,0.86119,-0.50828,1.0009,-0.59992,0 +0.25423,0.86119,-0.50828,1.1009,-0.59992,0 +0.34302,0.90764,-0.41976,1.2009,-0.59992,0 +0.39215,-0.93646,-0.35078,-1.2991,-0.49992,0 +0.3003,-0.91775,-0.39716,-1.1991,-0.49992,0 +0.20853,-0.91775,-0.39716,-1.0991,-0.49992,0 +0.11737,-0.87352,-0.48678,-0.99914,-0.49992,0 +0.030019,-0.87352,-0.48678,-0.89914,-0.49992,0 +-0.057276,-0.82056,-0.57156,-0.79914,-0.49992,0 +-0.13933,-0.82056,-0.57156,-0.69914,-0.49992,0 +-0.21851,-0.75939,-0.65063,-0.59913,-0.49992,0 +-0.29248,-0.69066,-0.72318,-0.49913,-0.49992,0 +-0.35908,-0.615,-0.78853,-0.39914,-0.49992,0 +-0.35843,0.59528,-0.80352,0.40087,-0.49992,0 +-0.29193,0.67252,-0.74008,0.50087,-0.49992,0 +-0.21771,0.74304,-0.66924,0.60087,-0.49992,0 +-0.13794,0.80615,-0.59171,0.70086,-0.49992,0 +-0.054951,0.86119,-0.50828,0.80086,-0.49992,0 +0.031168,0.86119,-0.50828,0.90087,-0.49992,0 +0.11952,0.90764,-0.41976,1.0009,-0.49992,0 +0.21028,0.90764,-0.41976,1.1009,-0.49992,0 +0.30104,0.92748,-0.37387,1.2009,-0.49992,0 +0.39408,0.94501,-0.32705,1.3009,-0.49992,0 +0.36048,-0.95282,-0.30354,-1.2991,-0.39992,0 +0.2652,-0.95282,-0.30354,-1.1991,-0.39992,0 +0.16992,-0.95282,-0.30354,-1.0991,-0.39992,0 +0.077039,-0.91775,-0.39716,-0.99914,-0.39992,0 +-0.014736,-0.91775,-0.39716,-0.89914,-0.39992,0 +-0.10601,-0.87352,-0.48678,-0.79914,-0.39992,0 +-0.19336,-0.87352,-0.48678,-0.69914,-0.39992,0 +-0.27854,-0.82056,-0.57156,-0.59913,-0.39992,0 +-0.35951,-0.75939,-0.65063,-0.49913,-0.39992,0 +-0.35834,0.80615,-0.59171,0.50087,-0.39992,0 +-0.27772,0.80615,-0.59171,0.60087,-0.39992,0 +-0.1919,0.86119,-0.50828,0.70086,-0.39992,0 +-0.10399,0.90764,-0.41976,0.80086,-0.39992,0 +-0.013222,0.90764,-0.41976,0.90087,-0.39992,0 +0.077872,0.92748,-0.37387,1.0009,-0.39992,0 +0.17237,0.94501,-0.32705,1.1009,-0.39992,0 +0.26687,0.94501,-0.32705,1.2009,-0.39992,0 +0.36137,0.94501,-0.32705,1.3009,-0.39992,0 +0.33433,-0.97836,-0.20691,-1.2991,-0.29992,0 +0.23649,-0.97836,-0.20691,-1.1991,-0.29992,0 +0.13956,-0.95282,-0.30354,-1.0991,-0.29992,0 +0.044283,-0.95282,-0.30354,-0.99914,-0.29992,0 +-0.050999,-0.95282,-0.30354,-0.89914,-0.29992,0 +-0.14623,-0.91775,-0.39716,-0.79914,-0.29992,0 +-0.238,-0.91775,-0.39716,-0.69914,-0.29992,0 +-0.32939,-0.87352,-0.48678,-0.59913,-0.29992,0 +-0.32749,0.90764,-0.41976,0.60087,-0.29992,0 +-0.23672,0.90764,-0.41976,0.70086,-0.29992,0 +-0.14384,0.94501,-0.32705,0.80086,-0.29992,0 +-0.049336,0.94501,-0.32705,0.90087,-0.29992,0 +0.045164,0.94501,-0.32705,1.0009,-0.29992,0 +0.14163,0.97294,-0.23108,1.1009,-0.29992,0 +0.23892,0.97294,-0.23108,1.2009,-0.29992,0 +0.33621,0.97294,-0.23108,1.3009,-0.29992,0 +0.3145,-0.98748,-0.15775,-1.2991,-0.19992,0 +0.21582,-0.98748,-0.15775,-1.1991,-0.19992,0 +0.11797,-0.97836,-0.20691,-1.0991,-0.19992,0 +0.02013,-0.97836,-0.20691,-0.99914,-0.19992,0 +-0.077707,-0.97836,-0.20691,-0.89914,-0.19992,0 +-0.17554,-0.97836,-0.20691,-0.79914,-0.19992,0 +-0.27192,-0.95282,-0.30354,-0.69914,-0.19992,0 +-0.3672,-0.95282,-0.30354,-0.59913,-0.19992,0 +-0.36554,0.94501,-0.32705,0.60087,-0.19992,0 +-0.27066,0.97294,-0.23108,0.70086,-0.19992,0 +-0.17336,0.97294,-0.23108,0.80086,-0.19992,0 +-0.076069,0.97294,-0.23108,0.90087,-0.19992,0 +0.021225,0.97294,-0.23108,1.0009,-0.19992,0 +0.11893,0.98327,-0.18216,1.1009,-0.19992,0 +0.21803,0.99114,-0.1328,1.2009,-0.19992,0 +0.31714,0.99114,-0.1328,1.3009,-0.19992,0 +0.30357,-0.99413,-0.10819,-1.2991,-0.099923,0 +0.20416,-0.99413,-0.10819,-1.1991,-0.099923,0 +0.10474,-0.99413,-0.10819,-1.0991,-0.099923,0 +0.0053304,-0.99413,-0.10819,-0.99914,-0.099923,0 +-0.094083,-0.99413,-0.10819,-0.89914,-0.099923,0 +-0.1935,-0.99413,-0.10819,-0.79914,-0.099923,0 +-0.29291,-0.99413,-0.10819,-0.69914,-0.099923,0 +-0.39191,-0.97836,-0.20691,-0.59913,-0.099923,0 +-0.38994,0.99114,-0.1328,0.60087,-0.099923,0 +-0.29082,0.99114,-0.1328,0.70086,-0.099923,0 +-0.19171,0.99114,-0.1328,0.80086,-0.099923,0 +-0.092594,0.99114,-0.1328,0.90087,-0.099923,0 +0.0065202,0.99114,-0.1328,1.0009,-0.099923,0 +0.10563,0.99114,-0.1328,1.1009,-0.099923,0 +0.20502,0.99618,-0.08728,1.2009,-0.099923,0 +0.30479,0.99618,-0.08728,1.3009,-0.099923,0 +0.30034,-0.99996,-0.0084035,-1.2991,7.7e-05,0 +0.20034,-0.99996,-0.0084035,-1.1991,7.7e-05,0 +0.10035,-0.99996,-0.0084035,-1.0991,7.7e-05,0 +0.00034878,-0.99996,-0.0084035,-0.99914,7.7e-05,0 +-0.099648,-0.99996,-0.0084035,-0.89914,7.7e-05,0 +-0.19964,-0.99996,-0.0084035,-0.79914,7.7e-05,0 +-0.29964,-0.99996,-0.0084035,-0.69914,7.7e-05,0 +-0.39964,-0.99996,-0.0084035,-0.59913,7.7e-05,0 +-0.39863,0.99875,0.049981,0.60087,7.7e-05,0 +-0.29876,0.99875,0.049981,0.70086,7.7e-05,0 +-0.19888,0.99875,0.049981,0.80086,7.7e-05,0 +-0.099007,0.99875,0.049981,0.90087,7.7e-05,0 +0.00086777,0.99875,0.049981,1.0009,7.7e-05,0 +0.10087,0.99999,0.0042039,1.1009,7.7e-05,0 +0.20087,0.99999,0.0042039,1.2009,7.7e-05,0 +0.30087,0.99999,0.0042039,1.3009,7.7e-05,0 +0.30409,-0.99581,0.091468,-1.2991,0.10008,0 +0.20451,-0.99581,0.091468,-1.1991,0.10008,0 +0.10493,-0.99581,0.091468,-1.0991,0.10008,0 +0.0053506,-0.99581,0.091468,-0.99914,0.10008,0 +-0.09423,-0.99581,0.091468,-0.89914,0.10008,0 +-0.19381,-0.99581,0.091468,-0.79914,0.10008,0 +-0.29335,-0.9817,0.19042,-0.69914,0.10008,0 +-0.39152,-0.9817,0.19042,-0.59913,0.10008,0 +-0.38968,0.98877,0.14943,0.60087,0.10008,0 +-0.2908,0.98877,0.14943,0.70086,0.10008,0 +-0.19192,0.98877,0.14943,0.80086,0.10008,0 +-0.093046,0.98877,0.14943,0.90087,0.10008,0 +0.0058659,0.99875,0.049981,1.0009,0.10008,0 +0.10574,0.99875,0.049981,1.1009,0.10008,0 +0.20562,0.99875,0.049981,1.2009,0.10008,0 +0.30549,0.99875,0.049981,1.3009,0.10008,0 +0.31471,-0.98999,0.14112,-1.2991,0.20008,0 +0.21654,-0.9817,0.19042,-1.1991,0.20008,0 +0.11837,-0.9817,0.19042,-1.0991,0.20008,0 +0.020202,-0.9817,0.19042,-0.99914,0.20008,0 +-0.077968,-0.9817,0.19042,-0.89914,0.20008,0 +-0.17583,-0.95779,0.28748,-0.79914,0.20008,0 +-0.27161,-0.95779,0.28748,-0.69914,0.20008,0 +-0.36739,-0.95779,0.28748,-0.59913,0.20008,0 +-0.36571,0.93937,0.3429,0.60087,0.20008,0 +-0.27017,0.96891,0.2474,0.70086,0.20008,0 +-0.17328,0.96891,0.2474,0.80086,0.20008,0 +-0.076391,0.96891,0.2474,0.90087,0.20008,0 +0.020775,0.98877,0.14943,1.0009,0.20008,0 +0.11965,0.98877,0.14943,1.1009,0.20008,0 +0.21853,0.98877,0.14943,1.2009,0.20008,0 +0.31741,0.98877,0.14943,1.3009,0.20008,0 +0.33376,-0.9817,0.19042,-1.2991,0.30008,0 +0.23615,-0.97096,0.23925,-1.1991,0.30008,0 +0.14025,-0.95779,0.28748,-1.0991,0.30008,0 +0.044474,-0.95779,0.28748,-0.99914,0.30008,0 +-0.051304,-0.95779,0.28748,-0.89914,0.30008,0 +-0.14558,-0.9243,0.38166,-0.79914,0.30008,0 +-0.23801,-0.9243,0.38166,-0.69914,0.30008,0 +-0.32892,-0.88158,0.47203,-0.59913,0.30008,0 +-0.32718,0.90045,0.43496,0.60087,0.30008,0 +-0.23714,0.90045,0.43496,0.70086,0.30008,0 +-0.14354,0.93937,0.3429,0.80086,0.30008,0 +-0.049607,0.93937,0.3429,0.90087,0.30008,0 +0.04524,0.96891,0.2474,1.0009,0.30008,0 +0.14213,0.96891,0.2474,1.1009,0.30008,0 +0.23902,0.96891,0.2474,1.2009,0.30008,0 +0.33591,0.96891,0.2474,1.3009,0.30008,0 +0.36056,-0.95779,0.28748,-1.2991,0.40008,0 +0.26478,-0.95779,0.28748,-1.1991,0.40008,0 +0.16988,-0.9243,0.38166,-1.0991,0.40008,0 +0.077447,-0.9243,0.38166,-0.99914,0.40008,0 +-0.014984,-0.9243,0.38166,-0.89914,0.40008,0 +-0.1054,-0.88158,0.47203,-0.79914,0.40008,0 +-0.19356,-0.88158,0.47203,-0.69914,0.40008,0 +-0.27832,-0.83005,0.55768,-0.59913,0.40008,0 +-0.35915,-0.77023,0.63777,-0.49913,0.40008,0 +-0.3579,0.79608,0.60519,0.50087,0.40008,0 +-0.27738,0.85252,0.52269,0.60087,0.40008,0 +-0.19213,0.85252,0.52269,0.70086,0.40008,0 +-0.10359,0.90045,0.43496,0.80086,0.40008,0 +-0.013549,0.90045,0.43496,0.90087,0.40008,0 +0.078621,0.93937,0.3429,1.0009,0.40008,0 +0.17256,0.93937,0.3429,1.1009,0.40008,0 +0.26649,0.93937,0.3429,1.2009,0.40008,0 +0.361,0.95534,0.29552,1.3009,0.40008,0 +0.3929,-0.9243,0.38166,-1.2991,0.50008,0 +0.30047,-0.9243,0.38166,-1.1991,0.50008,0 +0.20804,-0.9243,0.38166,-1.0991,0.50008,0 +0.11812,-0.88158,0.47203,-0.99914,0.50008,0 +0.029963,-0.88158,0.47203,-0.89914,0.50008,0 +-0.056541,-0.83005,0.55768,-0.79914,0.50008,0 +-0.13955,-0.83005,0.55768,-0.69914,0.50008,0 +-0.21835,-0.77023,0.63777,-0.59913,0.50008,0 +-0.29221,-0.70271,0.71148,-0.49913,0.50008,0 +-0.35893,-0.62817,0.77807,-0.39914,0.50008,0 +-0.35849,0.65998,0.75128,0.40087,0.50008,0 +-0.2914,0.73169,0.68164,0.50087,0.50008,0 +-0.21777,0.79608,0.60519,0.60087,0.50008,0 +-0.13816,0.79608,0.60519,0.70086,0.50008,0 +-0.05461,0.85252,0.52269,0.80086,0.50008,0 +0.030643,0.85252,0.52269,0.90087,0.50008,0 +0.11999,0.90045,0.43496,1.0009,0.50008,0 +0.21004,0.90045,0.43496,1.1009,0.50008,0 +0.30089,0.92106,0.38942,1.2009,0.50008,0 +0.39472,0.93937,0.3429,1.3009,0.50008,0 +0.34164,-0.88158,0.47203,-1.1991,0.60008,0 +0.25348,-0.88158,0.47203,-1.0991,0.60008,0 +0.16549,-0.85689,0.5155,-0.99914,0.60008,0 +0.082233,-0.83005,0.55768,-0.89914,0.60008,0 +-0.00052378,-0.77023,0.63777,-0.79914,0.60008,0 +-0.077547,-0.77023,0.63777,-0.69914,0.60008,0 +-0.15079,-0.70271,0.71148,-0.59913,0.60008,0 +-0.2183,-0.62817,0.77807,-0.49913,0.60008,0 +-0.27808,-0.54736,0.8369,-0.39914,0.60008,0 +-0.32834,-0.46107,0.88736,-0.29913,0.60008,0 +-0.36703,-0.27559,0.96127,-0.19914,0.60008,0 +-0.39061,-0.17825,0.98399,-0.099135,0.60008,0 +-0.39879,0.020799,0.99978,0.000865,0.60008,0 +-0.39089,0.1205,0.99271,0.10086,0.60008,0 +-0.36595,0.31532,0.94898,0.20087,0.60008,0 +-0.32812,0.40849,0.91276,0.30086,0.60008,0 +-0.27746,0.58168,0.81342,0.40087,0.60008,0 +-0.21736,0.65998,0.75128,0.50087,0.60008,0 +-0.15007,0.73169,0.68164,0.60087,0.60008,0 +-0.076899,0.73169,0.68164,0.70086,0.60008,0 +0.0019638,0.79608,0.60519,0.80086,0.60008,0 +0.082912,0.85252,0.52269,0.90087,0.60008,0 +0.16816,0.85252,0.52269,1.0009,0.60008,0 +0.25379,0.87758,0.47942,1.1009,0.60008,0 +0.34358,0.90045,0.43496,1.2009,0.60008,0 +0.38885,-0.85689,0.5155,-1.1991,0.70008,0 +0.30401,-0.83005,0.55768,-1.0991,0.70008,0 +0.22101,-0.83005,0.55768,-0.99914,0.70008,0 +0.14028,-0.77023,0.63777,-0.89914,0.70008,0 +0.063253,-0.77023,0.63777,-0.79914,0.70008,0 +-0.0093728,-0.70271,0.71148,-0.69914,0.70008,0 +-0.077678,-0.62817,0.77807,-0.59913,0.70008,0 +-0.13965,-0.54736,0.8369,-0.49913,0.70008,0 +-0.1935,-0.46107,0.88736,-0.39914,0.70008,0 +-0.23767,-0.37018,0.92896,-0.29913,0.70008,0 +-0.2709,-0.27559,0.96127,-0.19914,0.70008,0 +-0.29221,-0.17825,0.98399,-0.099135,0.70008,0 +-0.29881,0.020799,0.99978,0.000865,0.70008,0 +-0.29162,0.1205,0.99271,0.10086,0.70008,0 +-0.27105,0.31532,0.94898,0.20087,0.70008,0 +-0.23685,0.40849,0.91276,0.30086,0.70008,0 +-0.19203,0.49757,0.86742,0.40087,0.70008,0 +-0.13795,0.58168,0.81342,0.50087,0.70008,0 +-0.076235,0.65998,0.75128,0.60087,0.70008,0 +-0.0087357,0.73169,0.68164,0.70086,0.70008,0 +0.064433,0.73169,0.68164,0.80086,0.70008,0 +0.14209,0.79608,0.60519,0.90087,0.70008,0 +0.2217,0.79608,0.60519,1.0009,0.70008,0 +0.30569,0.85252,0.52269,1.1009,0.70008,0 +0.39094,0.85252,0.52269,1.2009,0.70008,0 +0.35978,-0.80114,0.59847,-1.0991,0.80008,0 +0.28108,-0.77023,0.63777,-0.99914,0.80008,0 +0.20405,-0.77023,0.63777,-0.89914,0.80008,0 +0.13205,-0.70271,0.71148,-0.79914,0.80008,0 +0.062947,-0.62817,0.77807,-0.69914,0.80008,0 +0.00012937,-0.62817,0.77807,-0.59913,0.80008,0 +-0.055961,-0.54736,0.8369,-0.49913,0.80008,0 +-0.10476,-0.46107,0.88736,-0.39914,0.80008,0 +-0.14478,-0.37018,0.92896,-0.29913,0.80008,0 +-0.17478,-0.27559,0.96127,-0.19914,0.80008,0 +-0.19334,-0.079123,0.99686,-0.099135,0.80008,0 +-0.19883,0.020799,0.99978,0.000865,0.80008,0 +-0.19235,0.1205,0.99271,0.10086,0.80008,0 +-0.17411,0.21901,0.97572,0.20087,0.80008,0 +-0.14462,0.31532,0.94898,0.30086,0.80008,0 +-0.10472,0.40849,0.91276,0.40087,0.80008,0 +-0.055529,0.49757,0.86742,0.50087,0.80008,0 +0.0015578,0.58168,0.81342,0.60087,0.80008,0 +0.064891,0.65998,0.75128,0.70086,0.80008,0 +0.1326,0.73169,0.68164,0.80086,0.80008,0 +0.20577,0.73169,0.68164,0.90087,0.80008,0 +0.28222,0.79608,0.60519,1.0009,0.80008,0 +0.36183,0.79608,0.60519,1.1009,0.80008,0 +0.34491,-0.73739,0.67546,-0.99914,0.90008,0 +0.27346,-0.70271,0.71148,-0.89914,0.90008,0 +0.20367,-0.66627,0.74571,-0.79914,0.90008,0 +0.14075,-0.62817,0.77807,-0.69914,0.90008,0 +0.082465,-0.54736,0.8369,-0.59913,0.90008,0 +0.030082,-0.46107,0.88736,-0.49913,0.90008,0 +-0.014863,-0.37018,0.92896,-0.39914,0.90008,0 +-0.05109,-0.27559,0.96127,-0.29913,0.90008,0 +-0.077592,-0.17825,0.98399,-0.19914,0.90008,0 +-0.093652,-0.079123,0.99686,-0.099135,0.90008,0 +-0.09885,0.020799,0.99978,0.000865,0.90008,0 +-0.093078,0.1205,0.99271,0.10086,0.90008,0 +-0.076533,0.21901,0.97572,0.20087,0.90008,0 +-0.049722,0.31532,0.94898,0.30086,0.90008,0 +-0.013444,0.40849,0.91276,0.40087,0.90008,0 +0.031214,0.49757,0.86742,0.50087,0.90008,0 +0.082899,0.58168,0.81342,0.60087,0.90008,0 +0.14107,0.58168,0.81342,0.70086,0.90008,0 +0.20602,0.65998,0.75128,0.80086,0.90008,0 +0.27393,0.73169,0.68164,0.90087,0.90008,0 +0.3471,0.73169,0.68164,1.0009,0.90008,0 +0.34486,-0.66627,0.74571,-0.89914,1.0001,0 +0.28138,-0.62817,0.77807,-0.79914,1.0001,0 +0.22089,-0.54736,0.8369,-0.69914,1.0001,0 +0.16615,-0.54736,0.8369,-0.59913,1.0001,0 +0.11882,-0.46107,0.88736,-0.49913,1.0001,0 +0.078033,-0.37018,0.92896,-0.39914,1.0001,0 +0.045038,-0.27559,0.96127,-0.29913,1.0001,0 +0.020806,-0.17825,0.98399,-0.19914,1.0001,0 +0.0060349,-0.079123,0.99686,-0.099135,1.0001,0 +0.0011282,0.020799,0.99978,0.000865,1.0001,0 +0.0061936,0.1205,0.99271,0.10086,1.0001,0 +0.021039,0.21901,0.97572,0.20087,1.0001,0 +0.045177,0.31532,0.94898,0.30086,1.0001,0 +0.077832,0.40849,0.91276,0.40087,1.0001,0 +0.11868,0.40849,0.91276,0.50087,1.0001,0 +0.16771,0.49757,0.86742,0.60087,1.0001,0 +0.22241,0.58168,0.81342,0.70086,1.0001,0 +0.28127,0.62161,0.78333,0.80086,1.0001,0 +0.34714,0.65998,0.75128,0.90087,1.0001,0 +0.3597,-0.5885,0.8085,-0.79914,1.1001,0 +0.30458,-0.54736,0.8369,-0.69914,1.1001,0 +0.25366,-0.46107,0.88736,-0.59913,1.1001,0 +0.20805,-0.41615,0.9093,-0.49913,1.1001,0 +0.17093,-0.37018,0.92896,-0.39914,1.1001,0 +0.14116,-0.27559,0.96127,-0.29913,1.1001,0 +0.1192,-0.17825,0.98399,-0.19914,1.1001,0 +0.10572,-0.079123,0.99686,-0.099135,1.1001,0 +0.10111,0.020799,0.99978,0.000865,1.1001,0 +0.10546,0.1205,0.99271,0.10086,1.1001,0 +0.11861,0.21901,0.97572,0.20087,1.1001,0 +0.14054,0.2675,0.96356,0.30086,1.1001,0 +0.17161,0.31532,0.94898,0.40087,1.1001,0 +0.20996,0.40849,0.91276,0.50087,1.1001,0 +0.25446,0.49757,0.86742,0.60087,1.1001,0 +0.3044,0.5403,0.84147,0.70086,1.1001,0 +0.36192,0.58168,0.81342,0.80086,1.1001,0 +0.38888,-0.50485,0.86321,-0.69914,1.2001,0 +0.3424,-0.46107,0.88736,-0.59913,1.2001,0 +0.30084,-0.37018,0.92896,-0.49913,1.2001,0 +0.26487,-0.32329,0.9463,-0.39914,1.2001,0 +0.23729,-0.27559,0.96127,-0.29913,1.2001,0 +0.2176,-0.17825,0.98399,-0.19914,1.2001,0 +0.20541,-0.079123,0.99686,-0.099135,1.2001,0 +0.20108,0.020799,0.99978,0.000865,1.2001,0 +0.20474,0.1205,0.99271,0.10086,1.2001,0 +0.21684,0.16997,0.98545,0.20087,1.2001,0 +0.23808,0.21901,0.97572,0.30086,1.2001,0 +0.26651,0.31532,0.94898,0.40087,1.2001,0 +0.30123,0.40849,0.91276,0.50087,1.2001,0 +0.34218,0.4536,0.89121,0.60087,1.2001,0 +0.39095,0.49757,0.86742,0.70086,1.2001,0 +0.39374,-0.37018,0.92896,-0.49913,1.3001,0 +0.36098,-0.27559,0.96127,-0.39914,1.3001,0 +0.33407,-0.2272,0.97385,-0.29913,1.3001,0 +0.316,-0.17825,0.98399,-0.19914,1.3001,0 +0.30509,-0.079123,0.99686,-0.099135,1.3001,0 +0.30106,0.020799,0.99978,0.000865,1.3001,0 +0.30408,0.070738,0.99749,0.10086,1.3001,0 +0.31606,0.1205,0.99271,0.20087,1.3001,0 +0.33566,0.21901,0.97572,0.30086,1.3001,0 +0.3614,0.31532,0.94898,0.40087,1.3001,0 +0.39324,0.36236,0.93204,0.50087,1.3001,0 diff --git a/test/preprocessing/data/signed_distances_hexagon.csv b/test/preprocessing/data/signed_distances_hexagon.csv new file mode 100644 index 000000000..2fdfe7ddd --- /dev/null +++ b/test/preprocessing/data/signed_distances_hexagon.csv @@ -0,0 +1,475 @@ +"signed_distances","normals:0","normals:1","Points:0","Points:1","Points:2" +0.39282,-0.5,-0.86603,-0.26602,-1.3,0 +0.34288,-6.4099e-17,-1,-0.16602,-1.3,0 +0.30718,-6.4099e-17,-1,-0.066025,-1.3,0 +0.30192,-6.4099e-17,-1,0.033975,-1.3,0 +0.32856,-6.4099e-17,-1,0.13398,-1.3,0 +0.3768,0.5,-0.86603,0.23398,-1.3,0 +0.35622,-0.5,-0.86603,-0.36602,-1.2,0 +0.30622,-0.5,-0.86603,-0.26602,-1.2,0 +0.25622,-0.5,-0.86603,-0.16602,-1.2,0 +0.21062,-6.4099e-17,-1,-0.066025,-1.2,0 +0.20287,-6.4099e-17,-1,0.033975,-1.2,0 +0.24019,0.5,-0.86603,0.13398,-1.2,0 +0.29019,0.5,-0.86603,0.23398,-1.2,0 +0.34019,0.5,-0.86603,0.33398,-1.2,0 +0.39019,0.5,-0.86603,0.43397,-1.2,0 +0.36962,-0.5,-0.86603,-0.56603,-1.1,0 +0.31962,-0.5,-0.86603,-0.46602,-1.1,0 +0.26962,-0.5,-0.86603,-0.36602,-1.1,0 +0.21962,-0.5,-0.86603,-0.26602,-1.1,0 +0.16962,-0.5,-0.86603,-0.16602,-1.1,0 +0.11962,-0.5,-0.86603,-0.066025,-1.1,0 +0.10561,-6.4099e-17,-1,0.033975,-1.1,0 +0.15359,0.5,-0.86603,0.13398,-1.1,0 +0.20359,0.5,-0.86603,0.23398,-1.1,0 +0.25359,0.5,-0.86603,0.33398,-1.1,0 +0.30359,0.5,-0.86603,0.43397,-1.1,0 +0.35359,0.5,-0.86603,0.53398,-1.1,0 +0.38301,-0.5,-0.86603,-0.76602,-1,0 +0.33301,-0.5,-0.86603,-0.66602,-1,0 +0.28301,-0.5,-0.86603,-0.56603,-1,0 +0.23301,-0.5,-0.86603,-0.46602,-1,0 +0.18301,-0.5,-0.86603,-0.36602,-1,0 +0.13301,-0.5,-0.86603,-0.26602,-1,0 +0.083013,-0.5,-0.86603,-0.16602,-1,0 +0.033013,-0.5,-0.86603,-0.066025,-1,0 +0.016988,0.5,-0.86603,0.033975,-1,0 +0.066988,0.5,-0.86603,0.13398,-1,0 +0.11699,0.5,-0.86603,0.23398,-1,0 +0.16699,0.5,-0.86603,0.33398,-1,0 +0.21699,0.5,-0.86603,0.43397,-1,0 +0.26699,0.5,-0.86603,0.53398,-1,0 +0.31699,0.5,-0.86603,0.63398,-1,0 +0.36699,0.5,-0.86603,0.73398,-1,0 +0.39641,-0.5,-0.86603,-0.96602,-0.9,0 +0.34641,-0.5,-0.86603,-0.86603,-0.9,0 +0.29641,-0.5,-0.86603,-0.76602,-0.9,0 +0.24641,-0.5,-0.86603,-0.66602,-0.9,0 +0.19641,-0.5,-0.86603,-0.56603,-0.9,0 +0.14641,-0.5,-0.86603,-0.46602,-0.9,0 +0.09641,-0.5,-0.86603,-0.36602,-0.9,0 +0.04641,-0.5,-0.86603,-0.26602,-0.9,0 +-0.00359,-0.5,-0.86603,-0.16602,-0.9,0 +-0.05359,-0.5,-0.86603,-0.066025,-0.9,0 +-0.069615,0.5,-0.86603,0.033975,-0.9,0 +-0.019615,0.5,-0.86603,0.13398,-0.9,0 +0.030385,0.5,-0.86603,0.23398,-0.9,0 +0.080385,0.5,-0.86603,0.33398,-0.9,0 +0.13039,0.5,-0.86603,0.43397,-0.9,0 +0.18039,0.5,-0.86603,0.53398,-0.9,0 +0.23039,0.5,-0.86603,0.63398,-0.9,0 +0.28039,0.5,-0.86603,0.73398,-0.9,0 +0.33039,0.5,-0.86603,0.83397,-0.9,0 +0.38039,0.5,-0.86603,0.93397,-0.9,0 +0.36056,-0.86603,-0.5,-1.066,-0.8,0 +0.30981,-0.5,-0.86603,-0.96602,-0.8,0 +0.25981,-0.5,-0.86603,-0.86603,-0.8,0 +0.20981,-0.5,-0.86603,-0.76602,-0.8,0 +0.15981,-0.5,-0.86603,-0.66602,-0.8,0 +0.10981,-0.5,-0.86603,-0.56603,-0.8,0 +0.059808,-0.5,-0.86603,-0.46602,-0.8,0 +0.0098075,-0.5,-0.86603,-0.36602,-0.8,0 +-0.040193,-0.5,-0.86603,-0.26602,-0.8,0 +-0.090193,-0.5,-0.86603,-0.16602,-0.8,0 +-0.14019,-0.5,-0.86603,-0.066025,-0.8,0 +-0.15622,0.5,-0.86603,0.033975,-0.8,0 +-0.10622,0.5,-0.86603,0.13398,-0.8,0 +-0.056218,0.5,-0.86603,0.23398,-0.8,0 +-0.0062175,0.5,-0.86603,0.33398,-0.8,0 +0.043783,0.5,-0.86603,0.43397,-0.8,0 +0.093783,0.5,-0.86603,0.53398,-0.8,0 +0.14378,0.5,-0.86603,0.63398,-0.8,0 +0.19378,0.5,-0.86603,0.73398,-0.8,0 +0.24378,0.5,-0.86603,0.83397,-0.8,0 +0.29378,0.5,-0.86603,0.93397,-0.8,0 +0.34378,0.5,-0.86603,1.034,-0.8,0 +0.36056,-0.86603,-0.5,-1.166,-0.7,0 +0.28284,-0.86603,-0.5,-1.066,-0.7,0 +0.22321,-0.5,-0.86603,-0.96602,-0.7,0 +0.17321,-0.5,-0.86603,-0.86603,-0.7,0 +0.12321,-0.5,-0.86603,-0.76602,-0.7,0 +0.073205,-0.5,-0.86603,-0.66602,-0.7,0 +0.023205,-0.5,-0.86603,-0.56603,-0.7,0 +-0.026795,-0.5,-0.86603,-0.46602,-0.7,0 +-0.076795,-0.5,-0.86603,-0.36602,-0.7,0 +-0.1268,-0.5,-0.86603,-0.26602,-0.7,0 +-0.1768,-0.5,-0.86603,-0.16602,-0.7,0 +-0.2268,-0.5,-0.86603,-0.066025,-0.7,0 +-0.24282,0.5,-0.86603,0.033975,-0.7,0 +-0.19282,0.5,-0.86603,0.13398,-0.7,0 +-0.14282,0.5,-0.86603,0.23398,-0.7,0 +-0.09282,0.5,-0.86603,0.33398,-0.7,0 +-0.04282,0.5,-0.86603,0.43397,-0.7,0 +0.00718,0.5,-0.86603,0.53398,-0.7,0 +0.05718,0.5,-0.86603,0.63398,-0.7,0 +0.10718,0.5,-0.86603,0.73398,-0.7,0 +0.15718,0.5,-0.86603,0.83397,-0.7,0 +0.20718,0.5,-0.86603,0.93397,-0.7,0 +0.26117,0.86603,-0.5,1.034,-0.7,0 +0.33436,0.86603,-0.5,1.134,-0.7,0 +0.31623,-0.86603,-0.5,-1.166,-0.6,0 +0.22361,-0.86603,-0.5,-1.066,-0.6,0 +0.14142,-0.86603,-0.5,-0.96602,-0.6,0 +0.086603,-0.5,-0.86603,-0.86603,-0.6,0 +0.036603,-0.5,-0.86603,-0.76602,-0.6,0 +-0.013398,-0.5,-0.86603,-0.66602,-0.6,0 +-0.063398,-0.5,-0.86603,-0.56603,-0.6,0 +-0.1134,-0.5,-0.86603,-0.46602,-0.6,0 +-0.1634,-0.5,-0.86603,-0.36602,-0.6,0 +-0.2134,-0.5,-0.86603,-0.26602,-0.6,0 +-0.2634,-0.5,-0.86603,-0.16602,-0.6,0 +-0.3134,-0.5,-0.86603,-0.066025,-0.6,0 +-0.32942,0.5,-0.86603,0.033975,-0.6,0 +-0.27942,0.5,-0.86603,0.13398,-0.6,0 +-0.22942,0.5,-0.86603,0.23398,-0.6,0 +-0.17942,0.5,-0.86603,0.33398,-0.6,0 +-0.12942,0.5,-0.86603,0.43397,-0.6,0 +-0.079423,0.5,-0.86603,0.53398,-0.6,0 +-0.029423,0.5,-0.86603,0.63398,-0.6,0 +0.020578,0.5,-0.86603,0.73398,-0.6,0 +0.070578,0.5,-0.86603,0.83397,-0.6,0 +0.1209,0.86603,-0.5,0.93397,-0.6,0 +0.19547,0.86603,-0.5,1.034,-0.6,0 +0.286,0.86603,-0.5,1.134,-0.6,0 +0.3813,0.86603,-0.5,1.234,-0.6,0 +0.4,-0.86603,-0.5,-1.266,-0.5,0 +0.3,-0.86603,-0.5,-1.166,-0.5,0 +0.2,-0.86603,-0.5,-1.066,-0.5,0 +0.1,-0.86603,-0.5,-0.96602,-0.5,0 +0,-1,0,-0.86603,-0.5,0 +-0.05,-0.5,-0.86603,-0.76602,-0.5,0 +-0.1,-0.5,-0.86603,-0.66602,-0.5,0 +-0.15,-0.5,-0.86603,-0.56603,-0.5,0 +-0.2,-0.5,-0.86603,-0.46602,-0.5,0 +-0.25,-0.5,-0.86603,-0.36602,-0.5,0 +-0.3,-0.5,-0.86603,-0.26602,-0.5,0 +-0.35,-0.5,-0.86603,-0.16602,-0.5,0 +-0.36603,0.5,-0.86603,0.13398,-0.5,0 +-0.31603,0.5,-0.86603,0.23398,-0.5,0 +-0.26603,0.5,-0.86603,0.33398,-0.5,0 +-0.21603,0.5,-0.86603,0.43397,-0.5,0 +-0.16603,0.5,-0.86603,0.53398,-0.5,0 +-0.11603,0.5,-0.86603,0.63398,-0.5,0 +-0.066025,0.5,-0.86603,0.73398,-0.5,0 +-0.016025,0.5,-0.86603,0.83397,-0.5,0 +0.06795,0.86603,-0.5,0.93397,-0.5,0 +0.16795,0.86603,-0.5,1.034,-0.5,0 +0.26795,0.86603,-0.5,1.134,-0.5,0 +0.36795,0.86603,-0.5,1.234,-0.5,0 +0.4,-1,0,-1.266,-0.4,0 +0.3,-1,0,-1.166,-0.4,0 +0.2,-1,0,-1.066,-0.4,0 +0.1,-1,0,-0.96602,-0.4,0 +0,-1,0,-0.86603,-0.4,0 +-0.1,-1,0,-0.76602,-0.4,0 +-0.1866,-0.5,-0.86603,-0.66602,-0.4,0 +-0.2366,-0.5,-0.86603,-0.56603,-0.4,0 +-0.2866,-0.5,-0.86603,-0.46602,-0.4,0 +-0.3366,-0.5,-0.86603,-0.36602,-0.4,0 +-0.3866,-0.5,-0.86603,-0.26602,-0.4,0 +-0.35263,0.5,-0.86603,0.33398,-0.4,0 +-0.30263,0.5,-0.86603,0.43397,-0.4,0 +-0.25263,0.5,-0.86603,0.53398,-0.4,0 +-0.20263,0.5,-0.86603,0.63398,-0.4,0 +-0.13205,1,0,0.73398,-0.4,0 +-0.03205,1,0,0.83397,-0.4,0 +0.06795,1,0,0.93397,-0.4,0 +0.16795,1,0,1.034,-0.4,0 +0.26795,1,0,1.134,-0.4,0 +0.36795,1,0,1.234,-0.4,0 +0.4,-1,0,-1.266,-0.3,0 +0.3,-1,0,-1.166,-0.3,0 +0.2,-1,0,-1.066,-0.3,0 +0.1,-1,0,-0.96602,-0.3,0 +0,-1,0,-0.86603,-0.3,0 +-0.1,-1,0,-0.76602,-0.3,0 +-0.2,-1,0,-0.66602,-0.3,0 +-0.3,-1,0,-0.56603,-0.3,0 +-0.37321,-0.5,-0.86603,-0.46602,-0.3,0 +-0.38923,0.5,-0.86603,0.43397,-0.3,0 +-0.33205,1,0,0.53398,-0.3,0 +-0.23205,1,0,0.63398,-0.3,0 +-0.13205,1,0,0.73398,-0.3,0 +-0.03205,1,0,0.83397,-0.3,0 +0.06795,1,0,0.93397,-0.3,0 +0.16795,1,0,1.034,-0.3,0 +0.26795,1,0,1.134,-0.3,0 +0.36795,1,0,1.234,-0.3,0 +0.4,-1,0,-1.266,-0.2,0 +0.3,-1,0,-1.166,-0.2,0 +0.2,-1,0,-1.066,-0.2,0 +0.1,-1,0,-0.96602,-0.2,0 +0,-1,0,-0.86603,-0.2,0 +-0.1,-1,0,-0.76602,-0.2,0 +-0.2,-1,0,-0.66602,-0.2,0 +-0.3,-1,0,-0.56603,-0.2,0 +-0.33205,1,0,0.53398,-0.2,0 +-0.23205,1,0,0.63398,-0.2,0 +-0.13205,1,0,0.73398,-0.2,0 +-0.03205,1,0,0.83397,-0.2,0 +0.06795,1,0,0.93397,-0.2,0 +0.16795,1,0,1.034,-0.2,0 +0.26795,1,0,1.134,-0.2,0 +0.36795,1,0,1.234,-0.2,0 +0.4,-1,0,-1.266,-0.1,0 +0.3,-1,0,-1.166,-0.1,0 +0.2,-1,0,-1.066,-0.1,0 +0.1,-1,0,-0.96602,-0.1,0 +0,-1,0,-0.86603,-0.1,0 +-0.1,-1,0,-0.76602,-0.1,0 +-0.2,-1,0,-0.66602,-0.1,0 +-0.3,-1,0,-0.56603,-0.1,0 +-0.33205,1,0,0.53398,-0.1,0 +-0.23205,1,0,0.63398,-0.1,0 +-0.13205,1,0,0.73398,-0.1,0 +-0.03205,1,0,0.83397,-0.1,0 +0.06795,1,0,0.93397,-0.1,0 +0.16795,1,0,1.034,-0.1,0 +0.26795,1,0,1.134,-0.1,0 +0.36795,1,0,1.234,-0.1,0 +0.4,-1,0,-1.266,2.2204e-16,0 +0.3,-1,0,-1.166,2.2204e-16,0 +0.2,-1,0,-1.066,2.2204e-16,0 +0.1,-1,0,-0.96602,2.2204e-16,0 +0,-1,0,-0.86603,2.2204e-16,0 +-0.1,-1,0,-0.76602,2.2204e-16,0 +-0.2,-1,0,-0.66602,2.2204e-16,0 +-0.3,-1,0,-0.56603,2.2204e-16,0 +-0.33205,1,0,0.53398,2.2204e-16,0 +-0.23205,1,0,0.63398,2.2204e-16,0 +-0.13205,1,0,0.73398,2.2204e-16,0 +-0.03205,1,0,0.83397,2.2204e-16,0 +0.06795,1,0,0.93397,2.2204e-16,0 +0.16795,1,0,1.034,2.2204e-16,0 +0.26795,1,0,1.134,2.2204e-16,0 +0.36795,1,0,1.234,2.2204e-16,0 +0.4,-1,0,-1.266,0.1,0 +0.3,-1,0,-1.166,0.1,0 +0.2,-1,0,-1.066,0.1,0 +0.1,-1,0,-0.96602,0.1,0 +0,-1,0,-0.86603,0.1,0 +-0.1,-1,0,-0.76602,0.1,0 +-0.2,-1,0,-0.66602,0.1,0 +-0.3,-1,0,-0.56603,0.1,0 +-0.33205,1,0,0.53398,0.1,0 +-0.23205,1,0,0.63398,0.1,0 +-0.13205,1,0,0.73398,0.1,0 +-0.03205,1,0,0.83397,0.1,0 +0.06795,1,0,0.93397,0.1,0 +0.16795,1,0,1.034,0.1,0 +0.26795,1,0,1.134,0.1,0 +0.36795,1,0,1.234,0.1,0 +0.4,-1,0,-1.266,0.2,0 +0.3,-1,0,-1.166,0.2,0 +0.2,-1,0,-1.066,0.2,0 +0.1,-1,0,-0.96602,0.2,0 +0,-1,0,-0.86603,0.2,0 +-0.1,-1,0,-0.76602,0.2,0 +-0.2,-1,0,-0.66602,0.2,0 +-0.3,-1,0,-0.56603,0.2,0 +-0.33205,1,0,0.53398,0.2,0 +-0.23205,1,0,0.63398,0.2,0 +-0.13205,1,0,0.73398,0.2,0 +-0.03205,1,0,0.83397,0.2,0 +0.06795,1,0,0.93397,0.2,0 +0.16795,1,0,1.034,0.2,0 +0.26795,1,0,1.134,0.2,0 +0.36795,1,0,1.234,0.2,0 +0.4,-1,0,-1.266,0.3,0 +0.3,-1,0,-1.166,0.3,0 +0.2,-1,0,-1.066,0.3,0 +0.1,-1,0,-0.96602,0.3,0 +0,-1,0,-0.86603,0.3,0 +-0.1,-1,0,-0.76602,0.3,0 +-0.2,-1,0,-0.66602,0.3,0 +-0.3,-1,0,-0.56603,0.3,0 +-0.37321,-0.5,0.86603,-0.46602,0.3,0 +-0.38923,0.5,0.86603,0.43397,0.3,0 +-0.33205,1,0,0.53398,0.3,0 +-0.23205,1,0,0.63398,0.3,0 +-0.13205,1,0,0.73398,0.3,0 +-0.03205,1,0,0.83397,0.3,0 +0.06795,1,0,0.93397,0.3,0 +0.16795,1,0,1.034,0.3,0 +0.26795,1,0,1.134,0.3,0 +0.36795,1,0,1.234,0.3,0 +0.4,-1,0,-1.266,0.4,0 +0.3,-1,0,-1.166,0.4,0 +0.2,-1,0,-1.066,0.4,0 +0.1,-1,0,-0.96602,0.4,0 +0,-1,0,-0.86603,0.4,0 +-0.1,-1,0,-0.76602,0.4,0 +-0.1866,-0.5,0.86603,-0.66602,0.4,0 +-0.2366,-0.5,0.86603,-0.56603,0.4,0 +-0.2866,-0.5,0.86603,-0.46602,0.4,0 +-0.3366,-0.5,0.86603,-0.36602,0.4,0 +-0.3866,-0.5,0.86603,-0.26602,0.4,0 +-0.35263,0.5,0.86603,0.33398,0.4,0 +-0.30263,0.5,0.86603,0.43397,0.4,0 +-0.25263,0.5,0.86603,0.53398,0.4,0 +-0.20263,0.5,0.86603,0.63398,0.4,0 +-0.13205,1,0,0.73398,0.4,0 +-0.03205,1,0,0.83397,0.4,0 +0.06795,1,0,0.93397,0.4,0 +0.16795,1,0,1.034,0.4,0 +0.26795,1,0,1.134,0.4,0 +0.36795,1,0,1.234,0.4,0 +0.4,-0.86603,0.5,-1.266,0.5,0 +0.3,-0.86603,0.5,-1.166,0.5,0 +0.2,-0.86603,0.5,-1.066,0.5,0 +0.1,-0.86603,0.5,-0.96602,0.5,0 +1.5701e-16,-0.5,0.86603,-0.86603,0.5,0 +-0.05,-0.5,0.86603,-0.76602,0.5,0 +-0.1,-0.5,0.86603,-0.66602,0.5,0 +-0.15,-0.5,0.86603,-0.56603,0.5,0 +-0.2,-0.5,0.86603,-0.46602,0.5,0 +-0.25,-0.5,0.86603,-0.36602,0.5,0 +-0.3,-0.5,0.86603,-0.26602,0.5,0 +-0.35,-0.5,0.86603,-0.16602,0.5,0 +-0.36603,0.5,0.86603,0.13398,0.5,0 +-0.31603,0.5,0.86603,0.23398,0.5,0 +-0.26603,0.5,0.86603,0.33398,0.5,0 +-0.21603,0.5,0.86603,0.43397,0.5,0 +-0.16603,0.5,0.86603,0.53398,0.5,0 +-0.11603,0.5,0.86603,0.63398,0.5,0 +-0.066025,0.5,0.86603,0.73398,0.5,0 +-0.016025,0.5,0.86603,0.83397,0.5,0 +0.06795,0.86603,0.5,0.93397,0.5,0 +0.16795,0.86603,0.5,1.034,0.5,0 +0.26795,0.86603,0.5,1.134,0.5,0 +0.36795,0.86603,0.5,1.234,0.5,0 +0.31623,-0.86603,0.5,-1.166,0.6,0 +0.22361,-0.86603,0.5,-1.066,0.6,0 +0.14142,-0.86603,0.5,-0.96602,0.6,0 +0.086603,-0.5,0.86603,-0.86603,0.6,0 +0.036603,-0.5,0.86603,-0.76602,0.6,0 +-0.013398,-0.5,0.86603,-0.66602,0.6,0 +-0.063398,-0.5,0.86603,-0.56603,0.6,0 +-0.1134,-0.5,0.86603,-0.46602,0.6,0 +-0.1634,-0.5,0.86603,-0.36602,0.6,0 +-0.2134,-0.5,0.86603,-0.26602,0.6,0 +-0.2634,-0.5,0.86603,-0.16602,0.6,0 +-0.3134,-0.5,0.86603,-0.066025,0.6,0 +-0.32942,0.5,0.86603,0.033975,0.6,0 +-0.27942,0.5,0.86603,0.13398,0.6,0 +-0.22942,0.5,0.86603,0.23398,0.6,0 +-0.17942,0.5,0.86603,0.33398,0.6,0 +-0.12942,0.5,0.86603,0.43397,0.6,0 +-0.079423,0.5,0.86603,0.53398,0.6,0 +-0.029423,0.5,0.86603,0.63398,0.6,0 +0.020578,0.5,0.86603,0.73398,0.6,0 +0.070578,0.5,0.86603,0.83397,0.6,0 +0.1209,0.86603,0.5,0.93397,0.6,0 +0.19547,0.86603,0.5,1.034,0.6,0 +0.286,0.86603,0.5,1.134,0.6,0 +0.3813,0.86603,0.5,1.234,0.6,0 +0.36056,-0.86603,0.5,-1.166,0.7,0 +0.28284,-0.86603,0.5,-1.066,0.7,0 +0.22321,-0.5,0.86603,-0.96602,0.7,0 +0.17321,-0.5,0.86603,-0.86603,0.7,0 +0.12321,-0.5,0.86603,-0.76602,0.7,0 +0.073205,-0.5,0.86603,-0.66602,0.7,0 +0.023205,-0.5,0.86603,-0.56603,0.7,0 +-0.026795,-0.5,0.86603,-0.46602,0.7,0 +-0.076795,-0.5,0.86603,-0.36602,0.7,0 +-0.1268,-0.5,0.86603,-0.26602,0.7,0 +-0.1768,-0.5,0.86603,-0.16602,0.7,0 +-0.2268,-0.5,0.86603,-0.066025,0.7,0 +-0.24282,0.5,0.86603,0.033975,0.7,0 +-0.19282,0.5,0.86603,0.13398,0.7,0 +-0.14282,0.5,0.86603,0.23398,0.7,0 +-0.09282,0.5,0.86603,0.33398,0.7,0 +-0.04282,0.5,0.86603,0.43397,0.7,0 +0.00718,0.5,0.86603,0.53398,0.7,0 +0.05718,0.5,0.86603,0.63398,0.7,0 +0.10718,0.5,0.86603,0.73398,0.7,0 +0.15718,0.5,0.86603,0.83397,0.7,0 +0.20718,0.5,0.86603,0.93397,0.7,0 +0.26117,0.86603,0.5,1.034,0.7,0 +0.33436,0.86603,0.5,1.134,0.7,0 +0.36056,-0.86603,0.5,-1.066,0.8,0 +0.30981,-0.5,0.86603,-0.96602,0.8,0 +0.25981,-0.5,0.86603,-0.86603,0.8,0 +0.20981,-0.5,0.86603,-0.76602,0.8,0 +0.15981,-0.5,0.86603,-0.66602,0.8,0 +0.10981,-0.5,0.86603,-0.56603,0.8,0 +0.059808,-0.5,0.86603,-0.46602,0.8,0 +0.0098075,-0.5,0.86603,-0.36602,0.8,0 +-0.040193,-0.5,0.86603,-0.26602,0.8,0 +-0.090193,-0.5,0.86603,-0.16602,0.8,0 +-0.14019,-0.5,0.86603,-0.066025,0.8,0 +-0.15622,0.5,0.86603,0.033975,0.8,0 +-0.10622,0.5,0.86603,0.13398,0.8,0 +-0.056218,0.5,0.86603,0.23398,0.8,0 +-0.0062175,0.5,0.86603,0.33398,0.8,0 +0.043783,0.5,0.86603,0.43397,0.8,0 +0.093783,0.5,0.86603,0.53398,0.8,0 +0.14378,0.5,0.86603,0.63398,0.8,0 +0.19378,0.5,0.86603,0.73398,0.8,0 +0.24378,0.5,0.86603,0.83397,0.8,0 +0.29378,0.5,0.86603,0.93397,0.8,0 +0.34378,0.5,0.86603,1.034,0.8,0 +0.39641,-0.5,0.86603,-0.96602,0.9,0 +0.34641,-0.5,0.86603,-0.86603,0.9,0 +0.29641,-0.5,0.86603,-0.76602,0.9,0 +0.24641,-0.5,0.86603,-0.66602,0.9,0 +0.19641,-0.5,0.86603,-0.56603,0.9,0 +0.14641,-0.5,0.86603,-0.46602,0.9,0 +0.09641,-0.5,0.86603,-0.36602,0.9,0 +0.04641,-0.5,0.86603,-0.26602,0.9,0 +-0.00359,-0.5,0.86603,-0.16602,0.9,0 +-0.05359,-0.5,0.86603,-0.066025,0.9,0 +-0.069615,0.5,0.86603,0.033975,0.9,0 +-0.019615,0.5,0.86603,0.13398,0.9,0 +0.030385,0.5,0.86603,0.23398,0.9,0 +0.080385,0.5,0.86603,0.33398,0.9,0 +0.13039,0.5,0.86603,0.43397,0.9,0 +0.18039,0.5,0.86603,0.53398,0.9,0 +0.23039,0.5,0.86603,0.63398,0.9,0 +0.28039,0.5,0.86603,0.73398,0.9,0 +0.33039,0.5,0.86603,0.83397,0.9,0 +0.38039,0.5,0.86603,0.93397,0.9,0 +0.38301,-0.5,0.86603,-0.76602,1,0 +0.33301,-0.5,0.86603,-0.66602,1,0 +0.28301,-0.5,0.86603,-0.56603,1,0 +0.23301,-0.5,0.86603,-0.46602,1,0 +0.18301,-0.5,0.86603,-0.36602,1,0 +0.13301,-0.5,0.86603,-0.26602,1,0 +0.083013,-0.5,0.86603,-0.16602,1,0 +0.033013,-0.5,0.86603,-0.066025,1,0 +0.016988,0.5,0.86603,0.033975,1,0 +0.066988,0.5,0.86603,0.13398,1,0 +0.11699,0.5,0.86603,0.23398,1,0 +0.16699,0.5,0.86603,0.33398,1,0 +0.21699,0.5,0.86603,0.43397,1,0 +0.26699,0.5,0.86603,0.53398,1,0 +0.31699,0.5,0.86603,0.63398,1,0 +0.36699,0.5,0.86603,0.73398,1,0 +0.36962,-0.5,0.86603,-0.56603,1.1,0 +0.31962,-0.5,0.86603,-0.46602,1.1,0 +0.26962,-0.5,0.86603,-0.36602,1.1,0 +0.21962,-0.5,0.86603,-0.26602,1.1,0 +0.16962,-0.5,0.86603,-0.16602,1.1,0 +0.11962,-0.5,0.86603,-0.066025,1.1,0 +0.10561,0,1,0.033975,1.1,0 +0.15359,0.5,0.86603,0.13398,1.1,0 +0.20359,0.5,0.86603,0.23398,1.1,0 +0.25359,0.5,0.86603,0.33398,1.1,0 +0.30359,0.5,0.86603,0.43397,1.1,0 +0.35359,0.5,0.86603,0.53398,1.1,0 +0.35622,-0.5,0.86603,-0.36602,1.2,0 +0.30622,-0.5,0.86603,-0.26602,1.2,0 +0.25622,-0.5,0.86603,-0.16602,1.2,0 +0.21062,0,1,-0.066025,1.2,0 +0.20287,0,1,0.033975,1.2,0 +0.24019,0.5,0.86603,0.13398,1.2,0 +0.29019,0.5,0.86603,0.23398,1.2,0 +0.34019,0.5,0.86603,0.33398,1.2,0 +0.39019,0.5,0.86603,0.43397,1.2,0 +0.39282,-0.5,0.86603,-0.26602,1.3,0 +0.34288,0,1,-0.16602,1.3,0 +0.30718,0,1,-0.066025,1.3,0 +0.30192,0,1,0.033975,1.3,0 +0.32856,0,1,0.13398,1.3,0 +0.3768,0.5,0.86603,0.23398,1.3,0 diff --git a/test/preprocessing/data/signed_distances_sphere.csv b/test/preprocessing/data/signed_distances_sphere.csv new file mode 100644 index 000000000..426f719eb --- /dev/null +++ b/test/preprocessing/data/signed_distances_sphere.csv @@ -0,0 +1,5246 @@ +"signed_distances","normals:0","normals:1","normals:2","Points:0","Points:1","Points:2" +0.38961,-0.14332,-0.34088,-0.92912,-0.18502,-0.38502,-0.98502 +0.37688,-0.097096,-0.34441,-0.93379,-0.085017,-0.38502,-0.98502 +0.37352,-0.00051998,-0.34597,-0.93825,0.014983,-0.38502,-0.98502 +0.37958,0.096258,-0.34442,-0.93387,0.11498,-0.38502,-0.98502 +0.39489,0.19173,-0.34014,-0.92062,0.21498,-0.38502,-0.98502 +0.38018,-0.24235,-0.24235,-0.93943,-0.28502,-0.28502,-0.98502 +0.35773,-0.14659,-0.24675,-0.95793,-0.18502,-0.28502,-0.98502 +0.34463,-0.099107,-0.24965,-0.96325,-0.085017,-0.28502,-0.98502 +0.34119,-0.00045304,-0.25083,-0.96803,0.014983,-0.28502,-0.98502 +0.34747,0.098381,-0.24966,-0.96332,0.11498,-0.28502,-0.98502 +0.36326,0.19587,-0.24648,-0.94915,0.21498,-0.28502,-0.98502 +0.38818,0.29061,-0.24185,-0.92577,0.31498,-0.28502,-0.98502 +0.38961,-0.34088,-0.14332,-0.92912,-0.38502,-0.18502,-0.98502 +0.35773,-0.24675,-0.14659,-0.95793,-0.28502,-0.18502,-0.98502 +0.33479,-0.14935,-0.14935,-0.97744,-0.18502,-0.18502,-0.98502 +0.32141,-0.10062,-0.15131,-0.98335,-0.085017,-0.18502,-0.98502 +0.31791,-0.00031812,-0.15204,-0.98837,0.014983,-0.18502,-0.98502 +0.32434,0.10011,-0.15131,-0.9834,0.11498,-0.18502,-0.98502 +0.34048,0.19912,-0.14933,-0.96853,0.21498,-0.18502,-0.98502 +0.36593,0.29531,-0.1465,-0.9441,0.31498,-0.18502,-0.98502 +0.37688,-0.34441,-0.097095,-0.93379,-0.38502,-0.085017,-0.98502 +0.34463,-0.24965,-0.099108,-0.96325,-0.28502,-0.085017,-0.98502 +0.32141,-0.15131,-0.10062,-0.98335,-0.18502,-0.085017,-0.98502 +0.30786,-0.1011,-0.1011,-0.98973,-0.085017,-0.085017,-0.98502 +0.30431,-0.0001189,-0.050943,-0.9987,0.014983,-0.085017,-0.98502 +0.31082,0.10118,-0.050694,-0.99358,0.11498,-0.085017,-0.98502 +0.32717,0.20046,-0.099522,-0.97463,0.21498,-0.085017,-0.98502 +0.35292,0.29711,-0.097571,-0.94985,0.31498,-0.085017,-0.98502 +0.3875,0.38965,-0.095335,-0.91602,0.41498,-0.085017,-0.98502 +0.37352,-0.34597,-0.00052185,-0.93824,-0.38502,0.014983,-0.98502 +0.34119,-0.25083,-0.00045242,-0.96803,-0.28502,0.014983,-0.98502 +0.31791,-0.15204,-0.00031716,-0.98837,-0.18502,0.014983,-0.98502 +0.30431,-0.050944,-0.00011898,-0.9987,-0.085017,0.014983,-0.98502 +0.30075,3.3739e-07,-1.0162e-08,-1,0.014983,0.014983,-0.98502 +0.30728,0.10151,0.00010867,-0.99483,0.11498,0.014983,-0.98502 +0.32368,0.20149,0.00019162,-0.97949,0.21498,0.014983,-0.98502 +0.34949,0.29852,0.00024102,-0.9544,0.31498,0.014983,-0.98502 +0.38415,0.39139,0.00025695,-0.92022,0.41498,0.014983,-0.98502 +0.37958,-0.34441,0.096259,-0.93387,-0.38502,0.11498,-0.98502 +0.34747,-0.24966,0.098382,-0.96332,-0.28502,0.11498,-0.98502 +0.32434,-0.15131,0.10011,-0.9834,-0.18502,0.11498,-0.98502 +0.31082,-0.050694,0.10118,-0.99358,-0.085017,0.11498,-0.98502 +0.30728,0.0001089,0.10151,-0.99483,0.014983,0.11498,-0.98502 +0.31376,0.1011,0.1011,-0.98973,0.11498,0.11498,-0.98502 +0.33005,0.20058,0.099833,-0.97458,0.21498,0.11498,-0.98502 +0.3557,0.29716,0.09796,-0.94979,0.31498,0.11498,-0.98502 +0.39015,0.38964,0.095752,-0.91598,0.41498,0.11498,-0.98502 +0.39489,-0.34014,0.19173,-0.92062,-0.38502,0.21498,-0.98502 +0.36326,-0.24648,0.19587,-0.94915,-0.28502,0.21498,-0.98502 +0.34048,-0.14933,0.19912,-0.96853,-0.18502,0.21498,-0.98502 +0.32717,-0.099522,0.20046,-0.97463,-0.085017,0.21498,-0.98502 +0.32368,0.00019164,0.20149,-0.97949,0.014983,0.21498,-0.98502 +0.33005,0.099833,0.20058,-0.97458,0.11498,0.21498,-0.98502 +0.34608,0.19802,0.19802,-0.95999,0.21498,0.21498,-0.98502 +0.37135,0.29341,0.19428,-0.93603,0.31498,0.21498,-0.98502 +0.38818,-0.24185,0.29061,-0.92577,-0.28502,0.31498,-0.98502 +0.36593,-0.1465,0.29531,-0.9441,-0.18502,0.31498,-0.98502 +0.35292,-0.097571,0.29711,-0.94985,-0.085017,0.31498,-0.98502 +0.34949,0.00024022,0.29852,-0.9544,0.014983,0.31498,-0.98502 +0.3557,0.097959,0.29716,-0.94979,0.11498,0.31498,-0.98502 +0.37135,0.19428,0.29341,-0.93604,0.21498,0.31498,-0.98502 +0.39606,0.28791,0.28791,-0.91335,0.31498,0.31498,-0.98502 +0.3875,-0.095334,0.38965,-0.91602,-0.085017,0.41498,-0.98502 +0.38415,0.0002576,0.39139,-0.92022,0.014983,0.41498,-0.98502 +0.39015,0.095752,0.38964,-0.91598,0.11498,0.41498,-0.98502 +0.39214,-0.18132,-0.55219,-0.81376,-0.18502,-0.58502,-0.88502 +0.37956,-0.091479,-0.55888,-0.82419,-0.085017,-0.58502,-0.88502 +0.37632,-0.00019249,-0.56126,-0.82764,0.014983,-0.58502,-0.88502 +0.38249,0.09116,-0.55899,-0.82415,0.11498,-0.58502,-0.88502 +0.39786,0.22577,-0.54762,-0.80569,0.21498,-0.58502,-0.88502 +0.39518,-0.35949,-0.45148,-0.81666,-0.38502,-0.48502,-0.88502 +0.36368,-0.27447,-0.46249,-0.84307,-0.28502,-0.48502,-0.88502 +0.34104,-0.18535,-0.4713,-0.86228,-0.18502,-0.48502,-0.88502 +0.32786,-0.093492,-0.47709,-0.87387,-0.085017,-0.48502,-0.88502 +0.32454,-0.00024081,-0.47918,-0.87772,0.014983,-0.48502,-0.88502 +0.3311,0.13984,-0.47461,-0.86902,0.11498,-0.48502,-0.88502 +0.34728,0.23077,-0.46728,-0.85346,0.21498,-0.48502,-0.88502 +0.37266,0.31823,-0.45727,-0.83044,0.31498,-0.48502,-0.88502 +0.39518,-0.45148,-0.35949,-0.81666,-0.48502,-0.38502,-0.88502 +0.35409,-0.36888,-0.36888,-0.85315,-0.38502,-0.38502,-0.88502 +0.32135,-0.28134,-0.37764,-0.88218,-0.28502,-0.38502,-0.88502 +0.29775,-0.18988,-0.38482,-0.90325,-0.18502,-0.38502,-0.88502 +0.284,-0.095752,-0.38964,-0.91598,-0.085017,-0.38502,-0.88502 +0.28059,0.047952,-0.39074,-0.91925,0.014983,-0.38502,-0.88502 +0.28748,0.14319,-0.38745,-0.9107,0.11498,-0.38502,-0.88502 +0.3044,0.23639,-0.38139,-0.89368,0.21498,-0.38502,-0.88502 +0.33083,0.32623,-0.3733,-0.86846,0.31498,-0.38502,-0.88502 +0.36609,0.41154,-0.36407,-0.83552,0.41498,-0.38502,-0.88502 +0.36368,-0.46249,-0.27446,-0.84307,-0.48502,-0.28502,-0.88502 +0.32135,-0.37764,-0.28134,-0.88218,-0.38502,-0.28502,-0.88502 +0.28753,-0.28791,-0.28791,-0.91335,-0.28502,-0.28502,-0.88502 +0.26305,-0.19429,-0.29341,-0.93603,-0.18502,-0.28502,-0.88502 +0.24878,-0.09796,-0.29716,-0.94979,-0.085017,-0.28502,-0.88502 +0.24528,0.049063,-0.29793,-0.95333,0.014983,-0.28502,-0.88502 +0.25247,0.1465,-0.29531,-0.9441,0.11498,-0.28502,-0.88502 +0.27001,0.24185,-0.29061,-0.92577,0.21498,-0.28502,-0.88502 +0.29738,0.33383,-0.28448,-0.89868,0.31498,-0.28502,-0.88502 +0.33381,0.42131,-0.27765,-0.86337,0.41498,-0.28502,-0.88502 +0.37835,0.50346,-0.27108,-0.82039,0.51498,-0.28502,-0.88502 +0.39214,-0.55219,-0.18132,-0.81376,-0.58502,-0.18502,-0.88502 +0.34104,-0.4713,-0.18535,-0.86228,-0.48502,-0.18502,-0.88502 +0.29775,-0.38482,-0.18988,-0.90325,-0.38502,-0.18502,-0.88502 +0.26305,-0.29341,-0.19428,-0.93604,-0.28502,-0.18502,-0.88502 +0.23788,-0.19802,-0.19802,-0.95999,-0.18502,-0.18502,-0.88502 +0.22319,-0.099833,-0.20058,-0.97458,-0.085017,-0.18502,-0.88502 +0.21962,0.050024,-0.201,-0.97831,0.014983,-0.18502,-0.88502 +0.22702,0.14933,-0.19912,-0.96853,0.11498,-0.18502,-0.88502 +0.24506,0.24648,-0.19587,-0.94915,0.21498,-0.18502,-0.88502 +0.27317,0.34014,-0.19173,-0.92062,0.31498,-0.18502,-0.88502 +0.31052,0.42924,-0.18722,-0.88357,0.41498,-0.18502,-0.88502 +0.35609,0.51297,-0.18296,-0.83868,0.51498,-0.18502,-0.88502 +0.37956,-0.55888,-0.091478,-0.82419,-0.58502,-0.085017,-0.88502 +0.32786,-0.47709,-0.093492,-0.87387,-0.48502,-0.085017,-0.88502 +0.284,-0.38964,-0.095752,-0.91598,-0.38502,-0.085017,-0.88502 +0.24878,-0.29716,-0.09796,-0.94979,-0.28502,-0.085017,-0.88502 +0.22319,-0.20058,-0.099833,-0.97458,-0.18502,-0.085017,-0.88502 +0.20824,-0.1011,-0.1011,-0.98973,-0.085017,-0.085017,-0.88502 +0.20463,0.050694,-0.10118,-0.99358,0.014983,-0.085017,-0.88502 +0.21216,0.15131,-0.10011,-0.9834,0.11498,-0.085017,-0.88502 +0.2305,0.24966,-0.098382,-0.96332,0.21498,-0.085017,-0.88502 +0.25906,0.34441,-0.096258,-0.93387,0.31498,-0.085017,-0.88502 +0.29696,0.43451,-0.094016,-0.89575,0.41498,-0.085017,-0.88502 +0.34312,0.51915,-0.091951,-0.84973,0.51498,-0.085017,-0.88502 +0.39631,0.55899,-0.09116,-0.82415,0.61498,-0.085017,-0.88502 +0.37632,-0.56126,-0.00019201,-0.82764,-0.58502,0.014983,-0.88502 +0.32454,-0.47918,-0.00024111,-0.87772,-0.48502,0.014983,-0.88502 +0.28059,-0.39074,0.047952,-0.91925,-0.38502,0.014983,-0.88502 +0.24528,-0.29793,0.049064,-0.95333,-0.28502,0.014983,-0.88502 +0.21962,-0.201,0.050024,-0.97831,-0.18502,0.014983,-0.88502 +0.20463,-0.10118,0.050694,-0.99358,-0.085017,0.014983,-0.88502 +0.20101,0.05088,0.050877,-0.99741,0.014983,0.014983,-0.88502 +0.20856,0.15185,0.050616,-0.98711,0.11498,0.014983,-0.88502 +0.22696,0.25052,0.049938,-0.96682,0.21498,0.014983,-0.88502 +0.25559,0.34555,0.048971,-0.93712,0.31498,0.014983,-0.88502 +0.29357,0.43589,0.047859,-0.89873,0.41498,0.014983,-0.88502 +0.33981,0.52132,0.00045791,-0.85336,0.51498,0.014983,-0.88502 +0.39309,0.56126,0.00019206,-0.82764,0.61498,0.014983,-0.88502 +0.38249,-0.55899,0.09116,-0.82415,-0.58502,0.11498,-0.88502 +0.3311,-0.47461,0.13984,-0.86902,-0.48502,0.11498,-0.88502 +0.28748,-0.38745,0.14319,-0.9107,-0.38502,0.11498,-0.88502 +0.25247,-0.29531,0.1465,-0.9441,-0.28502,0.11498,-0.88502 +0.22702,-0.19912,0.14933,-0.96853,-0.18502,0.11498,-0.88502 +0.21216,-0.10011,0.15131,-0.9834,-0.085017,0.11498,-0.88502 +0.20856,0.050618,0.15185,-0.98711,0.014983,0.11498,-0.88502 +0.21606,0.151,0.151,-0.97693,0.11498,0.11498,-0.88502 +0.2343,0.24902,0.14893,-0.95698,0.21498,0.11498,-0.88502 +0.2627,0.34337,0.14603,-0.92778,0.31498,0.11498,-0.88502 +0.30037,0.43299,0.1427,-0.89003,0.41498,0.11498,-0.88502 +0.34624,0.5171,0.13937,-0.8445,0.51498,0.11498,-0.88502 +0.39911,0.55888,0.091478,-0.82419,0.61498,0.11498,-0.88502 +0.39786,-0.54762,0.22577,-0.80569,-0.58502,0.21498,-0.88502 +0.34728,-0.46728,0.23077,-0.85346,-0.48502,0.21498,-0.88502 +0.3044,-0.38139,0.23639,-0.89368,-0.38502,0.21498,-0.88502 +0.27001,-0.29061,0.24185,-0.92577,-0.28502,0.21498,-0.88502 +0.24506,-0.19587,0.24648,-0.94915,-0.18502,0.21498,-0.88502 +0.2305,-0.098382,0.24966,-0.96332,-0.085017,0.21498,-0.88502 +0.22696,0.04994,0.25052,-0.96682,0.014983,0.21498,-0.88502 +0.2343,0.14894,0.24902,-0.95698,0.11498,0.21498,-0.88502 +0.25219,0.24556,0.24556,-0.93776,0.21498,0.21498,-0.88502 +0.28006,0.33854,0.24073,-0.90964,0.31498,0.21498,-0.88502 +0.31706,0.4268,0.23519,-0.87323,0.41498,0.21498,-0.88502 +0.36215,0.50956,0.22965,-0.82922,0.51498,0.21498,-0.88502 +0.37266,-0.45727,0.31823,-0.83044,-0.48502,0.31498,-0.88502 +0.33083,-0.3733,0.32623,-0.86846,-0.38502,0.31498,-0.88502 +0.29738,-0.28448,0.33383,-0.89868,-0.28502,0.31498,-0.88502 +0.27317,-0.19173,0.34014,-0.92062,-0.18502,0.31498,-0.88502 +0.25906,-0.096258,0.34442,-0.93387,-0.085017,0.31498,-0.88502 +0.25559,0.048967,0.34556,-0.93712,0.014983,0.31498,-0.88502 +0.2627,0.14603,0.34337,-0.92778,0.11498,0.31498,-0.88502 +0.28006,0.24073,0.33854,-0.90964,0.21498,0.31498,-0.88502 +0.30713,0.33181,0.33181,-0.88306,0.31498,0.31498,-0.88502 +0.34314,0.41817,0.32404,-0.8486,0.41498,0.31498,-0.88502 +0.38708,0.49895,0.31618,-0.8069,0.51498,0.31498,-0.88502 +0.36609,-0.36406,0.41154,-0.83552,-0.38502,0.41498,-0.88502 +0.33381,-0.27765,0.42131,-0.86337,-0.28502,0.41498,-0.88502 +0.31052,-0.18722,0.42924,-0.88357,-0.18502,0.41498,-0.88502 +0.29696,-0.094015,0.43451,-0.89575,-0.085017,0.41498,-0.88502 +0.29357,0.047861,0.43589,-0.89873,0.014983,0.41498,-0.88502 +0.30037,0.1427,0.43299,-0.89003,0.11498,0.41498,-0.88502 +0.31706,0.23519,0.4268,-0.87323,0.21498,0.41498,-0.88502 +0.34314,0.32404,0.41817,-0.84861,0.31498,0.41498,-0.88502 +0.37788,0.40806,0.40806,-0.81668,0.41498,0.41498,-0.88502 +0.37835,-0.27108,0.50346,-0.82039,-0.28502,0.51498,-0.88502 +0.35609,-0.18296,0.51297,-0.83868,-0.18502,0.51498,-0.88502 +0.34312,-0.091951,0.51915,-0.84972,-0.085017,0.51498,-0.88502 +0.33981,0.00045754,0.52132,-0.85336,0.014983,0.51498,-0.88502 +0.34624,0.13937,0.5171,-0.8445,0.11498,0.51498,-0.88502 +0.36215,0.22965,0.50956,-0.82922,0.21498,0.51498,-0.88502 +0.38708,0.31618,0.49895,-0.8069,0.31498,0.51498,-0.88502 +0.39631,-0.09116,0.55899,-0.82415,-0.085017,0.61498,-0.88502 +0.39309,0.000192,0.56126,-0.82764,0.014983,0.61498,-0.88502 +0.39911,0.091478,0.55888,-0.82419,0.11498,0.61498,-0.88502 +0.3956,-0.26294,-0.64971,-0.71326,-0.28502,-0.68502,-0.78502 +0.37368,-0.17791,-0.66242,-0.7277,-0.18502,-0.68502,-0.78502 +0.36092,-0.089782,-0.67035,-0.73659,-0.085017,-0.68502,-0.78502 +0.3577,-0.00012444,-0.67306,-0.73959,0.014983,-0.68502,-0.78502 +0.36406,0.13386,-0.66719,-0.73276,0.11498,-0.68502,-0.78502 +0.37973,0.2206,-0.65695,-0.72094,0.21498,-0.68502,-0.78502 +0.3679,-0.38856,-0.55821,-0.73309,-0.38502,-0.58502,-0.78502 +0.33551,-0.26611,-0.57968,-0.77016,-0.28502,-0.58502,-0.78502 +0.3121,-0.18,-0.59077,-0.7865,-0.18502,-0.58502,-0.78502 +0.29848,-0.090914,-0.59783,-0.79645,-0.085017,-0.58502,-0.78502 +0.29515,0.045134,-0.59967,-0.79897,0.014983,-0.58502,-0.78502 +0.30199,0.13477,-0.59535,-0.79208,0.11498,-0.58502,-0.78502 +0.31865,0.22231,-0.5866,-0.77876,0.21498,-0.58502,-0.78502 +0.34469,0.30951,-0.57099,-0.76037,0.31498,-0.58502,-0.78502 +0.37946,0.38883,-0.55501,-0.73537,0.41498,-0.58502,-0.78502 +0.35858,-0.4729,-0.4729,-0.74346,-0.48502,-0.48502,-0.78502 +0.3161,-0.39765,-0.48628,-0.77808,-0.38502,-0.48502,-0.78502 +0.28197,-0.31618,-0.49895,-0.80689,-0.28502,-0.48502,-0.78502 +0.25708,-0.22964,-0.50956,-0.82922,-0.18502,-0.48502,-0.78502 +0.24243,-0.092705,-0.51912,-0.84966,-0.085017,-0.48502,-0.78502 +0.23896,0.045834,-0.52077,-0.85247,0.014983,-0.48502,-0.78502 +0.24625,0.13696,-0.51723,-0.84482,0.11498,-0.48502,-0.78502 +0.26385,0.22616,-0.50986,-0.83,0.21498,-0.48502,-0.78502 +0.2913,0.3164,-0.49516,-0.80914,0.31498,-0.48502,-0.78502 +0.32788,0.39806,-0.48186,-0.78062,0.41498,-0.48502,-0.78502 +0.37267,0.47353,-0.46849,-0.74584,0.51498,-0.48502,-0.78502 +0.3679,-0.55821,-0.38857,-0.73309,-0.58502,-0.38502,-0.78502 +0.3161,-0.48628,-0.39765,-0.77808,-0.48502,-0.38502,-0.78502 +0.27176,-0.40806,-0.40806,-0.81668,-0.38502,-0.38502,-0.78502 +0.23604,-0.32404,-0.41817,-0.84861,-0.28502,-0.38502,-0.78502 +0.2099,-0.23519,-0.4268,-0.87323,-0.18502,-0.38502,-0.78502 +0.19426,-0.094863,-0.43449,-0.89567,-0.085017,-0.38502,-0.78502 +0.19063,0.046815,-0.43591,-0.89877,0.014983,-0.38502,-0.78502 +0.19833,0.13997,-0.4331,-0.89041,0.11498,-0.38502,-0.78502 +0.21681,0.23531,-0.42328,-0.87491,0.21498,-0.38502,-0.78502 +0.2456,0.32429,-0.41383,-0.85064,0.31498,-0.38502,-0.78502 +0.28386,0.4085,-0.40318,-0.81889,0.41498,-0.38502,-0.78502 +0.3306,0.48691,-0.39294,-0.78008,0.51498,-0.38502,-0.78502 +0.38463,0.56541,-0.34749,-0.74804,0.61498,-0.38502,-0.78502 +0.3956,-0.64971,-0.26294,-0.71326,-0.68502,-0.28502,-0.78502 +0.33551,-0.57968,-0.26611,-0.77016,-0.58502,-0.28502,-0.78502 +0.28197,-0.49895,-0.31618,-0.8069,-0.48502,-0.28502,-0.78502 +0.23604,-0.41817,-0.32404,-0.84861,-0.38502,-0.28502,-0.78502 +0.19894,-0.33181,-0.33181,-0.88306,-0.28502,-0.28502,-0.78502 +0.17174,-0.24073,-0.33854,-0.90964,-0.18502,-0.28502,-0.78502 +0.15531,-0.097096,-0.34441,-0.93379,-0.085017,-0.28502,-0.78502 +0.15151,0.047929,-0.34557,-0.93717,0.014983,-0.28502,-0.78502 +0.15956,0.14333,-0.34345,-0.92817,0.11498,-0.28502,-0.78502 +0.17884,0.24084,-0.33494,-0.91094,0.21498,-0.28502,-0.78502 +0.20878,0.33203,-0.32754,-0.88458,0.31498,-0.28502,-0.78502 +0.24848,0.41853,-0.31947,-0.85016,0.41498,-0.28502,-0.78502 +0.29689,0.49943,-0.31192,-0.80826,0.51498,-0.28502,-0.78502 +0.35275,0.57973,-0.26578,-0.77024,0.61498,-0.28502,-0.78502 +0.37368,-0.66242,-0.17791,-0.7277,-0.68502,-0.18502,-0.78502 +0.3121,-0.59077,-0.18,-0.78651,-0.58502,-0.18502,-0.78502 +0.25708,-0.50956,-0.22964,-0.82922,-0.48502,-0.18502,-0.78502 +0.2099,-0.4268,-0.23519,-0.87323,-0.38502,-0.18502,-0.78502 +0.17174,-0.33854,-0.24073,-0.90964,-0.28502,-0.18502,-0.78502 +0.1437,-0.24556,-0.24556,-0.93776,-0.18502,-0.18502,-0.78502 +0.1267,-0.099107,-0.24965,-0.96325,-0.085017,-0.18502,-0.78502 +0.12276,0.049034,-0.25053,-0.96687,0.014983,-0.18502,-0.78502 +0.13111,0.14896,-0.24675,-0.95756,0.11498,-0.18502,-0.78502 +0.15101,0.24564,-0.24234,-0.93858,0.21498,-0.18502,-0.78502 +0.18184,0.33869,-0.23698,-0.91056,0.31498,-0.18502,-0.78502 +0.22267,0.42704,-0.23133,-0.87414,0.41498,-0.18502,-0.78502 +0.27236,0.51297,-0.18296,-0.83868,0.51498,-0.18502,-0.78502 +0.32977,0.5908,-0.17959,-0.78657,0.61498,-0.18502,-0.78502 +0.39358,0.66244,-0.17774,-0.72773,0.71498,-0.18502,-0.78502 +0.36092,-0.67035,-0.089782,-0.73659,-0.68502,-0.085017,-0.78502 +0.29848,-0.59782,-0.090914,-0.79645,-0.58502,-0.085017,-0.78502 +0.24243,-0.51912,-0.092706,-0.84966,-0.48502,-0.085017,-0.78502 +0.19426,-0.43449,-0.094865,-0.89567,-0.38502,-0.085017,-0.78502 +0.15531,-0.34441,-0.097095,-0.93379,-0.28502,-0.085017,-0.78502 +0.1267,-0.24965,-0.099108,-0.96325,-0.18502,-0.085017,-0.78502 +0.10932,-0.1011,-0.1011,-0.98973,-0.085017,-0.085017,-0.78502 +0.10531,0.050694,-0.10118,-0.99358,0.014983,-0.085017,-0.78502 +0.11385,0.15131,-0.10011,-0.9834,0.11498,-0.085017,-0.78502 +0.13417,0.24966,-0.098382,-0.96332,0.21498,-0.085017,-0.78502 +0.16562,0.34441,-0.096258,-0.93387,0.31498,-0.085017,-0.78502 +0.20728,0.43451,-0.094016,-0.89575,0.41498,-0.085017,-0.78502 +0.25799,0.51915,-0.091951,-0.84973,0.51498,-0.085017,-0.78502 +0.31641,0.59785,-0.090368,-0.7965,0.61498,-0.085017,-0.78502 +0.38105,0.67036,-0.08957,-0.73661,0.71498,-0.085017,-0.78502 +0.3577,-0.67306,-0.00012339,-0.73959,-0.68502,0.014983,-0.78502 +0.29515,-0.59967,0.045134,-0.79897,-0.58502,0.014983,-0.78502 +0.23896,-0.52077,0.045835,-0.85247,-0.48502,0.014983,-0.78502 +0.19063,-0.43591,0.046815,-0.89877,-0.38502,0.014983,-0.78502 +0.15151,-0.34557,0.047929,-0.93717,-0.28502,0.014983,-0.78502 +0.12276,-0.25053,0.049033,-0.96687,-0.18502,0.014983,-0.78502 +0.10531,-0.10118,0.050694,-0.99358,-0.085017,0.014983,-0.78502 +0.10127,0.05088,0.050877,-0.99741,0.014983,0.014983,-0.78502 +0.10985,0.15185,0.050616,-0.98711,0.11498,0.014983,-0.78502 +0.13028,0.25052,0.049938,-0.96682,0.21498,0.014983,-0.78502 +0.16188,0.34555,0.048971,-0.93712,0.31498,0.014983,-0.78502 +0.2037,0.43498,0.046813,-0.89922,0.41498,0.014983,-0.78502 +0.25457,0.52,0.045833,-0.85293,0.51498,0.014983,-0.78502 +0.31312,0.59965,0.045784,-0.79895,0.61498,0.014983,-0.78502 +0.37785,0.67306,0.0001235,-0.73959,0.71498,0.014983,-0.78502 +0.36406,-0.66719,0.13386,-0.73276,-0.68502,0.11498,-0.78502 +0.30199,-0.59535,0.13477,-0.79208,-0.58502,0.11498,-0.78502 +0.24625,-0.51723,0.13696,-0.84482,-0.48502,0.11498,-0.78502 +0.19833,-0.4331,0.13997,-0.89041,-0.38502,0.11498,-0.78502 +0.15956,-0.34345,0.14333,-0.92817,-0.28502,0.11498,-0.78502 +0.13111,-0.24675,0.14896,-0.95756,-0.18502,0.11498,-0.78502 +0.11385,-0.10011,0.15131,-0.9834,-0.085017,0.11498,-0.78502 +0.10985,0.050618,0.15185,-0.98711,0.014983,0.11498,-0.78502 +0.11837,0.151,0.151,-0.97693,0.11498,0.11498,-0.78502 +0.1386,0.24675,0.14659,-0.95793,0.21498,0.11498,-0.78502 +0.16988,0.34088,0.14333,-0.92912,0.31498,0.11498,-0.78502 +0.21132,0.43063,0.13996,-0.89161,0.41498,0.11498,-0.78502 +0.26176,0.51518,0.13696,-0.84607,0.51498,0.11498,-0.78502 +0.31985,0.59523,0.1365,-0.79188,0.61498,0.11498,-0.78502 +0.38405,0.66714,0.13452,-0.73269,0.71498,0.11498,-0.78502 +0.37973,-0.65695,0.2206,-0.72094,-0.68502,0.21498,-0.78502 +0.31865,-0.5866,0.22231,-0.77876,-0.58502,0.21498,-0.78502 +0.26385,-0.50986,0.22616,-0.83,-0.48502,0.21498,-0.78502 +0.21681,-0.42328,0.23531,-0.87491,-0.38502,0.21498,-0.78502 +0.17884,-0.33494,0.24084,-0.91094,-0.28502,0.21498,-0.78502 +0.15101,-0.24234,0.24564,-0.93858,-0.18502,0.21498,-0.78502 +0.13417,-0.098382,0.24966,-0.96332,-0.085017,0.21498,-0.78502 +0.13028,0.04994,0.25052,-0.96682,0.014983,0.21498,-0.78502 +0.1386,0.14659,0.24675,-0.95793,0.11498,0.21498,-0.78502 +0.15835,0.24235,0.24235,-0.93943,0.21498,0.21498,-0.78502 +0.18898,0.33501,0.23701,-0.91192,0.31498,0.21498,-0.78502 +0.22961,0.42343,0.23135,-0.87589,0.41498,0.21498,-0.78502 +0.27914,0.5068,0.22617,-0.83186,0.51498,0.21498,-0.78502 +0.33626,0.58453,0.22231,-0.78032,0.61498,0.21498,-0.78502 +0.39942,0.6568,0.22161,-0.72076,0.71498,0.21498,-0.78502 +0.34469,-0.57099,0.30951,-0.76037,-0.58502,0.31498,-0.78502 +0.2913,-0.49516,0.3164,-0.80914,-0.48502,0.31498,-0.78502 +0.2456,-0.41383,0.32429,-0.85063,-0.38502,0.31498,-0.78502 +0.20878,-0.32754,0.33203,-0.88458,-0.28502,0.31498,-0.78502 +0.18184,-0.23698,0.33869,-0.91056,-0.18502,0.31498,-0.78502 +0.16562,-0.096258,0.34442,-0.93387,-0.085017,0.31498,-0.78502 +0.16188,0.048967,0.34556,-0.93712,0.014983,0.31498,-0.78502 +0.16988,0.14332,0.34088,-0.92912,0.11498,0.31498,-0.78502 +0.18898,0.23701,0.33501,-0.91192,0.21498,0.31498,-0.78502 +0.21865,0.32764,0.32764,-0.88618,0.31498,0.31498,-0.78502 +0.25808,0.41405,0.31957,-0.85231,0.41498,0.31498,-0.78502 +0.30625,0.49553,0.31198,-0.81063,0.51498,0.31498,-0.78502 +0.36193,0.57143,0.30618,-0.76139,0.61498,0.31498,-0.78502 +0.37946,-0.55501,0.38883,-0.73537,-0.58502,0.41498,-0.78502 +0.32788,-0.48186,0.39806,-0.78062,-0.48502,0.41498,-0.78502 +0.28386,-0.40318,0.4085,-0.81889,-0.38502,0.41498,-0.78502 +0.24848,-0.31947,0.41853,-0.85016,-0.28502,0.41498,-0.78502 +0.22267,-0.23133,0.42704,-0.87414,-0.18502,0.41498,-0.78502 +0.20728,-0.094015,0.43451,-0.89575,-0.085017,0.41498,-0.78502 +0.2037,0.046811,0.43498,-0.89922,0.014983,0.41498,-0.78502 +0.21132,0.13997,0.43063,-0.89161,0.11498,0.41498,-0.78502 +0.22961,0.23135,0.42342,-0.87589,0.21498,0.41498,-0.78502 +0.25808,0.31957,0.41405,-0.85231,0.31498,0.41498,-0.78502 +0.29599,0.40343,0.40343,-0.82127,0.41498,0.41498,-0.78502 +0.34241,0.48232,0.39312,-0.78283,0.51498,0.41498,-0.78502 +0.39622,0.55563,0.38495,-0.73695,0.61498,0.41498,-0.78502 +0.37267,-0.46849,0.47353,-0.74584,-0.48502,0.51498,-0.78502 +0.3306,-0.39294,0.48691,-0.78008,-0.38502,0.51498,-0.78502 +0.29689,-0.31192,0.49943,-0.80826,-0.28502,0.51498,-0.78502 +0.27236,-0.18296,0.51297,-0.83868,-0.18502,0.51498,-0.78502 +0.25799,-0.091951,0.51915,-0.84972,-0.085017,0.51498,-0.78502 +0.25457,0.045834,0.52,-0.85293,0.014983,0.51498,-0.78502 +0.26176,0.13696,0.51518,-0.84607,0.11498,0.51498,-0.78502 +0.27914,0.22617,0.5068,-0.83187,0.21498,0.51498,-0.78502 +0.30625,0.31198,0.49553,-0.81063,0.31498,0.51498,-0.78502 +0.34241,0.39312,0.48232,-0.78283,0.41498,0.51498,-0.78502 +0.38678,0.46889,0.46889,-0.74853,0.51498,0.51498,-0.78502 +0.38463,-0.34749,0.56541,-0.74804,-0.38502,0.61498,-0.78502 +0.35275,-0.26579,0.57973,-0.77024,-0.28502,0.61498,-0.78502 +0.32977,-0.17959,0.5908,-0.78657,-0.18502,0.61498,-0.78502 +0.31641,-0.090369,0.59785,-0.7965,-0.085017,0.61498,-0.78502 +0.31312,0.045784,0.59965,-0.79895,0.014983,0.61498,-0.78502 +0.31985,0.1365,0.59523,-0.79188,0.11498,0.61498,-0.78502 +0.33626,0.2223,0.58453,-0.78032,0.21498,0.61498,-0.78502 +0.36193,0.30618,0.57144,-0.76139,0.31498,0.61498,-0.78502 +0.39622,0.38495,0.55563,-0.73695,0.41498,0.61498,-0.78502 +0.39358,-0.17774,0.66244,-0.72773,-0.18502,0.71498,-0.78502 +0.38105,-0.08957,0.67036,-0.73661,-0.085017,0.71498,-0.78502 +0.37785,0.00012384,0.67306,-0.73959,0.014983,0.71498,-0.78502 +0.38405,0.13452,0.66714,-0.73269,0.11498,0.71498,-0.78502 +0.39942,0.22161,0.6568,-0.72076,0.21498,0.71498,-0.78502 +0.3956,-0.26294,-0.71326,-0.64971,-0.28502,-0.78502,-0.68502 +0.37368,-0.17791,-0.7277,-0.66242,-0.18502,-0.78502,-0.68502 +0.36092,-0.089782,-0.73659,-0.67035,-0.085017,-0.78502,-0.68502 +0.3577,-0.00012436,-0.73959,-0.67306,0.014983,-0.78502,-0.68502 +0.36406,0.13386,-0.73276,-0.66719,0.11498,-0.78502,-0.68502 +0.37973,0.2206,-0.72094,-0.65695,0.21498,-0.78502,-0.68502 +0.39884,-0.4515,-0.63093,-0.63093,-0.48502,-0.68502,-0.68502 +0.35792,-0.38128,-0.65369,-0.65369,-0.38502,-0.68502,-0.68502 +0.32516,-0.30379,-0.67369,-0.67369,-0.28502,-0.68502,-0.68502 +0.30136,-0.17728,-0.69591,-0.69591,-0.18502,-0.68502,-0.68502 +0.28747,-0.08943,-0.70427,-0.70427,-0.085017,-0.68502,-0.68502 +0.28413,0.044907,-0.70639,-0.70639,0.014983,-0.68502,-0.68502 +0.29109,0.134,-0.70073,-0.70073,0.11498,-0.68502,-0.68502 +0.30796,0.22083,-0.68965,-0.68965,0.21498,-0.68502,-0.68502 +0.33426,0.30379,-0.67369,-0.67369,0.31498,-0.68502,-0.68502 +0.36934,0.38128,-0.65369,-0.65369,0.41498,-0.68502,-0.68502 +0.38914,-0.54543,-0.54543,-0.6364,-0.58502,-0.58502,-0.68502 +0.33837,-0.45551,-0.57129,-0.68274,-0.48502,-0.58502,-0.68502 +0.29529,-0.38408,-0.59017,-0.71006,-0.38502,-0.58502,-0.68502 +0.26066,-0.30479,-0.64198,-0.70354,-0.28502,-0.58502,-0.68502 +0.23535,-0.22161,-0.6568,-0.72076,-0.18502,-0.58502,-0.68502 +0.22014,-0.089782,-0.67035,-0.73659,-0.085017,-0.58502,-0.68502 +0.21658,0.045106,-0.6722,-0.739,0.014983,-0.58502,-0.68502 +0.22407,0.13453,-0.66666,-0.73313,0.11498,-0.58502,-0.68502 +0.24198,0.22162,-0.65606,-0.72143,0.21498,-0.58502,-0.68502 +0.26979,0.30483,-0.64099,-0.70442,0.31498,-0.58502,-0.68502 +0.30691,0.41918,-0.58189,-0.69691,0.41498,-0.58502,-0.68502 +0.35272,0.48614,-0.56278,-0.66854,0.51498,-0.58502,-0.68502 +0.39884,-0.63023,-0.4515,-0.63163,-0.68502,-0.48502,-0.68502 +0.33837,-0.57129,-0.45551,-0.68275,-0.58502,-0.48502,-0.68502 +0.28438,-0.49853,-0.49853,-0.70919,-0.48502,-0.48502,-0.68502 +0.23877,-0.39124,-0.5208,-0.75874,-0.38502,-0.48502,-0.68502 +0.20229,-0.30938,-0.57365,-0.75843,-0.28502,-0.48502,-0.68502 +0.17551,-0.22487,-0.58632,-0.77825,-0.18502,-0.48502,-0.68502 +0.15921,-0.13651,-0.59523,-0.79188,-0.085017,-0.48502,-0.68502 +0.15529,0.045134,-0.59967,-0.79897,0.014983,-0.48502,-0.68502 +0.16329,0.13652,-0.59388,-0.79289,0.11498,-0.48502,-0.68502 +0.18223,0.22492,-0.58428,-0.77976,0.21498,-0.48502,-0.68502 +0.21174,0.34749,-0.56541,-0.74804,0.31498,-0.48502,-0.68502 +0.25166,0.4653,-0.50612,-0.72618,0.41498,-0.48502,-0.68502 +0.30017,0.53254,-0.49219,-0.68859,0.51498,-0.48502,-0.68502 +0.35633,0.60154,-0.453,-0.65799,0.61498,-0.48502,-0.68502 +0.35792,-0.6531,-0.38128,-0.65428,-0.68502,-0.38502,-0.68502 +0.29529,-0.59017,-0.38408,-0.71006,-0.58502,-0.38502,-0.68502 +0.23877,-0.5208,-0.39125,-0.75874,-0.48502,-0.38502,-0.68502 +0.19004,-0.43934,-0.43934,-0.78356,-0.38502,-0.38502,-0.68502 +0.1514,-0.31824,-0.45703,-0.83057,-0.28502,-0.38502,-0.68502 +0.1232,-0.22964,-0.50956,-0.82922,-0.18502,-0.38502,-0.68502 +0.10596,-0.13937,-0.5171,-0.8445,-0.085017,-0.38502,-0.68502 +0.10164,0.046754,-0.52,-0.85289,0.014983,-0.38502,-0.68502 +0.11013,0.1394,-0.51509,-0.84572,0.11498,-0.38502,-0.68502 +0.13008,0.22974,-0.50658,-0.83102,0.21498,-0.38502,-0.68502 +0.16185,0.40096,-0.44556,-0.80044,0.31498,-0.38502,-0.68502 +0.2042,0.47807,-0.43361,-0.76383,0.41498,-0.38502,-0.68502 +0.2554,0.55501,-0.38883,-0.73538,0.51498,-0.38502,-0.68502 +0.31393,0.62235,-0.38255,-0.68289,0.61498,-0.38502,-0.68502 +0.37807,0.68343,-0.38092,-0.62275,0.71498,-0.38502,-0.68502 +0.3956,-0.71329,-0.2628,-0.64974,-0.78502,-0.28502,-0.68502 +0.32516,-0.67321,-0.30379,-0.67416,-0.68502,-0.28502,-0.68502 +0.26066,-0.64198,-0.30479,-0.70354,-0.58502,-0.28502,-0.68502 +0.20229,-0.57365,-0.30938,-0.75843,-0.48502,-0.28502,-0.68502 +0.1514,-0.45703,-0.31824,-0.83057,-0.38502,-0.28502,-0.68502 +0.11039,-0.32764,-0.32764,-0.88618,-0.28502,-0.28502,-0.68502 +0.080646,-0.23701,-0.33501,-0.91192,-0.18502,-0.28502,-0.68502 +0.062456,-0.14332,-0.34088,-0.92912,-0.085017,-0.28502,-0.68502 +0.057797,0.047929,-0.34557,-0.93717,0.014983,-0.28502,-0.68502 +0.066742,0.14333,-0.34345,-0.92817,0.11498,-0.28502,-0.68502 +0.087752,0.28448,-0.33383,-0.89868,0.21498,-0.28502,-0.68502 +0.12183,0.41383,-0.32429,-0.85064,0.31498,-0.28502,-0.68502 +0.16623,0.49516,-0.3164,-0.80914,0.41498,-0.28502,-0.68502 +0.21939,0.57099,-0.30951,-0.76037,0.51498,-0.28502,-0.68502 +0.27987,0.64224,-0.3035,-0.70386,0.61498,-0.28502,-0.68502 +0.34594,0.71326,-0.26294,-0.64971,0.71498,-0.28502,-0.68502 +0.37368,-0.72773,-0.17774,-0.66244,-0.78502,-0.18502,-0.68502 +0.30136,-0.69576,-0.17724,-0.69606,-0.68502,-0.18502,-0.68502 +0.23535,-0.6568,-0.22161,-0.72076,-0.58502,-0.18502,-0.68502 +0.17551,-0.58632,-0.22486,-0.77825,-0.48502,-0.18502,-0.68502 +0.1232,-0.50956,-0.22964,-0.82922,-0.38502,-0.18502,-0.68502 +0.080646,-0.33501,-0.23701,-0.91192,-0.28502,-0.18502,-0.68502 +0.049885,-0.24235,-0.24235,-0.93943,-0.18502,-0.18502,-0.68502 +0.030983,-0.14893,-0.24902,-0.95698,-0.085017,-0.18502,-0.68502 +0.026076,0.049034,-0.25053,-0.96687,0.014983,-0.18502,-0.68502 +0.03535,0.14896,-0.24675,-0.95756,0.11498,-0.18502,-0.68502 +0.057184,0.29061,-0.24185,-0.92577,0.21498,-0.18502,-0.68502 +0.092625,0.42328,-0.23531,-0.87491,0.31498,-0.18502,-0.68502 +0.13837,0.50657,-0.22974,-0.83102,0.41498,-0.18502,-0.68502 +0.19303,0.5866,-0.22231,-0.77877,0.51498,-0.18502,-0.68502 +0.25502,0.65695,-0.2206,-0.72094,0.61498,-0.18502,-0.68502 +0.32274,0.7277,-0.17791,-0.66242,0.71498,-0.18502,-0.68502 +0.39568,0.75824,-0.17841,-0.62709,0.81498,-0.18502,-0.68502 +0.36092,-0.73661,-0.08957,-0.67036,-0.78502,-0.085017,-0.68502 +0.28747,-0.7042,-0.089379,-0.70436,-0.68502,-0.085017,-0.68502 +0.22014,-0.67035,-0.089782,-0.73659,-0.58502,-0.085017,-0.68502 +0.15921,-0.59523,-0.1365,-0.79188,-0.48502,-0.085017,-0.68502 +0.10596,-0.5171,-0.13937,-0.8445,-0.38502,-0.085017,-0.68502 +0.062456,-0.34088,-0.14332,-0.92912,-0.28502,-0.085017,-0.68502 +0.030983,-0.24903,-0.14893,-0.95698,-0.18502,-0.085017,-0.68502 +0.011625,-0.151,-0.151,-0.97693,-0.085017,-0.085017,-0.68502 +0.0065842,0.050617,-0.15122,-0.9872,0.014983,-0.085017,-0.68502 +0.016126,0.15102,-0.14935,-0.97718,0.11498,-0.085017,-0.68502 +0.038469,0.29531,-0.1465,-0.9441,0.21498,-0.085017,-0.68502 +0.074765,0.4331,-0.13997,-0.89041,0.31498,-0.085017,-0.68502 +0.12145,0.51723,-0.13696,-0.84482,0.41498,-0.085017,-0.68502 +0.17706,0.59785,-0.090368,-0.7965,0.51498,-0.085017,-0.68502 +0.24021,0.67036,-0.08957,-0.73661,0.61498,-0.085017,-0.68502 +0.30925,0.73659,-0.089781,-0.67035,0.71498,-0.085017,-0.68502 +0.38317,0.76755,-0.090006,-0.63464,0.81498,-0.085017,-0.68502 +0.3577,-0.73959,0.00012337,-0.67306,-0.78502,0.014983,-0.68502 +0.28413,-0.70648,0.044908,-0.70631,-0.68502,0.014983,-0.68502 +0.21658,-0.6722,0.045106,-0.739,-0.58502,0.014983,-0.68502 +0.15529,-0.59967,0.045134,-0.79897,-0.48502,0.014983,-0.68502 +0.10164,-0.52,0.046752,-0.85289,-0.38502,0.014983,-0.68502 +0.057797,-0.34557,0.047929,-0.93717,-0.28502,0.014983,-0.68502 +0.026076,-0.25053,0.049033,-0.96687,-0.18502,0.014983,-0.68502 +0.0065842,-0.15122,0.050618,-0.9872,-0.085017,0.014983,-0.68502 +0.0015246,0.05088,0.050877,-0.99741,0.014983,0.014983,-0.68502 +0.011144,0.15185,0.050616,-0.98711,0.11498,0.014983,-0.68502 +0.033639,0.29798,0.049063,-0.95331,0.21498,0.014983,-0.68502 +0.07024,0.43589,0.047859,-0.89873,0.31498,0.014983,-0.68502 +0.11725,0.52075,0.046749,-0.85243,0.41498,0.014983,-0.68502 +0.17326,0.59965,0.045784,-0.79895,0.51498,0.014983,-0.68502 +0.23673,0.67237,0.045106,-0.73884,0.61498,0.014983,-0.68502 +0.30596,0.73884,0.044858,-0.67238,0.71498,0.014983,-0.68502 +0.37997,0.77062,-0.00010981,-0.63729,0.81498,0.014983,-0.68502 +0.36406,-0.73269,0.13452,-0.66714,-0.78502,0.11498,-0.68502 +0.29109,-0.70096,0.134,-0.7005,-0.68502,0.11498,-0.68502 +0.22407,-0.66666,0.13453,-0.73313,-0.58502,0.11498,-0.68502 +0.16329,-0.59388,0.13652,-0.79288,-0.48502,0.11498,-0.68502 +0.11013,-0.51509,0.1394,-0.84572,-0.38502,0.11498,-0.68502 +0.066742,-0.34345,0.14333,-0.92817,-0.28502,0.11498,-0.68502 +0.03535,-0.24675,0.14896,-0.95756,-0.18502,0.11498,-0.68502 +0.016126,-0.14935,0.15102,-0.97718,-0.085017,0.11498,-0.68502 +0.011144,0.050618,0.15185,-0.98711,0.014983,0.11498,-0.68502 +0.020644,0.14935,0.14935,-0.97744,0.11498,0.11498,-0.68502 +0.042859,0.29544,0.14649,-0.94406,0.21498,0.11498,-0.68502 +0.079067,0.43299,0.1427,-0.89003,0.31498,0.11498,-0.68502 +0.12563,0.5171,0.13937,-0.8445,0.41498,0.11498,-0.68502 +0.18114,0.59523,0.1365,-0.79188,0.51498,0.11498,-0.68502 +0.24407,0.66714,0.13452,-0.73269,0.61498,0.11498,-0.68502 +0.31274,0.73276,0.13386,-0.66719,0.71498,0.11498,-0.68502 +0.38614,0.76342,0.1348,-0.63168,0.81498,0.11498,-0.68502 +0.37974,-0.72076,0.22161,-0.6568,-0.78502,0.21498,-0.68502 +0.30796,-0.69001,0.22083,-0.68929,-0.68502,0.21498,-0.68502 +0.24198,-0.65606,0.22162,-0.72143,-0.58502,0.21498,-0.68502 +0.18223,-0.58428,0.22492,-0.77976,-0.48502,0.21498,-0.68502 +0.13008,-0.50657,0.22974,-0.83102,-0.38502,0.21498,-0.68502 +0.087752,-0.33383,0.28448,-0.89868,-0.28502,0.21498,-0.68502 +0.057184,-0.24185,0.29061,-0.92577,-0.18502,0.21498,-0.68502 +0.038469,-0.1465,0.29531,-0.9441,-0.085017,0.21498,-0.68502 +0.033639,0.04906,0.29798,-0.95331,0.014983,0.21498,-0.68502 +0.042859,0.14649,0.29544,-0.94406,0.11498,0.21498,-0.68502 +0.064464,0.28791,0.28791,-0.91335,0.21498,0.21498,-0.68502 +0.099678,0.42343,0.23135,-0.87589,0.31498,0.21498,-0.68502 +0.14527,0.5068,0.22617,-0.83186,0.41498,0.21498,-0.68502 +0.19978,0.58453,0.22231,-0.78032,0.51498,0.21498,-0.68502 +0.26167,0.6568,0.22161,-0.72076,0.61498,0.21498,-0.68502 +0.32924,0.72094,0.2206,-0.65695,0.71498,0.21498,-0.68502 +0.33426,-0.67416,0.30379,-0.67321,-0.68502,0.31498,-0.68502 +0.26979,-0.64099,0.30483,-0.70442,-0.58502,0.31498,-0.68502 +0.21174,-0.56541,0.34749,-0.74804,-0.48502,0.31498,-0.68502 +0.16185,-0.44556,0.40096,-0.80044,-0.38502,0.31498,-0.68502 +0.12183,-0.32429,0.41383,-0.85064,-0.28502,0.31498,-0.68502 +0.092625,-0.23531,0.42328,-0.87491,-0.18502,0.31498,-0.68502 +0.074765,-0.13997,0.4331,-0.89041,-0.085017,0.31498,-0.68502 +0.07024,0.047861,0.43589,-0.89873,0.014983,0.31498,-0.68502 +0.079067,0.1427,0.43299,-0.89003,0.11498,0.31498,-0.68502 +0.099678,0.23135,0.42342,-0.87589,0.21498,0.31498,-0.68502 +0.13294,0.40806,0.40806,-0.81668,0.31498,0.31498,-0.68502 +0.17638,0.49142,0.3552,-0.7952,0.41498,0.31498,-0.68502 +0.22872,0.56537,0.34771,-0.74797,0.51498,0.31498,-0.68502 +0.28901,0.64125,0.30348,-0.70476,0.61498,0.31498,-0.68502 +0.35503,0.70386,0.3035,-0.64224,0.71498,0.31498,-0.68502 +0.36934,-0.65428,0.38128,-0.6531,-0.68502,0.41498,-0.68502 +0.30691,-0.58189,0.41918,-0.69691,-0.58502,0.41498,-0.68502 +0.25166,-0.50612,0.4653,-0.72618,-0.48502,0.41498,-0.68502 +0.2042,-0.43361,0.47807,-0.76382,-0.38502,0.41498,-0.68502 +0.16623,-0.3164,0.49516,-0.80914,-0.28502,0.41498,-0.68502 +0.13837,-0.22975,0.50657,-0.83102,-0.18502,0.41498,-0.68502 +0.12145,-0.13696,0.51723,-0.84482,-0.085017,0.41498,-0.68502 +0.11725,0.046748,0.52075,-0.85243,0.014983,0.41498,-0.68502 +0.12563,0.13937,0.5171,-0.8445,0.11498,0.41498,-0.68502 +0.14527,0.22617,0.5068,-0.83187,0.21498,0.41498,-0.68502 +0.17638,0.35519,0.49142,-0.7952,0.31498,0.41498,-0.68502 +0.21799,0.4729,0.4729,-0.74346,0.41498,0.41498,-0.68502 +0.26786,0.54902,0.42333,-0.72067,0.51498,0.41498,-0.68502 +0.32541,0.61335,0.41722,-0.67062,0.61498,0.41498,-0.68502 +0.38947,0.6823,0.38095,-0.62397,0.71498,0.41498,-0.68502 +0.35272,-0.56278,0.48614,-0.66854,-0.58502,0.51498,-0.68502 +0.30017,-0.49219,0.53254,-0.68859,-0.48502,0.51498,-0.68502 +0.2554,-0.38883,0.55501,-0.73538,-0.38502,0.51498,-0.68502 +0.21939,-0.30952,0.57099,-0.76037,-0.28502,0.51498,-0.68502 +0.19303,-0.22231,0.5866,-0.77876,-0.18502,0.51498,-0.68502 +0.17706,-0.090369,0.59785,-0.7965,-0.085017,0.51498,-0.68502 +0.17326,0.045784,0.59965,-0.79895,0.014983,0.51498,-0.68502 +0.18114,0.1365,0.59523,-0.79188,0.11498,0.51498,-0.68502 +0.19978,0.2223,0.58453,-0.78032,0.21498,0.51498,-0.68502 +0.22872,0.34771,0.56537,-0.74796,0.31498,0.51498,-0.68502 +0.26786,0.42333,0.54902,-0.72067,0.41498,0.51498,-0.68502 +0.31552,0.5257,0.5257,-0.66879,0.51498,0.51498,-0.68502 +0.37021,0.59259,0.48296,-0.64466,0.61498,0.51498,-0.68502 +0.35633,-0.45299,0.60154,-0.65799,-0.48502,0.61498,-0.68502 +0.31393,-0.38255,0.62235,-0.68289,-0.38502,0.61498,-0.68502 +0.27987,-0.3035,0.64224,-0.70386,-0.28502,0.61498,-0.68502 +0.25502,-0.2206,0.65695,-0.72094,-0.18502,0.61498,-0.68502 +0.24021,-0.08957,0.67036,-0.73661,-0.085017,0.61498,-0.68502 +0.23673,0.045107,0.67237,-0.73884,0.014983,0.61498,-0.68502 +0.24407,0.13452,0.66714,-0.73269,0.11498,0.61498,-0.68502 +0.26167,0.22161,0.6568,-0.72076,0.21498,0.61498,-0.68502 +0.28901,0.30348,0.64125,-0.70476,0.31498,0.61498,-0.68502 +0.32541,0.41722,0.61335,-0.67062,0.41498,0.61498,-0.68502 +0.37021,0.48296,0.59258,-0.64467,0.51498,0.61498,-0.68502 +0.37806,-0.38095,0.6823,-0.62397,-0.38502,0.71498,-0.68502 +0.34594,-0.2628,0.71329,-0.64974,-0.28502,0.71498,-0.68502 +0.32274,-0.17774,0.72773,-0.66244,-0.18502,0.71498,-0.68502 +0.30925,-0.08957,0.73661,-0.67036,-0.085017,0.71498,-0.68502 +0.30596,0.045106,0.73884,-0.67237,0.014983,0.71498,-0.68502 +0.31274,0.13385,0.7332,-0.66671,0.11498,0.71498,-0.68502 +0.32925,0.22059,0.72162,-0.6562,0.21498,0.71498,-0.68502 +0.35504,0.30348,0.70476,-0.64125,0.31498,0.71498,-0.68502 +0.38948,0.38092,0.68343,-0.62275,0.41498,0.71498,-0.68502 +0.39568,-0.17827,0.75805,-0.62736,-0.18502,0.81498,-0.68502 +0.38317,-0.089822,0.76745,-0.63479,-0.085017,0.81498,-0.68502 +0.37997,0.00010963,0.77062,-0.63729,0.014983,0.81498,-0.68502 +0.38614,0.1348,0.76376,-0.63127,0.11498,0.81498,-0.68502 +0.39214,-0.18132,-0.81376,-0.55219,-0.18502,-0.88502,-0.58502 +0.37956,-0.091478,-0.82419,-0.55888,-0.085017,-0.88502,-0.58502 +0.37632,-0.00019142,-0.82764,-0.56126,0.014983,-0.88502,-0.58502 +0.38249,0.091161,-0.82415,-0.55899,0.11498,-0.88502,-0.58502 +0.39786,0.22577,-0.80569,-0.54762,0.21498,-0.88502,-0.58502 +0.3679,-0.38857,-0.73309,-0.55821,-0.38502,-0.78502,-0.58502 +0.33551,-0.26611,-0.77016,-0.57968,-0.28502,-0.78502,-0.58502 +0.3121,-0.18,-0.78651,-0.59077,-0.18502,-0.78502,-0.58502 +0.29848,-0.090915,-0.79645,-0.59783,-0.085017,-0.78502,-0.58502 +0.29515,0.045134,-0.79897,-0.59967,0.014983,-0.78502,-0.58502 +0.30199,0.13477,-0.79208,-0.59535,0.11498,-0.78502,-0.58502 +0.31865,0.22231,-0.77876,-0.5866,0.21498,-0.78502,-0.58502 +0.34469,0.30951,-0.76037,-0.57099,0.31498,-0.78502,-0.58502 +0.37946,0.38883,-0.73538,-0.55501,0.41498,-0.78502,-0.58502 +0.38914,-0.54543,-0.6364,-0.54543,-0.58502,-0.68502,-0.58502 +0.33837,-0.45551,-0.68274,-0.57129,-0.48502,-0.68502,-0.58502 +0.29529,-0.38408,-0.71006,-0.59017,-0.38502,-0.68502,-0.58502 +0.26066,-0.30479,-0.70354,-0.64198,-0.28502,-0.68502,-0.58502 +0.23535,-0.22161,-0.72076,-0.6568,-0.18502,-0.68502,-0.58502 +0.22014,-0.089782,-0.73659,-0.67035,-0.085017,-0.68502,-0.58502 +0.21658,0.045106,-0.739,-0.6722,0.014983,-0.68502,-0.58502 +0.22407,0.13453,-0.73313,-0.66666,0.11498,-0.68502,-0.58502 +0.24198,0.22162,-0.72143,-0.65606,0.21498,-0.68502,-0.58502 +0.26979,0.30483,-0.70442,-0.64099,0.31498,-0.68502,-0.58502 +0.30691,0.41918,-0.69691,-0.58189,0.41498,-0.68502,-0.58502 +0.35272,0.48614,-0.66854,-0.56278,0.51498,-0.68502,-0.58502 +0.38914,-0.63715,-0.54499,-0.54499,-0.68502,-0.58502,-0.58502 +0.32826,-0.57357,-0.57923,-0.57923,-0.58502,-0.58502,-0.58502 +0.27431,-0.51075,-0.60792,-0.60792,-0.48502,-0.58502,-0.58502 +0.22755,-0.41574,-0.6431,-0.6431,-0.38502,-0.58502,-0.58502 +0.19042,-0.30379,-0.67369,-0.67369,-0.28502,-0.58502,-0.58502 +0.16341,-0.22083,-0.68965,-0.68965,-0.18502,-0.58502,-0.58502 +0.14693,-0.134,-0.70073,-0.70073,-0.085017,-0.58502,-0.58502 +0.14285,0.044907,-0.70639,-0.70639,0.014983,-0.58502,-0.58502 +0.15095,0.134,-0.70073,-0.70073,0.11498,-0.58502,-0.58502 +0.17003,0.22083,-0.68965,-0.68965,0.21498,-0.58502,-0.58502 +0.20048,0.38128,-0.65369,-0.65369,0.31498,-0.58502,-0.58502 +0.24103,0.4515,-0.63093,-0.63093,0.41498,-0.58502,-0.58502 +0.28962,0.51075,-0.60792,-0.60792,0.51498,-0.58502,-0.58502 +0.34635,0.61653,-0.55673,-0.55673,0.61498,-0.58502,-0.58502 +0.33837,-0.68195,-0.45544,-0.5723,-0.68502,-0.48502,-0.58502 +0.27431,-0.60618,-0.51074,-0.60966,-0.58502,-0.48502,-0.58502 +0.21699,-0.52277,-0.52276,-0.67337,-0.48502,-0.48502,-0.58502 +0.16743,-0.45551,-0.57129,-0.68274,-0.38502,-0.48502,-0.58502 +0.12667,-0.34456,-0.59955,-0.72237,-0.28502,-0.48502,-0.58502 +0.097685,-0.2222,-0.62135,-0.75137,-0.18502,-0.48502,-0.58502 +0.080123,-0.1348,-0.63127,-0.76376,-0.085017,-0.48502,-0.58502 +0.075512,0.04517,-0.63664,-0.76984,0.014983,-0.48502,-0.58502 +0.084162,0.1348,-0.63168,-0.76342,0.11498,-0.48502,-0.58502 +0.10487,0.30579,-0.60814,-0.73257,0.21498,-0.48502,-0.58502 +0.13818,0.38404,-0.59112,-0.70928,0.31498,-0.48502,-0.58502 +0.18112,0.45544,-0.5723,-0.68195,0.41498,-0.48502,-0.58502 +0.23343,0.57902,-0.51472,-0.63229,0.51498,-0.48502,-0.58502 +0.29309,0.62971,-0.51415,-0.58233,0.61498,-0.48502,-0.58502 +0.35898,0.68274,-0.45551,-0.57129,0.71498,-0.48502,-0.58502 +0.36788,-0.73449,-0.38489,-0.5589,-0.78502,-0.38502,-0.58502 +0.29529,-0.70928,-0.38404,-0.59112,-0.68502,-0.38502,-0.58502 +0.22755,-0.64278,-0.41573,-0.64343,-0.58502,-0.38502,-0.58502 +0.16743,-0.57129,-0.45551,-0.68275,-0.48502,-0.38502,-0.58502 +0.1152,-0.46889,-0.46889,-0.74853,-0.38502,-0.38502,-0.58502 +0.072068,-0.39312,-0.48232,-0.78283,-0.28502,-0.38502,-0.58502 +0.040124,-0.22617,-0.5068,-0.83187,-0.18502,-0.38502,-0.58502 +0.021486,-0.13696,-0.51518,-0.84607,-0.085017,-0.38502,-0.58502 +0.016391,0.045834,-0.52077,-0.85247,0.014983,-0.38502,-0.58502 +0.025568,0.13696,-0.51723,-0.84482,0.11498,-0.38502,-0.58502 +0.048482,0.31192,-0.49943,-0.80825,0.21498,-0.38502,-0.58502 +0.083783,0.39294,-0.48691,-0.78008,0.31498,-0.38502,-0.58502 +0.1296,0.50612,-0.46529,-0.72618,0.41498,-0.38502,-0.58502 +0.18507,0.60154,-0.453,-0.65799,0.51498,-0.38502,-0.58502 +0.24748,0.67062,-0.41722,-0.61335,0.61498,-0.38502,-0.58502 +0.31647,0.71006,-0.38408,-0.59017,0.71498,-0.38502,-0.58502 +0.38995,0.74797,-0.34771,-0.56537,0.81498,-0.38502,-0.58502 +0.33551,-0.77024,-0.26579,-0.57973,-0.78502,-0.28502,-0.58502 +0.26066,-0.70442,-0.30483,-0.64099,-0.68502,-0.28502,-0.58502 +0.19042,-0.67321,-0.30379,-0.67416,-0.58502,-0.28502,-0.58502 +0.12667,-0.59955,-0.34457,-0.72237,-0.48502,-0.28502,-0.58502 +0.072068,-0.48232,-0.39312,-0.78283,-0.38502,-0.28502,-0.58502 +0.026812,-0.40806,-0.40806,-0.81668,-0.28502,-0.28502,-0.58502 +-0.0075325,-0.23135,-0.42342,-0.87589,-0.18502,-0.28502,-0.58502 +-0.027188,-0.14269,-0.43299,-0.89003,-0.085017,-0.28502,-0.58502 +-0.032712,0.046815,-0.43591,-0.89877,0.014983,-0.28502,-0.58502 +-0.023002,0.14273,-0.43057,-0.8912,0.11498,-0.28502,-0.58502 +0.0016842,0.31947,-0.41853,-0.85016,0.21498,-0.28502,-0.58502 +0.038914,0.4085,-0.40318,-0.81889,0.31498,-0.28502,-0.58502 +0.087479,0.55501,-0.38883,-0.73538,0.41498,-0.28502,-0.58502 +0.14539,0.633,-0.34317,-0.69393,0.51498,-0.28502,-0.58502 +0.21135,0.70476,-0.30348,-0.64125,0.61498,-0.28502,-0.58502 +0.28238,0.73323,-0.3058,-0.60734,0.71498,-0.28502,-0.58502 +0.35838,0.77016,-0.26611,-0.57968,0.81498,-0.28502,-0.58502 +0.39214,-0.81368,-0.18109,-0.55238,-0.88502,-0.18502,-0.58502 +0.3121,-0.78657,-0.17959,-0.59081,-0.78502,-0.18502,-0.58502 +0.23534,-0.72143,-0.22162,-0.65606,-0.68502,-0.18502,-0.58502 +0.16341,-0.68929,-0.22083,-0.69001,-0.58502,-0.18502,-0.58502 +0.097685,-0.62135,-0.2222,-0.75137,-0.48502,-0.18502,-0.58502 +0.040124,-0.5068,-0.22617,-0.83187,-0.38502,-0.18502,-0.58502 +-0.0075325,-0.42342,-0.23135,-0.87589,-0.28502,-0.18502,-0.58502 +-0.044035,-0.33181,-0.33181,-0.88306,-0.18502,-0.18502,-0.58502 +-0.06464,-0.14603,-0.34337,-0.92778,-0.085017,-0.18502,-0.58502 +-0.070463,0.048972,-0.3446,-0.93747,0.014983,-0.18502,-0.58502 +-0.060275,0.14606,-0.34086,-0.9287,0.11498,-0.18502,-0.58502 +-0.034018,0.33494,-0.24084,-0.91094,0.21498,-0.18502,-0.58502 +0.0051344,0.42328,-0.23531,-0.87491,0.31498,-0.18502,-0.58502 +0.056598,0.58428,-0.22492,-0.77976,0.41498,-0.18502,-0.58502 +0.11725,0.65606,-0.22163,-0.72143,0.51498,-0.18502,-0.58502 +0.18486,0.72162,-0.22059,-0.6562,0.61498,-0.18502,-0.58502 +0.25753,0.75137,-0.2222,-0.62135,0.71498,-0.18502,-0.58502 +0.33563,0.78651,-0.18,-0.59077,0.81498,-0.18502,-0.58502 +0.37956,-0.82415,-0.09116,-0.55899,-0.88502,-0.085017,-0.58502 +0.29848,-0.7965,-0.090369,-0.59785,-0.78502,-0.085017,-0.58502 +0.22014,-0.73661,-0.08957,-0.67036,-0.68502,-0.085017,-0.58502 +0.14693,-0.7005,-0.134,-0.70096,-0.58502,-0.085017,-0.58502 +0.080123,-0.63127,-0.1348,-0.76376,-0.48502,-0.085017,-0.58502 +0.021486,-0.51518,-0.13696,-0.84607,-0.38502,-0.085017,-0.58502 +-0.027188,-0.43299,-0.1427,-0.89003,-0.28502,-0.085017,-0.58502 +-0.06464,-0.34337,-0.14603,-0.92778,-0.18502,-0.085017,-0.58502 +-0.086069,-0.151,-0.151,-0.97693,-0.085017,-0.085017,-0.58502 +-0.09213,0.049984,-0.15185,-0.98714,0.014983,-0.085017,-0.58502 +-0.081592,0.15102,-0.14935,-0.97718,0.11498,-0.085017,-0.58502 +-0.054423,0.34345,-0.14333,-0.92817,0.21498,-0.085017,-0.58502 +-0.014276,0.4331,-0.13997,-0.89041,0.31498,-0.085017,-0.58502 +0.038318,0.59388,-0.13652,-0.79288,0.41498,-0.085017,-0.58502 +0.10005,0.66719,-0.13386,-0.73276,0.51498,-0.085017,-0.58502 +0.16873,0.73269,-0.13452,-0.66714,0.61498,-0.085017,-0.58502 +0.24275,0.76755,-0.090006,-0.63464,0.71498,-0.085017,-0.58502 +0.32238,0.79645,-0.090914,-0.59783,0.81498,-0.085017,-0.58502 +0.37632,-0.82764,0.00019149,-0.56126,-0.88502,0.014983,-0.58502 +0.29515,-0.79895,0.045784,-0.59965,-0.78502,0.014983,-0.58502 +0.21658,-0.73884,0.045106,-0.67237,-0.68502,0.014983,-0.58502 +0.14285,-0.70648,0.044908,-0.70631,-0.58502,0.014983,-0.58502 +0.075512,-0.63664,0.04517,-0.76984,-0.48502,0.014983,-0.58502 +0.016391,-0.52077,0.045835,-0.85247,-0.38502,0.014983,-0.58502 +-0.032712,-0.43591,0.046815,-0.89877,-0.28502,0.014983,-0.58502 +-0.070463,-0.3446,0.048975,-0.93747,-0.18502,0.014983,-0.58502 +-0.09213,-0.15185,0.049983,-0.98714,-0.085017,0.014983,-0.58502 +-0.098216,0.05088,0.050877,-0.99741,0.014983,0.014983,-0.58502 +-0.087573,0.15122,0.049982,-0.98724,0.11498,0.014983,-0.58502 +-0.060103,0.34555,0.048971,-0.93712,0.21498,0.014983,-0.58502 +-0.019644,0.43498,0.046813,-0.89922,0.31498,0.014983,-0.58502 +0.033401,0.59965,0.045784,-0.79895,0.41498,0.014983,-0.58502 +0.095607,0.67237,0.045106,-0.73884,0.51498,0.014983,-0.58502 +0.16483,0.73884,0.044858,-0.67238,0.61498,0.014983,-0.58502 +0.23928,0.76984,0.045171,-0.63664,0.71498,0.014983,-0.58502 +0.31909,0.79897,0.045134,-0.59967,0.81498,0.014983,-0.58502 +0.38249,-0.82419,0.091479,-0.55888,-0.88502,0.11498,-0.58502 +0.30201,-0.79188,0.13651,-0.59523,-0.78502,0.11498,-0.58502 +0.22408,-0.73269,0.13452,-0.66714,-0.68502,0.11498,-0.58502 +0.15095,-0.70096,0.134,-0.7005,-0.58502,0.11498,-0.58502 +0.084162,-0.63168,0.1348,-0.76342,-0.48502,0.11498,-0.58502 +0.025568,-0.51723,0.13696,-0.84482,-0.38502,0.11498,-0.58502 +-0.023002,-0.43057,0.14273,-0.8912,-0.28502,0.11498,-0.58502 +-0.060275,-0.34086,0.14606,-0.9287,-0.18502,0.11498,-0.58502 +-0.081592,-0.14935,0.15102,-0.97718,-0.085017,0.11498,-0.58502 +-0.087573,0.049981,0.15122,-0.98724,0.014983,0.11498,-0.58502 +-0.0771,0.14935,0.14935,-0.97744,0.11498,0.11498,-0.58502 +-0.050034,0.34088,0.14333,-0.92912,0.21498,0.11498,-0.58502 +-0.010068,0.43063,0.13996,-0.89161,0.31498,0.11498,-0.58502 +0.04243,0.59523,0.1365,-0.79188,0.41498,0.11498,-0.58502 +0.10409,0.66714,0.13452,-0.73269,0.51498,0.11498,-0.58502 +0.17274,0.73276,0.13386,-0.66719,0.61498,0.11498,-0.58502 +0.2466,0.76342,0.1348,-0.63168,0.71498,0.11498,-0.58502 +0.32573,0.79208,0.13477,-0.59535,0.81498,0.11498,-0.58502 +0.39786,-0.80599,0.22578,-0.54719,-0.88502,0.21498,-0.58502 +0.31871,-0.77825,0.22486,-0.58632,-0.78502,0.21498,-0.58502 +0.24199,-0.72076,0.22161,-0.6568,-0.68502,0.21498,-0.58502 +0.17003,-0.69001,0.22083,-0.68929,-0.58502,0.21498,-0.58502 +0.10487,-0.60814,0.30579,-0.73257,-0.48502,0.21498,-0.58502 +0.048482,-0.49943,0.31192,-0.80826,-0.38502,0.21498,-0.58502 +0.0016842,-0.41853,0.31947,-0.85016,-0.28502,0.21498,-0.58502 +-0.034018,-0.24084,0.33494,-0.91094,-0.18502,0.21498,-0.58502 +-0.054423,-0.14333,0.34345,-0.92817,-0.085017,0.21498,-0.58502 +-0.060103,0.048967,0.34556,-0.93712,0.014983,0.21498,-0.58502 +-0.050034,0.14332,0.34088,-0.92912,0.11498,0.21498,-0.58502 +-0.024149,0.33181,0.33181,-0.88306,0.21498,0.21498,-0.58502 +0.014256,0.41405,0.31957,-0.85231,0.31498,0.21498,-0.58502 +0.064608,0.57365,0.30938,-0.75843,0.41498,0.21498,-0.58502 +0.12407,0.64971,0.26294,-0.71326,0.51498,0.21498,-0.58502 +0.19146,0.72143,0.22162,-0.65606,0.61498,0.21498,-0.58502 +0.26419,0.75086,0.22219,-0.62196,0.71498,0.21498,-0.58502 +0.342,0.77976,0.22492,-0.58428,0.81498,0.21498,-0.58502 +0.34477,-0.75843,0.30938,-0.57365,-0.78502,0.31498,-0.58502 +0.26979,-0.70354,0.30479,-0.64198,-0.68502,0.31498,-0.58502 +0.20048,-0.65428,0.38128,-0.6531,-0.58502,0.31498,-0.58502 +0.13818,-0.59112,0.38404,-0.70928,-0.48502,0.31498,-0.58502 +0.083783,-0.48691,0.39294,-0.78008,-0.38502,0.31498,-0.58502 +0.038914,-0.40318,0.4085,-0.81889,-0.28502,0.31498,-0.58502 +0.0051345,-0.23531,0.42328,-0.87491,-0.18502,0.31498,-0.58502 +-0.014276,-0.13997,0.4331,-0.89041,-0.085017,0.31498,-0.58502 +-0.019644,0.046811,0.43498,-0.89922,0.014983,0.31498,-0.58502 +-0.010068,0.13997,0.43063,-0.89161,0.11498,0.31498,-0.58502 +0.014256,0.31957,0.41405,-0.85231,0.21498,0.31498,-0.58502 +0.051049,0.40343,0.40343,-0.82127,0.31498,0.31498,-0.58502 +0.09915,0.55821,0.38857,-0.73309,0.41498,0.31498,-0.58502 +0.15664,0.62358,0.38248,-0.6818,0.51498,0.31498,-0.58502 +0.22082,0.69393,0.34317,-0.633,0.61498,0.31498,-0.58502 +0.29155,0.73257,0.30579,-0.60814,0.71498,0.31498,-0.58502 +0.36747,0.76037,0.30952,-0.57099,0.81498,0.31498,-0.58502 +0.37954,-0.73309,0.38857,-0.55821,-0.78502,0.41498,-0.58502 +0.30691,-0.69731,0.4192,-0.58141,-0.68502,0.41498,-0.58502 +0.24103,-0.63163,0.4515,-0.63023,-0.58502,0.41498,-0.58502 +0.18112,-0.5723,0.45544,-0.68195,-0.48502,0.41498,-0.58502 +0.1296,-0.4653,0.50612,-0.72618,-0.38502,0.41498,-0.58502 +0.087479,-0.38883,0.55501,-0.73538,-0.28502,0.41498,-0.58502 +0.056598,-0.22492,0.58428,-0.77976,-0.18502,0.41498,-0.58502 +0.038318,-0.13652,0.59388,-0.79289,-0.085017,0.41498,-0.58502 +0.033401,0.045784,0.59965,-0.79895,0.014983,0.41498,-0.58502 +0.04243,0.1365,0.59523,-0.79188,0.11498,0.41498,-0.58502 +0.064608,0.30938,0.57365,-0.75843,0.21498,0.41498,-0.58502 +0.09915,0.38857,0.55821,-0.73309,0.31498,0.41498,-0.58502 +0.14364,0.49853,0.49853,-0.70919,0.41498,0.41498,-0.58502 +0.19867,0.60299,0.45286,-0.65675,0.51498,0.41498,-0.58502 +0.26055,0.65744,0.45117,-0.60351,0.61498,0.41498,-0.58502 +0.328,0.69691,0.41918,-0.58189,0.71498,0.41498,-0.58502 +0.35272,-0.6687,0.4863,-0.56245,-0.68502,0.51498,-0.58502 +0.28962,-0.60966,0.51074,-0.60618,-0.58502,0.51498,-0.58502 +0.23343,-0.51472,0.57902,-0.63229,-0.48502,0.51498,-0.58502 +0.18507,-0.45299,0.60154,-0.65799,-0.38502,0.51498,-0.58502 +0.14539,-0.34317,0.633,-0.69393,-0.28502,0.51498,-0.58502 +0.11725,-0.22162,0.65606,-0.72143,-0.18502,0.51498,-0.58502 +0.10005,-0.13386,0.66719,-0.73276,-0.085017,0.51498,-0.58502 +0.095607,0.045107,0.67237,-0.73884,0.014983,0.51498,-0.58502 +0.10409,0.13452,0.66714,-0.73269,0.11498,0.51498,-0.58502 +0.12407,0.26294,0.64971,-0.71326,0.21498,0.51498,-0.58502 +0.15664,0.38247,0.62358,-0.6818,0.31498,0.51498,-0.58502 +0.19867,0.45286,0.60299,-0.65675,0.41498,0.51498,-0.58502 +0.24924,0.54543,0.54543,-0.6364,0.51498,0.51498,-0.58502 +0.30838,0.63155,0.51045,-0.5836,0.61498,0.51498,-0.58502 +0.37284,0.68859,0.49219,-0.53254,0.71498,0.51498,-0.58502 +0.34621,-0.56272,0.60555,-0.56272,-0.58502,0.61498,-0.58502 +0.29308,-0.51045,0.63154,-0.5836,-0.48502,0.61498,-0.58502 +0.24748,-0.41716,0.67064,-0.61337,-0.38502,0.61498,-0.58502 +0.21133,-0.3035,0.70386,-0.64224,-0.28502,0.61498,-0.58502 +0.18484,-0.2206,0.72094,-0.65695,-0.18502,0.61498,-0.58502 +0.16873,-0.13386,0.73276,-0.66719,-0.085017,0.61498,-0.58502 +0.16484,0.045106,0.73884,-0.67237,0.014983,0.61498,-0.58502 +0.17275,0.13385,0.7332,-0.66671,0.11498,0.61498,-0.58502 +0.19147,0.22059,0.72162,-0.6562,0.21498,0.61498,-0.58502 +0.22082,0.34328,0.6939,-0.63298,0.31498,0.61498,-0.58502 +0.26058,0.45114,0.65878,-0.60207,0.41498,0.61498,-0.58502 +0.30843,0.51036,0.63491,-0.58002,0.51498,0.61498,-0.58502 +0.36335,0.58147,0.5928,-0.55721,0.61498,0.61498,-0.58502 +0.35898,-0.45544,0.68195,-0.5723,-0.48502,0.71498,-0.58502 +0.31647,-0.38404,0.70928,-0.59112,-0.38502,0.71498,-0.58502 +0.28238,-0.30579,0.73257,-0.60814,-0.28502,0.71498,-0.58502 +0.25753,-0.22219,0.75086,-0.62196,-0.18502,0.71498,-0.58502 +0.24275,-0.089822,0.76745,-0.63479,-0.085017,0.71498,-0.58502 +0.23928,0.04517,0.76996,-0.63649,0.014983,0.71498,-0.58502 +0.2466,0.1348,0.76376,-0.63127,0.11498,0.71498,-0.58502 +0.26419,0.2222,0.75137,-0.62135,0.21498,0.71498,-0.58502 +0.29155,0.3058,0.73323,-0.60734,0.31498,0.71498,-0.58502 +0.328,0.4192,0.69731,-0.58141,0.41498,0.71498,-0.58502 +0.37284,0.49194,0.68873,-0.53259,0.51498,0.71498,-0.58502 +0.38995,-0.34749,0.74804,-0.56541,-0.38502,0.81498,-0.58502 +0.35838,-0.26578,0.77024,-0.57973,-0.28502,0.81498,-0.58502 +0.33563,-0.17959,0.78657,-0.59081,-0.18502,0.81498,-0.58502 +0.32238,-0.090369,0.7965,-0.59785,-0.085017,0.81498,-0.58502 +0.31909,0.045784,0.79895,-0.59965,0.014983,0.81498,-0.58502 +0.32574,0.13651,0.79188,-0.59523,0.11498,0.81498,-0.58502 +0.34203,0.22486,0.77825,-0.58632,0.21498,0.81498,-0.58502 +0.3675,0.30938,0.75843,-0.57365,0.31498,0.81498,-0.58502 +0.39518,-0.35949,-0.81666,-0.45148,-0.38502,-0.88502,-0.48502 +0.36368,-0.27446,-0.84307,-0.46249,-0.28502,-0.88502,-0.48502 +0.34104,-0.18535,-0.86228,-0.4713,-0.18502,-0.88502,-0.48502 +0.32786,-0.093492,-0.87387,-0.47709,-0.085017,-0.88502,-0.48502 +0.32454,-0.00024099,-0.87772,-0.47918,0.014983,-0.88502,-0.48502 +0.3311,0.13984,-0.86902,-0.47461,0.11498,-0.88502,-0.48502 +0.34728,0.23077,-0.85346,-0.46728,0.21498,-0.88502,-0.48502 +0.37266,0.31823,-0.83044,-0.45728,0.31498,-0.88502,-0.48502 +0.35858,-0.4729,-0.74346,-0.4729,-0.48502,-0.78502,-0.48502 +0.3161,-0.39765,-0.77808,-0.48628,-0.38502,-0.78502,-0.48502 +0.28197,-0.31618,-0.8069,-0.49895,-0.28502,-0.78502,-0.48502 +0.25708,-0.22965,-0.82922,-0.50956,-0.18502,-0.78502,-0.48502 +0.24243,-0.092705,-0.84966,-0.51912,-0.085017,-0.78502,-0.48502 +0.23896,0.045835,-0.85247,-0.52077,0.014983,-0.78502,-0.48502 +0.24625,0.13696,-0.84482,-0.51723,0.11498,-0.78502,-0.48502 +0.26385,0.22616,-0.83,-0.50986,0.21498,-0.78502,-0.48502 +0.2913,0.3164,-0.80914,-0.49516,0.31498,-0.78502,-0.48502 +0.32788,0.39806,-0.78062,-0.48186,0.41498,-0.78502,-0.48502 +0.37267,0.47353,-0.74584,-0.46849,0.51498,-0.78502,-0.48502 +0.39884,-0.63023,-0.63163,-0.4515,-0.68502,-0.68502,-0.48502 +0.33837,-0.57129,-0.68274,-0.45551,-0.58502,-0.68502,-0.48502 +0.28438,-0.49853,-0.70919,-0.49853,-0.48502,-0.68502,-0.48502 +0.23877,-0.39125,-0.75874,-0.5208,-0.38502,-0.68502,-0.48502 +0.20229,-0.30938,-0.75843,-0.57365,-0.28502,-0.68502,-0.48502 +0.17551,-0.22486,-0.77825,-0.58632,-0.18502,-0.68502,-0.48502 +0.15921,-0.13651,-0.79188,-0.59523,-0.085017,-0.68502,-0.48502 +0.15529,0.045134,-0.79897,-0.59967,0.014983,-0.68502,-0.48502 +0.16329,0.13652,-0.79289,-0.59388,0.11498,-0.68502,-0.48502 +0.18223,0.22492,-0.77976,-0.58428,0.21498,-0.68502,-0.48502 +0.21174,0.34749,-0.74804,-0.56541,0.31498,-0.68502,-0.48502 +0.25166,0.4653,-0.72618,-0.50612,0.41498,-0.68502,-0.48502 +0.30017,0.53254,-0.68859,-0.49219,0.51498,-0.68502,-0.48502 +0.35633,0.60154,-0.65799,-0.45299,0.61498,-0.68502,-0.48502 +0.33837,-0.68195,-0.5723,-0.45544,-0.68502,-0.58502,-0.48502 +0.27431,-0.60618,-0.60966,-0.51075,-0.58502,-0.58502,-0.48502 +0.21699,-0.52277,-0.67337,-0.52277,-0.48502,-0.58502,-0.48502 +0.16743,-0.45551,-0.68274,-0.57129,-0.38502,-0.58502,-0.48502 +0.12667,-0.34457,-0.72237,-0.59955,-0.28502,-0.58502,-0.48502 +0.097685,-0.2222,-0.75137,-0.62135,-0.18502,-0.58502,-0.48502 +0.080123,-0.1348,-0.76376,-0.63127,-0.085017,-0.58502,-0.48502 +0.075512,0.04517,-0.76984,-0.63664,0.014983,-0.58502,-0.48502 +0.084162,0.1348,-0.76342,-0.63168,0.11498,-0.58502,-0.48502 +0.10487,0.30579,-0.73257,-0.60814,0.21498,-0.58502,-0.48502 +0.13818,0.38404,-0.70928,-0.59112,0.31498,-0.58502,-0.48502 +0.18112,0.45544,-0.68195,-0.5723,0.41498,-0.58502,-0.48502 +0.23343,0.57903,-0.63229,-0.51472,0.51498,-0.58502,-0.48502 +0.29309,0.62971,-0.58233,-0.51415,0.61498,-0.58502,-0.48502 +0.35898,0.68274,-0.57129,-0.45551,0.71498,-0.58502,-0.48502 +0.35848,-0.74585,-0.47102,-0.47102,-0.78502,-0.48502,-0.48502 +0.28438,-0.70895,-0.49869,-0.49869,-0.68502,-0.48502,-0.48502 +0.21697,-0.67085,-0.52438,-0.52438,-0.58502,-0.48502,-0.48502 +0.15506,-0.57357,-0.57923,-0.57923,-0.48502,-0.48502,-0.48502 +0.10165,-0.51075,-0.60792,-0.60792,-0.38502,-0.48502,-0.48502 +0.058311,-0.38128,-0.65369,-0.65369,-0.28502,-0.48502,-0.48502 +0.025478,-0.22083,-0.68965,-0.68965,-0.18502,-0.48502,-0.48502 +0.0067866,-0.134,-0.70073,-0.70073,-0.085017,-0.48502,-0.48502 +0.0015726,0.044907,-0.70639,-0.70639,0.014983,-0.48502,-0.48502 +0.010802,0.134,-0.70073,-0.70073,0.11498,-0.48502,-0.48502 +0.034406,0.30379,-0.67369,-0.67369,0.21498,-0.48502,-0.48502 +0.069769,0.41572,-0.64311,-0.64311,0.31498,-0.48502,-0.48502 +0.11696,0.51075,-0.60792,-0.60792,0.41498,-0.48502,-0.48502 +0.17332,0.59959,-0.5659,-0.5659,0.51498,-0.48502,-0.48502 +0.23717,0.67337,-0.52276,-0.52277,0.61498,-0.48502,-0.48502 +0.30626,0.74853,-0.46888,-0.46889,0.71498,-0.48502,-0.48502 +0.38086,0.74346,-0.4729,-0.4729,0.81498,-0.48502,-0.48502 +0.39518,-0.81664,-0.35938,-0.45159,-0.88502,-0.38502,-0.48502 +0.31601,-0.78008,-0.39294,-0.48691,-0.78502,-0.38502,-0.48502 +0.23877,-0.75836,-0.39121,-0.52139,-0.68502,-0.38502,-0.48502 +0.16743,-0.68195,-0.45544,-0.5723,-0.58502,-0.38502,-0.48502 +0.10165,-0.60618,-0.51074,-0.60966,-0.48502,-0.38502,-0.48502 +0.045102,-0.52277,-0.52276,-0.67337,-0.38502,-0.38502,-0.48502 +-0.0026714,-0.38495,-0.55563,-0.73695,-0.28502,-0.38502,-0.48502 +-0.037696,-0.30778,-0.57254,-0.75991,-0.18502,-0.38502,-0.48502 +-0.058713,-0.13476,-0.59398,-0.79311,-0.085017,-0.38502,-0.48502 +-0.064474,0.045134,-0.59967,-0.79897,0.014983,-0.38502,-0.48502 +-0.054527,0.22231,-0.5866,-0.77876,0.11498,-0.38502,-0.48502 +-0.028572,0.30617,-0.57414,-0.75936,0.21498,-0.38502,-0.48502 +0.010681,0.45722,-0.54224,-0.70493,0.31498,-0.38502,-0.48502 +0.060839,0.55303,-0.5188,-0.65192,0.41498,-0.38502,-0.48502 +0.12097,0.65878,-0.45114,-0.60207,0.51498,-0.38502,-0.48502 +0.18858,0.70311,-0.46095,-0.54144,0.61498,-0.38502,-0.48502 +0.2614,0.75874,-0.39125,-0.5208,0.71498,-0.38502,-0.48502 +0.33941,0.77808,-0.39765,-0.48628,0.81498,-0.38502,-0.48502 +0.36368,-0.84307,-0.27427,-0.46261,-0.88502,-0.28502,-0.48502 +0.28192,-0.80826,-0.31192,-0.49943,-0.78502,-0.28502,-0.48502 +0.20228,-0.76037,-0.30952,-0.57099,-0.68502,-0.28502,-0.48502 +0.12667,-0.72203,-0.34448,-0.6,-0.58502,-0.28502,-0.48502 +0.058311,-0.6531,-0.38128,-0.65428,-0.48502,-0.28502,-0.48502 +-0.0026714,-0.55563,-0.38495,-0.73695,-0.38502,-0.28502,-0.48502 +-0.053621,-0.4729,-0.4729,-0.74346,-0.28502,-0.28502,-0.48502 +-0.091507,-0.31618,-0.49895,-0.80689,-0.18502,-0.28502,-0.48502 +-0.11465,-0.13937,-0.5171,-0.8445,-0.085017,-0.28502,-0.48502 +-0.12093,0.045834,-0.52077,-0.85247,0.014983,-0.28502,-0.48502 +-0.10973,0.22616,-0.50986,-0.83,0.11498,-0.28502,-0.48502 +-0.082111,0.3164,-0.49516,-0.80914,0.21498,-0.28502,-0.48502 +-0.039489,0.47353,-0.46849,-0.74584,0.31498,-0.28502,-0.48502 +0.014627,0.62235,-0.38255,-0.68289,0.41498,-0.28502,-0.48502 +0.078737,0.68343,-0.38092,-0.62275,0.51498,-0.28502,-0.48502 +0.14903,0.74797,-0.34771,-0.56537,0.61498,-0.28502,-0.48502 +0.22542,0.7854,-0.31102,-0.53518,0.71498,-0.28502,-0.48502 +0.30615,0.8069,-0.31618,-0.49895,0.81498,-0.28502,-0.48502 +0.38938,0.84307,-0.27446,-0.46249,0.91498,-0.28502,-0.48502 +0.34104,-0.86228,-0.18508,-0.4714,-0.88502,-0.18502,-0.48502 +0.25708,-0.83,-0.22616,-0.50985,-0.78502,-0.18502,-0.48502 +0.17549,-0.77976,-0.22492,-0.58428,-0.68502,-0.18502,-0.48502 +0.097685,-0.75086,-0.22219,-0.62196,-0.58502,-0.18502,-0.48502 +0.025478,-0.68929,-0.22083,-0.69001,-0.48502,-0.18502,-0.48502 +-0.037696,-0.57254,-0.30778,-0.75991,-0.38502,-0.18502,-0.48502 +-0.091507,-0.49895,-0.31618,-0.8069,-0.28502,-0.18502,-0.48502 +-0.13237,-0.32764,-0.32764,-0.88618,-0.18502,-0.18502,-0.48502 +-0.15746,-0.14332,-0.34088,-0.92912,-0.085017,-0.18502,-0.48502 +-0.16419,0.047929,-0.34557,-0.93717,0.014983,-0.18502,-0.48502 +-0.15195,0.23698,-0.33869,-0.91056,0.11498,-0.18502,-0.48502 +-0.1221,0.41383,-0.32429,-0.85064,0.21498,-0.18502,-0.48502 +-0.076667,0.49943,-0.31192,-0.80826,0.31498,-0.18502,-0.48502 +-0.0197,0.64224,-0.3035,-0.70386,0.41498,-0.18502,-0.48502 +0.047075,0.72162,-0.22059,-0.6562,0.51498,-0.18502,-0.48502 +0.12095,0.78032,-0.22231,-0.58453,0.61498,-0.18502,-0.48502 +0.19911,0.80598,-0.22578,-0.54719,0.71498,-0.18502,-0.48502 +0.282,0.83858,-0.18351,-0.51294,0.81498,-0.18502,-0.48502 +0.36724,0.86228,-0.18535,-0.4713,0.91498,-0.18502,-0.48502 +0.32786,-0.87387,-0.093098,-0.47715,-0.88502,-0.085017,-0.48502 +0.24243,-0.84972,-0.091949,-0.51915,-0.78502,-0.085017,-0.48502 +0.15921,-0.79208,-0.13477,-0.59535,-0.68502,-0.085017,-0.48502 +0.080123,-0.76342,-0.1348,-0.63168,-0.58502,-0.085017,-0.48502 +0.0067866,-0.7005,-0.134,-0.70096,-0.48502,-0.085017,-0.48502 +-0.058713,-0.59398,-0.13476,-0.79311,-0.38502,-0.085017,-0.48502 +-0.11465,-0.5171,-0.13937,-0.8445,-0.28502,-0.085017,-0.48502 +-0.15746,-0.34088,-0.14332,-0.92912,-0.18502,-0.085017,-0.48502 +-0.18379,-0.14935,-0.14935,-0.97744,-0.085017,-0.085017,-0.48502 +-0.19084,0.049984,-0.15185,-0.98714,0.014983,-0.085017,-0.48502 +-0.17791,0.24675,-0.14896,-0.95756,0.11498,-0.085017,-0.48502 +-0.14655,0.43057,-0.14273,-0.8912,0.21498,-0.085017,-0.48502 +-0.099241,0.51723,-0.13696,-0.84482,0.31498,-0.085017,-0.48502 +-0.039936,0.66666,-0.13453,-0.73312,0.41498,-0.085017,-0.48502 +0.02875,0.7332,-0.13385,-0.66671,0.51498,-0.085017,-0.48502 +0.10376,0.79188,-0.13651,-0.59523,0.61498,-0.085017,-0.48502 +0.18319,0.82419,-0.091478,-0.55888,0.71498,-0.085017,-0.48502 +0.26791,0.84966,-0.092705,-0.51912,0.81498,-0.085017,-0.48502 +0.35436,0.87387,-0.093492,-0.47709,0.91498,-0.085017,-0.48502 +0.32454,-0.87772,0.00024113,-0.47918,-0.88502,0.014983,-0.48502 +0.23896,-0.85243,0.04675,-0.52075,-0.78502,0.014983,-0.48502 +0.15529,-0.79895,0.045784,-0.59965,-0.68502,0.014983,-0.48502 +0.075512,-0.76996,0.04517,-0.63649,-0.58502,0.014983,-0.48502 +0.0015725,-0.70648,0.044908,-0.70631,-0.48502,0.014983,-0.48502 +-0.064474,-0.59967,0.045134,-0.79897,-0.38502,0.014983,-0.48502 +-0.12093,-0.52077,0.045835,-0.85247,-0.28502,0.014983,-0.48502 +-0.16419,-0.34557,0.047929,-0.93717,-0.18502,0.014983,-0.48502 +-0.19084,-0.15185,0.049983,-0.98714,-0.085017,0.014983,-0.48502 +-0.19796,0.05088,0.050877,-0.99741,0.014983,0.014983,-0.48502 +-0.18482,0.25052,0.049938,-0.96682,0.11498,0.014983,-0.48502 +-0.15309,0.43589,0.047859,-0.89873,0.21498,0.014983,-0.48502 +-0.10531,0.52,0.045833,-0.85293,0.31498,0.014983,-0.48502 +-0.045514,0.67237,0.045106,-0.73884,0.41498,0.014983,-0.48502 +0.023711,0.73884,0.044858,-0.67238,0.51498,0.014983,-0.48502 +0.099332,0.79897,0.045134,-0.59967,0.61498,0.014983,-0.48502 +0.17945,0.82682,0.045862,-0.56059,0.71498,0.014983,-0.48502 +0.26451,0.85247,0.045836,-0.52077,0.81498,0.014983,-0.48502 +0.35106,0.87772,-0.00024132,-0.47918,0.91498,0.014983,-0.48502 +0.3311,-0.86911,0.13984,-0.47444,-0.88502,0.11498,-0.48502 +0.2463,-0.8445,0.13937,-0.5171,-0.78502,0.11498,-0.48502 +0.1633,-0.79188,0.13651,-0.59523,-0.68502,0.11498,-0.48502 +0.084162,-0.76376,0.1348,-0.63127,-0.58502,0.11498,-0.48502 +0.010802,-0.70096,0.134,-0.7005,-0.48502,0.11498,-0.48502 +-0.054527,-0.5866,0.22231,-0.77876,-0.38502,0.11498,-0.48502 +-0.10973,-0.50986,0.22616,-0.83,-0.28502,0.11498,-0.48502 +-0.15195,-0.33869,0.23698,-0.91056,-0.18502,0.11498,-0.48502 +-0.17791,-0.14896,0.24675,-0.95756,-0.085017,0.11498,-0.48502 +-0.18482,0.04994,0.25052,-0.96682,0.014983,0.11498,-0.48502 +-0.17202,0.24556,0.24556,-0.93776,0.11498,0.11498,-0.48502 +-0.14111,0.4268,0.23519,-0.87323,0.21498,0.11498,-0.48502 +-0.094414,0.50956,0.22965,-0.82922,0.31498,0.11498,-0.48502 +-0.035902,0.66671,0.13385,-0.7332,0.41498,0.11498,-0.48502 +0.032753,0.73313,0.13453,-0.66665,0.51498,0.11498,-0.48502 +0.10778,0.79208,0.13477,-0.59535,0.61498,0.11498,-0.48502 +0.18727,0.81973,0.13689,-0.55615,0.71498,0.11498,-0.48502 +0.27157,0.84481,0.13696,-0.51723,0.81498,0.11498,-0.48502 +0.35738,0.86902,0.13984,-0.47461,0.91498,0.11498,-0.48502 +0.34728,-0.85358,0.23078,-0.46705,-0.88502,0.21498,-0.48502 +0.26395,-0.83187,0.22617,-0.5068,-0.78502,0.21498,-0.48502 +0.18225,-0.77825,0.22486,-0.58632,-0.68502,0.21498,-0.48502 +0.10487,-0.73323,0.3058,-0.60734,-0.58502,0.21498,-0.48502 +0.034406,-0.67416,0.30379,-0.67321,-0.48502,0.21498,-0.48502 +-0.028572,-0.57414,0.30617,-0.75935,-0.38502,0.21498,-0.48502 +-0.082111,-0.49516,0.3164,-0.80914,-0.28502,0.21498,-0.48502 +-0.1221,-0.32429,0.41383,-0.85064,-0.18502,0.21498,-0.48502 +-0.14655,-0.14273,0.43057,-0.8912,-0.085017,0.21498,-0.48502 +-0.15309,0.047861,0.43589,-0.89873,0.014983,0.21498,-0.48502 +-0.14111,0.23519,0.4268,-0.87323,0.11498,0.21498,-0.48502 +-0.11201,0.40806,0.40806,-0.81668,0.21498,0.21498,-0.48502 +-0.06724,0.49553,0.31198,-0.81063,0.31498,0.21498,-0.48502 +-0.010553,0.64198,0.30479,-0.70354,0.41498,0.21498,-0.48502 +0.055465,0.70386,0.3035,-0.64224,0.51498,0.21498,-0.48502 +0.1277,0.77024,0.26579,-0.57973,0.61498,0.21498,-0.48502 +0.20587,0.80569,0.22577,-0.54762,0.71498,0.21498,-0.48502 +0.28874,0.83102,0.22974,-0.50657,0.81498,0.21498,-0.48502 +0.37312,0.85346,0.23077,-0.46728,0.91498,0.21498,-0.48502 +0.37266,-0.83057,0.31824,-0.45703,-0.88502,0.31498,-0.48502 +0.2914,-0.81063,0.31199,-0.49553,-0.78502,0.31498,-0.48502 +0.21174,-0.74797,0.34771,-0.56537,-0.68502,0.31498,-0.48502 +0.13818,-0.71006,0.38408,-0.59017,-0.58502,0.31498,-0.48502 +0.069769,-0.64343,0.41573,-0.64278,-0.48502,0.31498,-0.48502 +0.010681,-0.54224,0.45722,-0.70493,-0.38502,0.31498,-0.48502 +-0.039489,-0.46849,0.47353,-0.74584,-0.28502,0.31498,-0.48502 +-0.076667,-0.31192,0.49943,-0.80826,-0.18502,0.31498,-0.48502 +-0.099241,-0.13696,0.51723,-0.84482,-0.085017,0.31498,-0.48502 +-0.10531,0.045834,0.52,-0.85293,0.014983,0.31498,-0.48502 +-0.094414,0.22965,0.50956,-0.82922,0.11498,0.31498,-0.48502 +-0.06724,0.31198,0.49553,-0.81063,0.21498,0.31498,-0.48502 +-0.025331,0.46889,0.46889,-0.74853,0.31498,0.31498,-0.48502 +0.027406,0.60299,0.45286,-0.65675,0.41498,0.31498,-0.48502 +0.09014,0.68289,0.38255,-0.62235,0.51498,0.31498,-0.48502 +0.16015,0.73449,0.38489,-0.5589,0.61498,0.31498,-0.48502 +0.23475,0.77287,0.35077,-0.52881,0.71498,0.31498,-0.48502 +0.31555,0.80914,0.3164,-0.49516,0.81498,0.31498,-0.48502 +0.39786,0.84307,0.27427,-0.46261,0.91498,0.31498,-0.48502 +0.32796,-0.78283,0.39312,-0.48232,-0.78502,0.41498,-0.48502 +0.25166,-0.72649,0.46535,-0.50563,-0.68502,0.41498,-0.48502 +0.18112,-0.68274,0.45551,-0.57129,-0.58502,0.41498,-0.48502 +0.11696,-0.60966,0.51074,-0.60618,-0.48502,0.41498,-0.48502 +0.060839,-0.5188,0.55303,-0.65192,-0.38502,0.41498,-0.48502 +0.014627,-0.38255,0.62235,-0.68289,-0.28502,0.41498,-0.48502 +-0.0197,-0.3035,0.64224,-0.70386,-0.18502,0.41498,-0.48502 +-0.039936,-0.13453,0.66666,-0.73312,-0.085017,0.41498,-0.48502 +-0.045514,0.045107,0.67237,-0.73884,0.014983,0.41498,-0.48502 +-0.035902,0.13385,0.66671,-0.7332,0.11498,0.41498,-0.48502 +-0.010553,0.30479,0.64198,-0.70354,0.21498,0.41498,-0.48502 +0.027406,0.45286,0.60299,-0.65675,0.31498,0.41498,-0.48502 +0.076432,0.54543,0.54543,-0.6364,0.41498,0.41498,-0.48502 +0.13582,0.63155,0.51045,-0.5836,0.51498,0.41498,-0.48502 +0.20224,0.7052,0.45933,-0.54011,0.61498,0.41498,-0.48502 +0.27356,0.74364,0.42791,-0.51371,0.71498,0.41498,-0.48502 +0.35127,0.78062,0.39806,-0.48186,0.81498,0.41498,-0.48502 +0.37273,-0.74853,0.46888,-0.46889,-0.78502,0.51498,-0.48502 +0.30017,-0.68873,0.53259,-0.49194,-0.68502,0.51498,-0.48502 +0.23344,-0.62971,0.58233,-0.51415,-0.58502,0.51498,-0.48502 +0.17311,-0.56272,0.60555,-0.56272,-0.48502,0.51498,-0.48502 +0.12097,-0.453,0.65799,-0.60154,-0.38502,0.51498,-0.48502 +0.078707,-0.38095,0.6823,-0.62397,-0.28502,0.51498,-0.48502 +0.047069,-0.22162,0.72143,-0.65606,-0.18502,0.51498,-0.48502 +0.028737,-0.13386,0.73276,-0.66719,-0.085017,0.51498,-0.48502 +0.023715,0.045106,0.73884,-0.67237,0.014983,0.51498,-0.48502 +0.032761,0.13385,0.7332,-0.66671,0.11498,0.51498,-0.48502 +0.05549,0.30479,0.70354,-0.64198,0.21498,0.51498,-0.48502 +0.090152,0.38092,0.68343,-0.62275,0.31498,0.51498,-0.48502 +0.13588,0.51415,0.62971,-0.58233,0.41498,0.51498,-0.48502 +0.1902,0.58147,0.5928,-0.55721,0.51498,0.51498,-0.48502 +0.25285,0.65192,0.55303,-0.5188,0.61498,0.51498,-0.48502 +0.32123,0.72618,0.50612,-0.4653,0.71498,0.51498,-0.48502 +0.39502,0.74584,0.47353,-0.46849,0.81498,0.51498,-0.48502 +0.35635,-0.65878,0.60207,-0.45114,-0.68502,0.61498,-0.48502 +0.29308,-0.5836,0.63154,-0.51045,-0.58502,0.61498,-0.48502 +0.23707,-0.52438,0.67085,-0.52438,-0.48502,0.61498,-0.48502 +0.18854,-0.45722,0.70493,-0.54224,-0.38502,0.61498,-0.48502 +0.14903,-0.34749,0.74804,-0.56541,-0.28502,0.61498,-0.48502 +0.12092,-0.22231,0.77876,-0.5866,-0.18502,0.61498,-0.48502 +0.10374,-0.13477,0.79208,-0.59535,-0.085017,0.61498,-0.48502 +0.099339,0.045784,0.79895,-0.59965,0.014983,0.61498,-0.48502 +0.1078,0.13476,0.79311,-0.59398,0.11498,0.61498,-0.48502 +0.1277,0.26611,0.77016,-0.57968,0.21498,0.61498,-0.48502 +0.16021,0.38495,0.73695,-0.55563,0.31498,0.61498,-0.48502 +0.20232,0.45739,0.70758,-0.53863,0.41498,0.61498,-0.48502 +0.25285,0.55293,0.65199,-0.51882,0.51498,0.61498,-0.48502 +0.31081,0.61962,0.62072,-0.48038,0.61498,0.61498,-0.48502 +0.37606,0.68195,0.5723,-0.45544,0.71498,0.61498,-0.48502 +0.35898,-0.5723,0.68195,-0.45544,-0.58502,0.71498,-0.48502 +0.30625,-0.47101,0.74585,-0.47102,-0.48502,0.71498,-0.48502 +0.2614,-0.39121,0.75836,-0.52139,-0.38502,0.71498,-0.48502 +0.22542,-0.31101,0.78504,-0.53571,-0.28502,0.71498,-0.48502 +0.19911,-0.22577,0.80569,-0.54762,-0.18502,0.71498,-0.48502 +0.18319,-0.09116,0.82415,-0.55899,-0.085017,0.71498,-0.48502 +0.17945,0.045861,0.8269,-0.56047,0.014983,0.71498,-0.48502 +0.18727,0.13689,0.81993,-0.55585,0.11498,0.71498,-0.48502 +0.20587,0.22578,0.80598,-0.54719,0.21498,0.71498,-0.48502 +0.23475,0.35088,0.77301,-0.52853,0.31498,0.71498,-0.48502 +0.27356,0.42788,0.74384,-0.51345,0.41498,0.71498,-0.48502 +0.32123,0.50563,0.72649,-0.46535,0.51498,0.71498,-0.48502 +0.37606,0.57129,0.68274,-0.45551,0.61498,0.71498,-0.48502 +0.38083,-0.47101,0.74585,-0.47102,-0.48502,0.81498,-0.48502 +0.33938,-0.39294,0.78008,-0.48691,-0.38502,0.81498,-0.48502 +0.30614,-0.31192,0.80826,-0.49943,-0.28502,0.81498,-0.48502 +0.282,-0.18296,0.83868,-0.51297,-0.18502,0.81498,-0.48502 +0.26791,-0.09195,0.84972,-0.51915,-0.085017,0.81498,-0.48502 +0.26451,0.04675,0.85243,-0.52075,0.014983,0.81498,-0.48502 +0.2716,0.13937,0.8445,-0.5171,0.11498,0.81498,-0.48502 +0.28881,0.22964,0.82922,-0.50956,0.21498,0.81498,-0.48502 +0.31562,0.31618,0.8069,-0.49895,0.31498,0.81498,-0.48502 +0.35133,0.39765,0.77808,-0.48628,0.41498,0.81498,-0.48502 +0.39503,0.4729,0.74346,-0.4729,0.51498,0.81498,-0.48502 +0.38938,-0.27427,0.84307,-0.46261,-0.28502,0.91498,-0.48502 +0.36724,-0.18508,0.86228,-0.4714,-0.18502,0.91498,-0.48502 +0.35436,-0.093098,0.87387,-0.47715,-0.085017,0.91498,-0.48502 +0.35106,0.0002411,0.87772,-0.47918,0.014983,0.91498,-0.48502 +0.35738,0.13984,0.86911,-0.47444,0.11498,0.91498,-0.48502 +0.37312,0.23078,0.85358,-0.46705,0.21498,0.91498,-0.48502 +0.39786,0.27446,0.84307,-0.46249,0.31498,0.91498,-0.48502 +0.38961,-0.14332,-0.92912,-0.34088,-0.18502,-0.98502,-0.38502 +0.37688,-0.097095,-0.93379,-0.34441,-0.085017,-0.98502,-0.38502 +0.37352,-0.0005214,-0.93825,-0.34597,0.014983,-0.98502,-0.38502 +0.37958,0.096259,-0.93387,-0.34442,0.11498,-0.98502,-0.38502 +0.39489,0.19173,-0.92062,-0.34014,0.21498,-0.98502,-0.38502 +0.39518,-0.45148,-0.81666,-0.35949,-0.48502,-0.88502,-0.38502 +0.35409,-0.36888,-0.85315,-0.36888,-0.38502,-0.88502,-0.38502 +0.32135,-0.28134,-0.88218,-0.37764,-0.28502,-0.88502,-0.38502 +0.29775,-0.18988,-0.90325,-0.38482,-0.18502,-0.88502,-0.38502 +0.284,-0.095752,-0.91598,-0.38964,-0.085017,-0.88502,-0.38502 +0.28059,0.047952,-0.91925,-0.39074,0.014983,-0.88502,-0.38502 +0.28748,0.14319,-0.9107,-0.38745,0.11498,-0.88502,-0.38502 +0.3044,0.23639,-0.89368,-0.38139,0.21498,-0.88502,-0.38502 +0.33083,0.32623,-0.86846,-0.3733,0.31498,-0.88502,-0.38502 +0.36609,0.41154,-0.83552,-0.36406,0.41498,-0.88502,-0.38502 +0.3679,-0.55821,-0.73309,-0.38856,-0.58502,-0.78502,-0.38502 +0.3161,-0.48628,-0.77808,-0.39765,-0.48502,-0.78502,-0.38502 +0.27176,-0.40806,-0.81668,-0.40806,-0.38502,-0.78502,-0.38502 +0.23604,-0.32404,-0.8486,-0.41817,-0.28502,-0.78502,-0.38502 +0.2099,-0.23519,-0.87323,-0.4268,-0.18502,-0.78502,-0.38502 +0.19426,-0.094865,-0.89567,-0.43449,-0.085017,-0.78502,-0.38502 +0.19063,0.046815,-0.89877,-0.43591,0.014983,-0.78502,-0.38502 +0.19833,0.13997,-0.89041,-0.4331,0.11498,-0.78502,-0.38502 +0.21681,0.23531,-0.87491,-0.42328,0.21498,-0.78502,-0.38502 +0.2456,0.32429,-0.85064,-0.41383,0.31498,-0.78502,-0.38502 +0.28386,0.4085,-0.81889,-0.40318,0.41498,-0.78502,-0.38502 +0.3306,0.48691,-0.78008,-0.39294,0.51498,-0.78502,-0.38502 +0.38463,0.56541,-0.74804,-0.34749,0.61498,-0.78502,-0.38502 +0.35792,-0.6531,-0.65428,-0.38128,-0.68502,-0.68502,-0.38502 +0.29529,-0.59017,-0.71006,-0.38408,-0.58502,-0.68502,-0.38502 +0.23877,-0.5208,-0.75874,-0.39124,-0.48502,-0.68502,-0.38502 +0.19004,-0.43934,-0.78356,-0.43934,-0.38502,-0.68502,-0.38502 +0.1514,-0.31824,-0.83057,-0.45703,-0.28502,-0.68502,-0.38502 +0.1232,-0.22965,-0.82922,-0.50956,-0.18502,-0.68502,-0.38502 +0.10596,-0.13937,-0.8445,-0.5171,-0.085017,-0.68502,-0.38502 +0.10164,0.046752,-0.85289,-0.52,0.014983,-0.68502,-0.38502 +0.11013,0.1394,-0.84572,-0.51509,0.11498,-0.68502,-0.38502 +0.13008,0.22974,-0.83102,-0.50657,0.21498,-0.68502,-0.38502 +0.16185,0.40097,-0.80044,-0.44556,0.31498,-0.68502,-0.38502 +0.2042,0.47807,-0.76383,-0.43361,0.41498,-0.68502,-0.38502 +0.2554,0.55501,-0.73538,-0.38883,0.51498,-0.68502,-0.38502 +0.31393,0.62235,-0.68289,-0.38255,0.61498,-0.68502,-0.38502 +0.37807,0.68343,-0.62275,-0.38092,0.71498,-0.68502,-0.38502 +0.36788,-0.73449,-0.5589,-0.38489,-0.78502,-0.58502,-0.38502 +0.29529,-0.70928,-0.59112,-0.38404,-0.68502,-0.58502,-0.38502 +0.22755,-0.64279,-0.64343,-0.41573,-0.58502,-0.58502,-0.38502 +0.16743,-0.57129,-0.68274,-0.45551,-0.48502,-0.58502,-0.38502 +0.1152,-0.46889,-0.74853,-0.46888,-0.38502,-0.58502,-0.38502 +0.072068,-0.39312,-0.78283,-0.48232,-0.28502,-0.58502,-0.38502 +0.040124,-0.22617,-0.83187,-0.5068,-0.18502,-0.58502,-0.38502 +0.021486,-0.13696,-0.84607,-0.51518,-0.085017,-0.58502,-0.38502 +0.016391,0.045835,-0.85247,-0.52077,0.014983,-0.58502,-0.38502 +0.025568,0.13696,-0.84482,-0.51723,0.11498,-0.58502,-0.38502 +0.048482,0.31192,-0.80826,-0.49943,0.21498,-0.58502,-0.38502 +0.083783,0.39294,-0.78008,-0.48691,0.31498,-0.58502,-0.38502 +0.1296,0.50612,-0.72618,-0.4653,0.41498,-0.58502,-0.38502 +0.18507,0.60154,-0.65799,-0.45299,0.51498,-0.58502,-0.38502 +0.24748,0.67062,-0.61335,-0.41722,0.61498,-0.58502,-0.38502 +0.31647,0.71006,-0.59017,-0.38408,0.71498,-0.58502,-0.38502 +0.38995,0.74797,-0.56537,-0.34771,0.81498,-0.58502,-0.38502 +0.39518,-0.81664,-0.45159,-0.35938,-0.88502,-0.48502,-0.38502 +0.31601,-0.78008,-0.48691,-0.39294,-0.78502,-0.48502,-0.38502 +0.23877,-0.75836,-0.52139,-0.39121,-0.68502,-0.48502,-0.38502 +0.16743,-0.68195,-0.5723,-0.45544,-0.58502,-0.48502,-0.38502 +0.10165,-0.60618,-0.60966,-0.51075,-0.48502,-0.48502,-0.38502 +0.045102,-0.52277,-0.67337,-0.52277,-0.38502,-0.48502,-0.38502 +-0.0026714,-0.38495,-0.73695,-0.55563,-0.28502,-0.48502,-0.38502 +-0.037696,-0.30778,-0.75991,-0.57255,-0.18502,-0.48502,-0.38502 +-0.058713,-0.13477,-0.79311,-0.59398,-0.085017,-0.48502,-0.38502 +-0.064474,0.045134,-0.79897,-0.59967,0.014983,-0.48502,-0.38502 +-0.054527,0.22231,-0.77876,-0.5866,0.11498,-0.48502,-0.38502 +-0.028572,0.30617,-0.75935,-0.57414,0.21498,-0.48502,-0.38502 +0.010681,0.45722,-0.70493,-0.54224,0.31498,-0.48502,-0.38502 +0.060839,0.55303,-0.65192,-0.5188,0.41498,-0.48502,-0.38502 +0.12097,0.65878,-0.60207,-0.45114,0.51498,-0.48502,-0.38502 +0.18858,0.70311,-0.54144,-0.46096,0.61498,-0.48502,-0.38502 +0.2614,0.75874,-0.5208,-0.39125,0.71498,-0.48502,-0.38502 +0.33941,0.77808,-0.48628,-0.39765,0.81498,-0.48502,-0.38502 +0.35409,-0.8532,-0.36881,-0.36881,-0.88502,-0.38502,-0.38502 +0.27162,-0.81889,-0.40584,-0.40584,-0.78502,-0.38502,-0.38502 +0.19004,-0.78346,-0.43943,-0.43943,-0.68502,-0.38502,-0.38502 +0.11511,-0.74585,-0.47102,-0.47102,-0.58502,-0.38502,-0.38502 +0.045005,-0.67085,-0.52438,-0.52438,-0.48502,-0.38502,-0.38502 +-0.018126,-0.55673,-0.61653,-0.55673,-0.38502,-0.38502,-0.38502 +-0.069967,-0.45114,-0.65878,-0.60207,-0.28502,-0.38502,-0.38502 +-0.10932,-0.30348,-0.70476,-0.64125,-0.18502,-0.38502,-0.38502 +-0.13321,-0.13385,-0.66671,-0.7332,-0.085017,-0.38502,-0.38502 +-0.13955,0.044858,-0.73884,-0.67238,0.014983,-0.38502,-0.38502 +-0.12779,0.2206,-0.72094,-0.65695,0.11498,-0.38502,-0.38502 +-0.099045,0.38095,-0.6823,-0.62397,0.21498,-0.38502,-0.38502 +-0.055668,0.51045,-0.5836,-0.63154,0.31498,-0.38502,-0.38502 +0.00018366,0.59959,-0.5659,-0.5659,0.41498,-0.38502,-0.38502 +0.065156,0.66879,-0.5257,-0.5257,0.51498,-0.38502,-0.38502 +0.13758,0.74346,-0.4729,-0.4729,0.61498,-0.38502,-0.38502 +0.21429,0.82127,-0.40343,-0.40343,0.71498,-0.38502,-0.38502 +0.29623,0.81668,-0.40806,-0.40806,0.81498,-0.38502,-0.38502 +0.37989,0.85315,-0.36888,-0.36888,0.91498,-0.38502,-0.38502 +0.32135,-0.88224,-0.28117,-0.37762,-0.88502,-0.28502,-0.38502 +0.23594,-0.85016,-0.31947,-0.41853,-0.78502,-0.28502,-0.38502 +0.1514,-0.83044,-0.31823,-0.45727,-0.68502,-0.28502,-0.38502 +0.072008,-0.78008,-0.39294,-0.48691,-0.58502,-0.28502,-0.38502 +-0.0026903,-0.73538,-0.38883,-0.55501,-0.48502,-0.28502,-0.38502 +-0.069967,-0.60207,-0.45114,-0.65878,-0.38502,-0.28502,-0.38502 +-0.1269,-0.5257,-0.5257,-0.66878,-0.28502,-0.28502,-0.38502 +-0.17052,-0.38856,-0.55821,-0.73309,-0.18502,-0.28502,-0.38502 +-0.19742,-0.13476,-0.59398,-0.79311,-0.085017,-0.28502,-0.38502 +-0.20434,0.045134,-0.59967,-0.79897,0.014983,-0.28502,-0.38502 +-0.19104,0.22492,-0.58428,-0.77976,0.11498,-0.28502,-0.38502 +-0.15896,0.38883,-0.55501,-0.73537,0.21498,-0.28502,-0.38502 +-0.11118,0.52644,-0.52233,-0.67085,0.31498,-0.28502,-0.38502 +-0.050228,0.65675,-0.45286,-0.60299,0.41498,-0.28502,-0.38502 +0.019412,0.73695,-0.38495,-0.55563,0.51498,-0.28502,-0.38502 +0.095404,0.77808,-0.39765,-0.48628,0.61498,-0.28502,-0.38502 +0.17641,0.85231,-0.31957,-0.41405,0.71498,-0.28502,-0.38502 +0.26147,0.84861,-0.32404,-0.41817,0.81498,-0.28502,-0.38502 +0.34787,0.88218,-0.28134,-0.37764,0.91498,-0.28502,-0.38502 +0.38961,-0.9287,-0.14606,-0.34086,-0.98502,-0.18502,-0.38502 +0.29775,-0.90331,-0.1896,-0.38482,-0.88502,-0.18502,-0.38502 +0.20987,-0.87414,-0.23133,-0.42704,-0.78502,-0.18502,-0.38502 +0.12319,-0.83102,-0.22974,-0.50657,-0.68502,-0.18502,-0.38502 +0.040091,-0.83,-0.22616,-0.50985,-0.58502,-0.18502,-0.38502 +-0.037747,-0.75935,-0.30617,-0.57414,-0.48502,-0.18502,-0.38502 +-0.10932,-0.64125,-0.30348,-0.70477,-0.38502,-0.18502,-0.38502 +-0.17052,-0.55821,-0.38857,-0.73309,-0.28502,-0.18502,-0.38502 +-0.21814,-0.40806,-0.40806,-0.81668,-0.18502,-0.18502,-0.38502 +-0.24827,-0.23519,-0.4268,-0.87323,-0.085017,-0.18502,-0.38502 +-0.25606,0.046815,-0.43591,-0.89877,0.014983,-0.18502,-0.38502 +-0.24134,0.23531,-0.42328,-0.87491,0.11498,-0.18502,-0.38502 +-0.20602,0.48186,-0.39806,-0.78062,0.21498,-0.18502,-0.38502 +-0.15382,0.5589,-0.38489,-0.73449,0.31498,-0.18502,-0.38502 +-0.088206,0.70476,-0.30348,-0.64125,0.41498,-0.18502,-0.38502 +-0.014969,0.75843,-0.30938,-0.57365,0.51498,-0.18502,-0.38502 +0.065052,0.83187,-0.22617,-0.5068,0.61498,-0.18502,-0.38502 +0.14865,0.85358,-0.23078,-0.46705,0.71498,-0.18502,-0.38502 +0.23607,0.87323,-0.23519,-0.4268,0.81498,-0.18502,-0.38502 +0.32485,0.90325,-0.18988,-0.38482,0.91498,-0.18502,-0.38502 +0.37688,-0.93387,-0.096259,-0.34441,-0.98502,-0.085017,-0.38502 +0.284,-0.91602,-0.095335,-0.38965,-0.88502,-0.085017,-0.38502 +0.19426,-0.89575,-0.094016,-0.43451,-0.78502,-0.085017,-0.38502 +0.10595,-0.84573,-0.1394,-0.51509,-0.68502,-0.085017,-0.38502 +0.021464,-0.84482,-0.13696,-0.51723,-0.58502,-0.085017,-0.38502 +-0.058739,-0.79208,-0.13477,-0.59535,-0.48502,-0.085017,-0.38502 +-0.13321,-0.66671,-0.13385,-0.7332,-0.38502,-0.085017,-0.38502 +-0.19742,-0.59398,-0.13476,-0.79311,-0.28502,-0.085017,-0.38502 +-0.24827,-0.4268,-0.23519,-0.87323,-0.18502,-0.085017,-0.38502 +-0.28052,-0.24556,-0.24556,-0.93776,-0.085017,-0.085017,-0.38502 +-0.28903,0.049939,-0.24966,-0.96705,0.014983,-0.085017,-0.38502 +-0.27322,0.24564,-0.24234,-0.93858,0.11498,-0.085017,-0.38502 +-0.23522,0.50985,-0.22616,-0.83,0.21498,-0.085017,-0.38502 +-0.17964,0.59535,-0.13477,-0.79208,0.31498,-0.085017,-0.38502 +-0.11124,0.7332,-0.13385,-0.66671,0.41498,-0.085017,-0.38502 +-0.034955,0.79188,-0.13651,-0.59523,0.51498,-0.085017,-0.38502 +0.046817,0.8445,-0.13937,-0.5171,0.61498,-0.085017,-0.38502 +0.13178,0.86911,-0.13984,-0.47444,0.71498,-0.085017,-0.38502 +0.2211,0.89567,-0.094864,-0.43449,0.81498,-0.085017,-0.38502 +0.31145,0.91598,-0.095752,-0.38964,0.91498,-0.085017,-0.38502 +0.37352,-0.93825,0.0005204,-0.34597,-0.98502,0.014983,-0.38502 +0.28059,-0.91926,0.047955,-0.39072,-0.88502,0.014983,-0.38502 +0.19064,-0.89873,0.047861,-0.43589,-0.78502,0.014983,-0.38502 +0.10165,-0.85243,0.04675,-0.52075,-0.68502,0.014983,-0.38502 +0.016399,-0.85294,0.045832,-0.52,-0.58502,0.014983,-0.38502 +-0.064465,-0.79935,0.045132,-0.59916,-0.48502,0.014983,-0.38502 +-0.13955,-0.73901,0.044858,-0.6722,-0.38502,0.014983,-0.38502 +-0.20434,-0.59967,0.045134,-0.79897,-0.28502,0.014983,-0.38502 +-0.25606,-0.43591,0.046815,-0.89877,-0.18502,0.014983,-0.38502 +-0.28903,-0.24966,0.04994,-0.96705,-0.085017,0.014983,-0.38502 +-0.2977,0.05088,0.050877,-0.99741,0.014983,0.014983,-0.38502 +-0.28151,0.24965,0.049031,-0.96709,0.11498,0.014983,-0.38502 +-0.24263,0.52075,0.046749,-0.85243,0.21498,0.014983,-0.38502 +-0.18636,0.59916,0.045132,-0.79936,0.31498,0.014983,-0.38502 +-0.11741,0.73884,0.044858,-0.67238,0.41498,0.014983,-0.38502 +-0.040532,0.79897,0.045134,-0.59967,0.51498,0.014983,-0.38502 +0.041936,0.85247,0.045836,-0.52077,0.61498,0.014983,-0.38502 +0.12769,0.87684,0.046837,-0.4785,0.71498,0.014983,-0.38502 +0.21757,0.89877,0.046814,-0.43591,0.81498,0.014983,-0.38502 +0.30806,0.91925,0.047953,-0.39074,0.91498,0.014983,-0.38502 +0.37958,-0.93379,0.097096,-0.34441,-0.98502,0.11498,-0.38502 +0.28748,-0.91072,0.14319,-0.38742,-0.88502,0.11498,-0.38502 +0.19839,-0.89003,0.14269,-0.43299,-0.78502,0.11498,-0.38502 +0.11014,-0.8445,0.13937,-0.5171,-0.68502,0.11498,-0.38502 +0.02559,-0.84607,0.13696,-0.51518,-0.58502,0.11498,-0.38502 +-0.054516,-0.77825,0.22486,-0.58632,-0.48502,0.11498,-0.38502 +-0.12778,-0.72162,0.22059,-0.6562,-0.38502,0.11498,-0.38502 +-0.19104,-0.58428,0.22492,-0.77976,-0.28502,0.11498,-0.38502 +-0.24134,-0.42328,0.23531,-0.87491,-0.18502,0.11498,-0.38502 +-0.27322,-0.24234,0.24564,-0.93858,-0.085017,0.11498,-0.38502 +-0.28151,0.049029,0.24965,-0.96709,0.014983,0.11498,-0.38502 +-0.26589,0.24235,0.24235,-0.93943,0.11498,0.11498,-0.38502 +-0.22829,0.50956,0.22965,-0.82922,0.21498,0.11498,-0.38502 +-0.17346,0.58453,0.22231,-0.78032,0.31498,0.11498,-0.38502 +-0.10618,0.72094,0.2206,-0.65695,0.41498,0.11498,-0.38502 +-0.030916,0.79289,0.13652,-0.59388,0.51498,0.11498,-0.38502 +0.0509,0.84572,0.1394,-0.51509,0.61498,0.11498,-0.38502 +0.13598,0.86902,0.13984,-0.47461,0.71498,0.11498,-0.38502 +0.22501,0.89041,0.13997,-0.4331,0.81498,0.11498,-0.38502 +0.31471,0.9107,0.14319,-0.38745,0.91498,0.11498,-0.38502 +0.39489,-0.92051,0.19227,-0.34013,-0.98502,0.21498,-0.38502 +0.3044,-0.89368,0.23639,-0.38138,-0.88502,0.21498,-0.38502 +0.21692,-0.87589,0.23135,-0.42342,-0.78502,0.21498,-0.38502 +0.13008,-0.82922,0.22965,-0.50956,-0.68502,0.21498,-0.38502 +0.048526,-0.81063,0.31199,-0.49553,-0.58502,0.21498,-0.38502 +-0.028521,-0.76139,0.30618,-0.57144,-0.48502,0.21498,-0.38502 +-0.099038,-0.68343,0.38093,-0.62275,-0.38502,0.21498,-0.38502 +-0.15896,-0.55501,0.38883,-0.73537,-0.28502,0.21498,-0.38502 +-0.20602,-0.39806,0.48186,-0.78062,-0.18502,0.21498,-0.38502 +-0.23522,-0.22616,0.50986,-0.83,-0.085017,0.21498,-0.38502 +-0.24263,0.046748,0.52075,-0.85243,0.014983,0.21498,-0.38502 +-0.22829,0.22965,0.50956,-0.82922,0.11498,0.21498,-0.38502 +-0.19389,0.40343,0.40343,-0.82127,0.21498,0.21498,-0.38502 +-0.14224,0.55563,0.38495,-0.73695,0.31498,0.21498,-0.38502 +-0.078599,0.6823,0.38095,-0.62397,0.41498,0.21498,-0.38502 +-0.0057884,0.76037,0.30952,-0.57099,0.51498,0.21498,-0.38502 +0.072703,0.80826,0.31192,-0.49943,0.61498,0.21498,-0.38502 +0.15558,0.85346,0.23077,-0.46728,0.71498,0.21498,-0.38502 +0.24303,0.87491,0.23531,-0.42328,0.81498,0.21498,-0.38502 +0.33115,0.89368,0.23639,-0.38139,0.91498,0.21498,-0.38502 +0.33083,-0.86844,0.32623,-0.37335,-0.88502,0.31498,-0.38502 +0.24567,-0.85231,0.31957,-0.41405,-0.78502,0.31498,-0.38502 +0.16185,-0.80055,0.40098,-0.44534,-0.68502,0.31498,-0.38502 +0.083848,-0.78283,0.39312,-0.48232,-0.58502,0.31498,-0.38502 +0.010757,-0.70758,0.45739,-0.53862,-0.48502,0.31498,-0.38502 +-0.055658,-0.63491,0.51036,-0.58002,-0.38502,0.31498,-0.38502 +-0.11118,-0.52233,0.52644,-0.67085,-0.28502,0.31498,-0.38502 +-0.15382,-0.38489,0.5589,-0.73449,-0.18502,0.31498,-0.38502 +-0.17964,-0.13477,0.59535,-0.79208,-0.085017,0.31498,-0.38502 +-0.18636,0.045132,0.59916,-0.79935,0.014983,0.31498,-0.38502 +-0.17346,0.2223,0.58453,-0.78032,0.11498,0.31498,-0.38502 +-0.14224,0.38495,0.55563,-0.73695,0.21498,0.31498,-0.38502 +-0.095458,0.52276,0.52277,-0.67338,0.31498,0.31498,-0.38502 +-0.036711,0.65799,0.453,-0.60154,0.41498,0.31498,-0.38502 +0.031805,0.70493,0.45722,-0.54224,0.51498,0.31498,-0.38502 +0.10716,0.78035,0.3955,-0.48439,0.61498,0.31498,-0.38502 +0.1862,0.83552,0.36406,-0.41154,0.71498,0.31498,-0.38502 +0.27109,0.85064,0.32429,-0.41383,0.81498,0.31498,-0.38502 +0.35691,0.86846,0.32623,-0.3733,0.91498,0.31498,-0.38502 +0.36609,-0.83545,0.41153,-0.36423,-0.88502,0.41498,-0.38502 +0.2839,-0.82128,0.40343,-0.40343,-0.78502,0.41498,-0.38502 +0.2042,-0.76391,0.47809,-0.43344,-0.68502,0.41498,-0.38502 +0.1296,-0.72649,0.50563,-0.46535,-0.58502,0.41498,-0.38502 +0.060839,-0.65199,0.55293,-0.51882,-0.48502,0.41498,-0.38502 +8.9431e-06,-0.56272,0.60555,-0.56272,-0.38502,0.41498,-0.38502 +-0.050272,-0.45117,0.65744,-0.60351,-0.28502,0.41498,-0.38502 +-0.08824,-0.3035,0.70386,-0.64224,-0.18502,0.41498,-0.38502 +-0.11126,-0.13453,0.73313,-0.66666,-0.085017,0.41498,-0.38502 +-0.11741,0.045106,0.73884,-0.67237,0.014983,0.41498,-0.38502 +-0.10617,0.22161,0.72076,-0.6568,0.11498,0.41498,-0.38502 +-0.078584,0.38248,0.6818,-0.62358,0.21498,0.41498,-0.38502 +-0.036707,0.45114,0.65878,-0.60207,0.31498,0.41498,-0.38502 +0.017047,0.58147,0.5928,-0.55721,0.41498,0.41498,-0.38502 +0.080883,0.67085,0.52644,-0.52233,0.51498,0.41498,-0.38502 +0.15165,0.74584,0.47353,-0.46849,0.61498,0.41498,-0.38502 +0.22754,0.78062,0.48186,-0.39806,0.71498,0.41498,-0.38502 +0.3084,0.81889,0.4085,-0.40318,0.81498,0.41498,-0.38502 +0.3913,0.83552,0.41154,-0.36406,0.91498,0.41498,-0.38502 +0.33063,-0.78283,0.48232,-0.39312,-0.78502,0.51498,-0.38502 +0.25543,-0.73695,0.55563,-0.38494,-0.68502,0.51498,-0.38502 +0.1851,-0.65675,0.60299,-0.45286,-0.58502,0.51498,-0.38502 +0.12097,-0.60154,0.65799,-0.453,-0.48502,0.51498,-0.38502 +0.065108,-0.52438,0.67085,-0.52438,-0.38502,0.51498,-0.38502 +0.019346,-0.38883,0.73538,-0.55501,-0.28502,0.51498,-0.38502 +-0.014992,-0.30617,0.75935,-0.57414,-0.18502,0.51498,-0.38502 +-0.035004,-0.13477,0.79208,-0.59535,-0.085017,0.51498,-0.38502 +-0.040521,0.045784,0.79895,-0.59965,0.014983,0.51498,-0.38502 +-0.030908,0.13476,0.79311,-0.59398,0.11498,0.51498,-0.38502 +-0.005705,0.30618,0.76139,-0.57144,0.21498,0.51498,-0.38502 +0.031845,0.46095,0.70311,-0.54144,0.31498,0.51498,-0.38502 +0.080909,0.5257,0.66878,-0.5257,0.41498,0.51498,-0.38502 +0.13913,0.63023,0.63163,-0.4515,0.51498,0.51498,-0.38502 +0.20494,0.68195,0.5723,-0.45544,0.61498,0.51498,-0.38502 +0.27744,0.73537,0.55501,-0.38883,0.71498,0.51498,-0.38502 +0.35397,0.78008,0.48691,-0.39294,0.81498,0.51498,-0.38502 +0.38463,-0.74797,0.56537,-0.34771,-0.78502,0.61498,-0.38502 +0.31396,-0.6818,0.62358,-0.38247,-0.68502,0.61498,-0.38502 +0.24748,-0.61337,0.67064,-0.41716,-0.58502,0.61498,-0.38502 +0.18854,-0.54224,0.70493,-0.45722,-0.48502,0.61498,-0.38502 +0.13746,-0.47101,0.74585,-0.47102,-0.38502,0.61498,-0.38502 +0.095384,-0.39294,0.78008,-0.48691,-0.28502,0.61498,-0.38502 +0.064992,-0.22974,0.83102,-0.50657,-0.18502,0.61498,-0.38502 +0.04678,-0.13696,0.84482,-0.51723,-0.085017,0.61498,-0.38502 +0.041948,0.04675,0.85243,-0.52075,0.014983,0.61498,-0.38502 +0.050944,0.13696,0.84607,-0.51518,0.11498,0.61498,-0.38502 +0.072731,0.31618,0.8069,-0.49895,0.21498,0.61498,-0.38502 +0.10731,0.39312,0.78283,-0.48232,0.31498,0.61498,-0.38502 +0.15168,0.46889,0.74853,-0.46889,0.41498,0.61498,-0.38502 +0.20494,0.57129,0.68274,-0.45551,0.51498,0.61498,-0.38502 +0.26635,0.6531,0.65428,-0.38128,0.61498,0.61498,-0.38502 +0.33439,0.68289,0.62235,-0.38255,0.71498,0.61498,-0.38502 +0.37806,-0.62397,0.6823,-0.38095,-0.68502,0.71498,-0.38502 +0.31647,-0.59112,0.70928,-0.38404,-0.58502,0.71498,-0.38502 +0.2614,-0.52139,0.75836,-0.39121,-0.48502,0.71498,-0.38502 +0.21427,-0.40584,0.81889,-0.40584,-0.38502,0.71498,-0.38502 +0.1764,-0.31947,0.85016,-0.41853,-0.28502,0.71498,-0.38502 +0.14865,-0.23077,0.85346,-0.46728,-0.18502,0.71498,-0.38502 +0.13178,-0.13984,0.86902,-0.47461,-0.085017,0.71498,-0.38502 +0.12769,0.046838,0.87687,-0.47843,0.014983,0.71498,-0.38502 +0.13598,0.13984,0.86911,-0.47444,0.11498,0.71498,-0.38502 +0.15558,0.23078,0.85358,-0.46705,0.21498,0.71498,-0.38502 +0.1862,0.36423,0.83545,-0.41153,0.31498,0.71498,-0.38502 +0.22755,0.48628,0.77808,-0.39765,0.41498,0.71498,-0.38502 +0.27746,0.55821,0.73309,-0.38856,0.51498,0.71498,-0.38502 +0.33439,0.62358,0.6818,-0.38248,0.61498,0.71498,-0.38502 +0.3971,0.66418,0.66471,-0.34208,0.71498,0.71498,-0.38502 +0.38995,-0.56541,0.74804,-0.34749,-0.58502,0.81498,-0.38502 +0.33938,-0.48691,0.78008,-0.39294,-0.48502,0.81498,-0.38502 +0.29616,-0.40584,0.81889,-0.40584,-0.38502,0.81498,-0.38502 +0.26142,-0.31947,0.85016,-0.41853,-0.28502,0.81498,-0.38502 +0.23606,-0.23133,0.87414,-0.42704,-0.18502,0.81498,-0.38502 +0.2211,-0.094015,0.89575,-0.43451,-0.085017,0.81498,-0.38502 +0.21757,0.04786,0.89873,-0.43589,0.014983,0.81498,-0.38502 +0.22506,0.1427,0.89003,-0.43299,0.11498,0.81498,-0.38502 +0.24311,0.23519,0.87323,-0.4268,0.21498,0.81498,-0.38502 +0.27118,0.32404,0.84861,-0.41817,0.31498,0.81498,-0.38502 +0.30846,0.40806,0.81668,-0.40806,0.41498,0.81498,-0.38502 +0.35398,0.48628,0.77808,-0.39765,0.51498,0.81498,-0.38502 +0.37989,-0.36881,0.8532,-0.36881,-0.38502,0.91498,-0.38502 +0.34787,-0.28117,0.88224,-0.37762,-0.28502,0.91498,-0.38502 +0.32485,-0.1896,0.90331,-0.38483,-0.18502,0.91498,-0.38502 +0.31145,-0.095335,0.91602,-0.38965,-0.085017,0.91498,-0.38502 +0.30806,0.047953,0.91926,-0.39073,0.014983,0.91498,-0.38502 +0.31471,0.14319,0.91072,-0.38742,0.11498,0.91498,-0.38502 +0.33115,0.23639,0.89368,-0.38138,0.21498,0.91498,-0.38502 +0.35691,0.32623,0.86844,-0.37335,0.31498,0.91498,-0.38502 +0.3913,0.41153,0.83545,-0.36423,0.41498,0.91498,-0.38502 +0.38018,-0.24235,-0.93943,-0.24235,-0.28502,-0.98502,-0.28502 +0.35773,-0.14659,-0.95793,-0.24675,-0.18502,-0.98502,-0.28502 +0.34463,-0.099107,-0.96325,-0.24965,-0.085017,-0.98502,-0.28502 +0.34119,-0.00045285,-0.96803,-0.25083,0.014983,-0.98502,-0.28502 +0.34747,0.098382,-0.96332,-0.24966,0.11498,-0.98502,-0.28502 +0.36326,0.19587,-0.94915,-0.24647,0.21498,-0.98502,-0.28502 +0.38818,0.29061,-0.92577,-0.24185,0.31498,-0.98502,-0.28502 +0.36368,-0.46249,-0.84307,-0.27446,-0.48502,-0.88502,-0.28502 +0.32135,-0.37764,-0.88218,-0.28134,-0.38502,-0.88502,-0.28502 +0.28753,-0.28791,-0.91335,-0.28791,-0.28502,-0.88502,-0.28502 +0.26305,-0.19428,-0.93604,-0.29341,-0.18502,-0.88502,-0.28502 +0.24878,-0.09796,-0.94979,-0.29716,-0.085017,-0.88502,-0.28502 +0.24528,0.049063,-0.95333,-0.29793,0.014983,-0.88502,-0.28502 +0.25247,0.1465,-0.9441,-0.29531,0.11498,-0.88502,-0.28502 +0.27001,0.24185,-0.92577,-0.29061,0.21498,-0.88502,-0.28502 +0.29738,0.33383,-0.89868,-0.28448,0.31498,-0.88502,-0.28502 +0.33381,0.42131,-0.86337,-0.27765,0.41498,-0.88502,-0.28502 +0.37835,0.50346,-0.82039,-0.27108,0.51498,-0.88502,-0.28502 +0.3956,-0.64971,-0.71326,-0.26294,-0.68502,-0.78502,-0.28502 +0.33551,-0.57968,-0.77016,-0.26611,-0.58502,-0.78502,-0.28502 +0.28197,-0.49895,-0.80689,-0.31618,-0.48502,-0.78502,-0.28502 +0.23604,-0.41817,-0.84861,-0.32404,-0.38502,-0.78502,-0.28502 +0.19894,-0.33181,-0.88306,-0.33181,-0.28502,-0.78502,-0.28502 +0.17174,-0.24073,-0.90964,-0.33854,-0.18502,-0.78502,-0.28502 +0.15531,-0.097095,-0.93379,-0.34441,-0.085017,-0.78502,-0.28502 +0.15151,0.047929,-0.93717,-0.34557,0.014983,-0.78502,-0.28502 +0.15956,0.14333,-0.92817,-0.34345,0.11498,-0.78502,-0.28502 +0.17884,0.24084,-0.91094,-0.33494,0.21498,-0.78502,-0.28502 +0.20878,0.33203,-0.88458,-0.32754,0.31498,-0.78502,-0.28502 +0.24848,0.41853,-0.85016,-0.31947,0.41498,-0.78502,-0.28502 +0.29689,0.49943,-0.80826,-0.31192,0.51498,-0.78502,-0.28502 +0.35275,0.57973,-0.77024,-0.26579,0.61498,-0.78502,-0.28502 +0.3956,-0.71329,-0.64974,-0.2628,-0.78502,-0.68502,-0.28502 +0.32516,-0.67321,-0.67416,-0.30379,-0.68502,-0.68502,-0.28502 +0.26066,-0.64198,-0.70354,-0.30479,-0.58502,-0.68502,-0.28502 +0.20229,-0.57365,-0.75843,-0.30938,-0.48502,-0.68502,-0.28502 +0.1514,-0.45703,-0.83057,-0.31824,-0.38502,-0.68502,-0.28502 +0.11039,-0.32764,-0.88618,-0.32764,-0.28502,-0.68502,-0.28502 +0.080646,-0.23701,-0.91192,-0.33501,-0.18502,-0.68502,-0.28502 +0.062456,-0.14332,-0.92912,-0.34088,-0.085017,-0.68502,-0.28502 +0.057797,0.047929,-0.93717,-0.34557,0.014983,-0.68502,-0.28502 +0.066742,0.14333,-0.92817,-0.34345,0.11498,-0.68502,-0.28502 +0.087752,0.28448,-0.89868,-0.33383,0.21498,-0.68502,-0.28502 +0.12183,0.41383,-0.85064,-0.32429,0.31498,-0.68502,-0.28502 +0.16623,0.49516,-0.80914,-0.3164,0.41498,-0.68502,-0.28502 +0.21939,0.57099,-0.76037,-0.30952,0.51498,-0.68502,-0.28502 +0.27987,0.64224,-0.70386,-0.3035,0.61498,-0.68502,-0.28502 +0.34594,0.71326,-0.64971,-0.26294,0.71498,-0.68502,-0.28502 +0.33551,-0.77024,-0.57972,-0.26579,-0.78502,-0.58502,-0.28502 +0.26066,-0.70442,-0.64099,-0.30483,-0.68502,-0.58502,-0.28502 +0.19042,-0.67321,-0.67416,-0.30379,-0.58502,-0.58502,-0.28502 +0.12667,-0.59955,-0.72237,-0.34456,-0.48502,-0.58502,-0.28502 +0.072068,-0.48232,-0.78283,-0.39312,-0.38502,-0.58502,-0.28502 +0.026812,-0.40806,-0.81668,-0.40806,-0.28502,-0.58502,-0.28502 +-0.0075324,-0.23136,-0.87589,-0.42342,-0.18502,-0.58502,-0.28502 +-0.027188,-0.1427,-0.89003,-0.43299,-0.085017,-0.58502,-0.28502 +-0.032712,0.046815,-0.89877,-0.43591,0.014983,-0.58502,-0.28502 +-0.023002,0.14273,-0.8912,-0.43057,0.11498,-0.58502,-0.28502 +0.0016842,0.31947,-0.85016,-0.41853,0.21498,-0.58502,-0.28502 +0.038914,0.4085,-0.81889,-0.40318,0.31498,-0.58502,-0.28502 +0.087479,0.55501,-0.73538,-0.38883,0.41498,-0.58502,-0.28502 +0.14539,0.633,-0.69393,-0.34317,0.51498,-0.58502,-0.28502 +0.21135,0.70477,-0.64125,-0.30348,0.61498,-0.58502,-0.28502 +0.28238,0.73323,-0.60734,-0.3058,0.71498,-0.58502,-0.28502 +0.35838,0.77016,-0.57968,-0.26611,0.81498,-0.58502,-0.28502 +0.36368,-0.84307,-0.46261,-0.27427,-0.88502,-0.48502,-0.28502 +0.28192,-0.80826,-0.49943,-0.31192,-0.78502,-0.48502,-0.28502 +0.20228,-0.76037,-0.57099,-0.30951,-0.68502,-0.48502,-0.28502 +0.12667,-0.72203,-0.6,-0.34449,-0.58502,-0.48502,-0.28502 +0.058311,-0.6531,-0.65428,-0.38128,-0.48502,-0.48502,-0.28502 +-0.0026714,-0.55563,-0.73695,-0.38495,-0.38502,-0.48502,-0.28502 +-0.053621,-0.4729,-0.74346,-0.4729,-0.28502,-0.48502,-0.28502 +-0.091507,-0.31618,-0.8069,-0.49895,-0.18502,-0.48502,-0.28502 +-0.11465,-0.13937,-0.8445,-0.5171,-0.085017,-0.48502,-0.28502 +-0.12093,0.045835,-0.85247,-0.52077,0.014983,-0.48502,-0.28502 +-0.10973,0.22616,-0.83,-0.50986,0.11498,-0.48502,-0.28502 +-0.082111,0.3164,-0.80914,-0.49516,0.21498,-0.48502,-0.28502 +-0.039489,0.47353,-0.74584,-0.46849,0.31498,-0.48502,-0.28502 +0.014627,0.62235,-0.68289,-0.38255,0.41498,-0.48502,-0.28502 +0.078737,0.68343,-0.62275,-0.38092,0.51498,-0.48502,-0.28502 +0.14903,0.74797,-0.56537,-0.34771,0.61498,-0.48502,-0.28502 +0.22542,0.7854,-0.53518,-0.31102,0.71498,-0.48502,-0.28502 +0.30615,0.8069,-0.49895,-0.31618,0.81498,-0.48502,-0.28502 +0.38938,0.84307,-0.46249,-0.27446,0.91498,-0.48502,-0.28502 +0.32135,-0.88224,-0.37762,-0.28117,-0.88502,-0.38502,-0.28502 +0.23594,-0.85016,-0.41853,-0.31947,-0.78502,-0.38502,-0.28502 +0.1514,-0.83044,-0.45728,-0.31823,-0.68502,-0.38502,-0.28502 +0.072008,-0.78008,-0.48691,-0.39294,-0.58502,-0.38502,-0.28502 +-0.0026903,-0.73538,-0.55501,-0.38883,-0.48502,-0.38502,-0.28502 +-0.069967,-0.60207,-0.65878,-0.45113,-0.38502,-0.38502,-0.28502 +-0.1269,-0.5257,-0.66878,-0.5257,-0.28502,-0.38502,-0.28502 +-0.17052,-0.38857,-0.73309,-0.55821,-0.18502,-0.38502,-0.28502 +-0.19742,-0.13477,-0.79311,-0.59398,-0.085017,-0.38502,-0.28502 +-0.20434,0.045134,-0.79897,-0.59967,0.014983,-0.38502,-0.28502 +-0.19104,0.22492,-0.77976,-0.58428,0.11498,-0.38502,-0.28502 +-0.15896,0.38883,-0.73538,-0.55501,0.21498,-0.38502,-0.28502 +-0.11118,0.52644,-0.67085,-0.52233,0.31498,-0.38502,-0.28502 +-0.050228,0.65675,-0.60299,-0.45286,0.41498,-0.38502,-0.28502 +0.019412,0.73695,-0.55563,-0.38494,0.51498,-0.38502,-0.28502 +0.095404,0.77808,-0.48628,-0.39765,0.61498,-0.38502,-0.28502 +0.17641,0.85231,-0.41405,-0.31957,0.71498,-0.38502,-0.28502 +0.26147,0.8486,-0.41817,-0.32404,0.81498,-0.38502,-0.28502 +0.34787,0.88218,-0.37764,-0.28134,0.91498,-0.38502,-0.28502 +0.38017,-0.93858,-0.24399,-0.24399,-0.98502,-0.28502,-0.28502 +0.28753,-0.91344,-0.28778,-0.28778,-0.88502,-0.28502,-0.28502 +0.19883,-0.88458,-0.32978,-0.32978,-0.78502,-0.28502,-0.28502 +0.11037,-0.88458,-0.32978,-0.32978,-0.68502,-0.28502,-0.28502 +0.026673,-0.81889,-0.40584,-0.40584,-0.58502,-0.28502,-0.28502 +-0.053679,-0.74584,-0.47354,-0.46849,-0.48502,-0.28502,-0.28502 +-0.12696,-0.67085,-0.52644,-0.52233,-0.38502,-0.28502,-0.28502 +-0.19112,-0.55673,-0.61653,-0.55673,-0.28502,-0.28502,-0.28502 +-0.24107,-0.38092,-0.68343,-0.62275,-0.18502,-0.28502,-0.28502 +-0.27217,-0.22059,-0.6562,-0.72162,-0.085017,-0.28502,-0.28502 +-0.28067,0.044858,-0.73884,-0.67238,0.014983,-0.28502,-0.28502 +-0.2652,0.3035,-0.64224,-0.70386,0.11498,-0.28502,-0.28502 +-0.22766,0.45117,-0.60351,-0.65744,0.21498,-0.28502,-0.28502 +-0.17296,0.59959,-0.5659,-0.5659,0.31498,-0.28502,-0.28502 +-0.10585,0.74853,-0.46888,-0.46889,0.41498,-0.28502,-0.28502 +-0.030646,0.82127,-0.40343,-0.40343,0.51498,-0.28502,-0.28502 +0.051284,0.81668,-0.40806,-0.40806,0.61498,-0.28502,-0.28502 +0.13695,0.88618,-0.32763,-0.32764,0.71498,-0.28502,-0.28502 +0.2254,0.88306,-0.33181,-0.33181,0.81498,-0.28502,-0.28502 +0.31484,0.91335,-0.28791,-0.28791,0.91498,-0.28502,-0.28502 +0.35773,-0.95756,-0.14896,-0.24675,-0.98502,-0.18502,-0.28502 +0.26305,-0.93612,-0.19403,-0.29332,-0.88502,-0.18502,-0.28502 +0.17169,-0.91056,-0.23698,-0.33869,-0.78502,-0.18502,-0.28502 +0.080631,-0.91056,-0.23698,-0.33869,-0.68502,-0.18502,-0.28502 +-0.0075496,-0.87491,-0.23531,-0.42328,-0.58502,-0.18502,-0.28502 +-0.091592,-0.80914,-0.3164,-0.49516,-0.48502,-0.18502,-0.28502 +-0.17057,-0.73449,-0.38489,-0.5589,-0.38502,-0.18502,-0.28502 +-0.24107,-0.62275,-0.38092,-0.68343,-0.28502,-0.18502,-0.28502 +-0.29692,-0.46889,-0.46889,-0.74853,-0.18502,-0.18502,-0.28502 +-0.33341,-0.22617,-0.5068,-0.83187,-0.085017,-0.18502,-0.28502 +-0.3435,0.045834,-0.52077,-0.85247,0.014983,-0.18502,-0.28502 +-0.32507,0.31192,-0.49943,-0.80825,0.11498,-0.18502,-0.28502 +-0.28192,0.53797,-0.46142,-0.70546,0.21498,-0.18502,-0.28502 +-0.22059,0.68343,-0.38092,-0.62275,0.31498,-0.18502,-0.28502 +-0.14818,0.75843,-0.30938,-0.57365,0.41498,-0.18502,-0.28502 +-0.067328,0.8069,-0.31618,-0.49895,0.51498,-0.18502,-0.28502 +0.018715,0.87589,-0.23135,-0.42342,0.61498,-0.18502,-0.28502 +0.10797,0.91192,-0.23701,-0.33501,0.71498,-0.18502,-0.28502 +0.19899,0.90964,-0.24073,-0.33854,0.81498,-0.18502,-0.28502 +0.29106,0.93603,-0.19429,-0.29341,0.91498,-0.18502,-0.28502 +0.38643,0.95793,-0.14659,-0.24675,1.015,-0.18502,-0.28502 +0.34463,-0.96332,-0.098381,-0.24966,-0.98502,-0.085017,-0.28502 +0.24878,-0.94985,-0.097571,-0.29711,-0.88502,-0.085017,-0.28502 +0.15531,-0.93387,-0.096259,-0.34441,-0.78502,-0.085017,-0.28502 +0.062447,-0.92817,-0.14333,-0.34345,-0.68502,-0.085017,-0.28502 +-0.027254,-0.89041,-0.13997,-0.4331,-0.58502,-0.085017,-0.28502 +-0.1147,-0.84573,-0.1394,-0.51509,-0.48502,-0.085017,-0.28502 +-0.19744,-0.79288,-0.13652,-0.59388,-0.38502,-0.085017,-0.28502 +-0.27217,-0.6562,-0.22059,-0.72162,-0.28502,-0.085017,-0.28502 +-0.33341,-0.5068,-0.22617,-0.83187,-0.18502,-0.085017,-0.28502 +-0.37436,-0.24235,-0.24235,-0.93943,-0.085017,-0.085017,-0.28502 +-0.38572,0.049034,-0.25053,-0.96687,0.014983,-0.085017,-0.28502 +-0.36488,0.33494,-0.24084,-0.91094,0.11498,-0.085017,-0.28502 +-0.31668,0.58428,-0.22492,-0.77976,0.21498,-0.085017,-0.28502 +-0.25056,0.72076,-0.22161,-0.6568,0.31498,-0.085017,-0.28502 +-0.17367,0.79188,-0.13651,-0.59523,0.41498,-0.085017,-0.28502 +-0.089343,0.8445,-0.13937,-0.5171,0.51498,-0.085017,-0.28502 +-0.00051679,0.89003,-0.1427,-0.43299,0.61498,-0.085017,-0.28502 +0.090277,0.92778,-0.14603,-0.34337,0.71498,-0.085017,-0.28502 +0.18325,0.93379,-0.097096,-0.3444,0.81498,-0.085017,-0.28502 +0.27721,0.94979,-0.09796,-0.29716,0.91498,-0.085017,-0.28502 +0.37361,0.96709,-0.04903,-0.24965,1.015,-0.085017,-0.28502 +0.34119,-0.96803,0.00045263,-0.25083,-0.98502,0.014983,-0.28502 +0.24528,-0.95331,0.049061,-0.29798,-0.88502,0.014983,-0.28502 +0.15152,-0.93712,0.048969,-0.34556,-0.78502,0.014983,-0.28502 +0.057801,-0.93753,0.04793,-0.3446,-0.68502,0.014983,-0.28502 +-0.032695,-0.89873,0.047861,-0.43589,-0.58502,0.014983,-0.28502 +-0.12091,-0.85243,0.04675,-0.52075,-0.48502,0.014983,-0.28502 +-0.20432,-0.79895,0.045784,-0.59965,-0.38502,0.014983,-0.28502 +-0.28067,-0.73901,0.044858,-0.6722,-0.28502,0.014983,-0.28502 +-0.3435,-0.52077,0.045835,-0.85247,-0.18502,0.014983,-0.28502 +-0.38572,-0.25053,0.049033,-0.96687,-0.085017,0.014983,-0.28502 +-0.39744,0.050639,0.050639,-0.99743,0.014983,0.014983,-0.28502 +-0.3758,0.3446,0.047927,-0.93753,0.11498,0.014983,-0.28502 +-0.32621,0.59965,0.045784,-0.79895,0.21498,0.014983,-0.28502 +-0.25853,0.73884,0.044858,-0.67238,0.31498,0.014983,-0.28502 +-0.18039,0.79932,0.045785,-0.59915,0.41498,0.014983,-0.28502 +-0.095376,0.85289,0.046752,-0.52,0.51498,0.014983,-0.28502 +-0.0057796,0.89877,0.046814,-0.43591,0.61498,0.014983,-0.28502 +0.08588,0.93717,0.047931,-0.34557,0.71498,0.014983,-0.28502 +0.1796,0.93717,0.047931,-0.34557,0.81498,0.014983,-0.28502 +0.27374,0.95333,0.049063,-0.29793,0.91498,0.014983,-0.28502 +0.37018,0.96803,-0.00045211,-0.25083,1.015,0.014983,-0.28502 +0.34747,-0.96325,0.099107,-0.24965,-0.98502,0.11498,-0.28502 +0.25247,-0.94406,0.14649,-0.29544,-0.88502,0.11498,-0.28502 +0.15963,-0.92778,0.14603,-0.34337,-0.78502,0.11498,-0.28502 +0.066751,-0.92912,0.14332,-0.34088,-0.68502,0.11498,-0.28502 +-0.022972,-0.89161,0.13996,-0.43063,-0.58502,0.11498,-0.28502 +-0.10968,-0.82922,0.22965,-0.50956,-0.48502,0.11498,-0.28502 +-0.19097,-0.77929,0.22358,-0.58543,-0.38502,0.11498,-0.28502 +-0.26518,-0.70476,0.30348,-0.64125,-0.28502,0.11498,-0.28502 +-0.32507,-0.49943,0.31192,-0.80826,-0.18502,0.11498,-0.28502 +-0.36488,-0.24084,0.33494,-0.91094,-0.085017,0.11498,-0.28502 +-0.3758,0.047931,0.3446,-0.93753,0.014983,0.11498,-0.28502 +-0.35549,0.32764,0.32764,-0.88618,0.11498,0.11498,-0.28502 +-0.30859,0.57365,0.30938,-0.75843,0.21498,0.11498,-0.28502 +-0.24395,0.72143,0.22162,-0.65606,0.31498,0.11498,-0.28502 +-0.16768,0.77976,0.22492,-0.58428,0.41498,0.11498,-0.28502 +-0.084858,0.83102,0.22974,-0.50657,0.51498,0.11498,-0.28502 +0.003704,0.8912,0.14273,-0.43057,0.61498,0.11498,-0.28502 +0.094556,0.92817,0.14333,-0.34345,0.71498,0.11498,-0.28502 +0.18738,0.9287,0.14606,-0.34086,0.81498,0.11498,-0.28502 +0.28066,0.9441,0.1465,-0.29531,0.91498,0.11498,-0.28502 +0.37621,0.96332,0.098382,-0.24966,1.015,0.11498,-0.28502 +0.36326,-0.94906,0.19632,-0.24647,-0.98502,0.21498,-0.28502 +0.27001,-0.92571,0.24185,-0.29081,-0.88502,0.21498,-0.28502 +0.17894,-0.91192,0.23701,-0.33501,-0.78502,0.21498,-0.28502 +0.087752,-0.8986,0.28476,-0.33382,-0.68502,0.21498,-0.28502 +0.0018043,-0.8486,0.32404,-0.41817,-0.58502,0.21498,-0.28502 +-0.082089,-0.81063,0.31199,-0.49553,-0.48502,0.21498,-0.28502 +-0.15889,-0.73695,0.38494,-0.55563,-0.38502,0.21498,-0.28502 +-0.22765,-0.65878,0.45114,-0.60207,-0.28502,0.21498,-0.28502 +-0.28192,-0.46142,0.53797,-0.70546,-0.18502,0.21498,-0.28502 +-0.31668,-0.22492,0.58428,-0.77976,-0.085017,0.21498,-0.28502 +-0.32621,0.045784,0.59965,-0.79895,0.014983,0.21498,-0.28502 +-0.30859,0.30938,0.57365,-0.75843,0.11498,0.21498,-0.28502 +-0.26742,0.5257,0.5257,-0.66879,0.21498,0.21498,-0.28502 +-0.20796,0.65799,0.453,-0.60154,0.31498,0.21498,-0.28502 +-0.13684,0.78008,0.39294,-0.48691,0.41498,0.21498,-0.28502 +-0.057856,0.85016,0.31947,-0.41853,0.51498,0.21498,-0.28502 +0.02716,0.85016,0.31947,-0.41853,0.61498,0.21498,-0.28502 +0.11505,0.91094,0.24084,-0.33494,0.71498,0.21498,-0.28502 +0.20614,0.91094,0.24084,-0.33494,0.81498,0.21498,-0.28502 +0.29768,0.92577,0.24185,-0.29061,0.91498,0.21498,-0.28502 +0.39157,0.94915,0.19587,-0.24648,1.015,0.21498,-0.28502 +0.38818,-0.92571,0.29081,-0.24185,-0.98502,0.31498,-0.28502 +0.29738,-0.8986,0.33382,-0.28476,-0.88502,0.31498,-0.28502 +0.20883,-0.88618,0.32763,-0.32764,-0.78502,0.31498,-0.28502 +0.12187,-0.85231,0.41405,-0.31957,-0.68502,0.31498,-0.28502 +0.03896,-0.82128,0.40343,-0.40343,-0.58502,0.31498,-0.28502 +-0.03945,-0.74346,0.4729,-0.4729,-0.48502,0.31498,-0.28502 +-0.11115,-0.66879,0.5257,-0.5257,-0.38502,0.31498,-0.28502 +-0.17308,-0.56837,0.60553,-0.55703,-0.28502,0.31498,-0.28502 +-0.22063,-0.38255,0.68289,-0.62235,-0.18502,0.31498,-0.28502 +-0.25058,-0.2206,0.72094,-0.65695,-0.085017,0.31498,-0.28502 +-0.25853,0.045106,0.73884,-0.67237,0.014983,0.31498,-0.28502 +-0.24394,0.22059,0.72162,-0.6562,0.11498,0.31498,-0.28502 +-0.20792,0.45286,0.65675,-0.60299,0.21498,0.31498,-0.28502 +-0.156,0.56135,0.60809,-0.56135,0.31498,0.31498,-0.28502 +-0.090293,0.70546,0.53797,-0.46142,0.41498,0.31498,-0.28502 +-0.016578,0.78062,0.48186,-0.39806,0.51498,0.31498,-0.28502 +0.063453,0.81889,0.4085,-0.40318,0.61498,0.31498,-0.28502 +0.14733,0.86846,0.3733,-0.32623,0.71498,0.31498,-0.28502 +0.23528,0.88458,0.33203,-0.32754,0.81498,0.31498,-0.28502 +0.3243,0.89868,0.33383,-0.28448,0.91498,0.31498,-0.28502 +0.33381,-0.86326,0.42129,-0.27802,-0.88502,0.41498,-0.28502 +0.2485,-0.85231,0.41405,-0.31957,-0.78502,0.41498,-0.28502 +0.16629,-0.81063,0.49552,-0.31198,-0.68502,0.41498,-0.28502 +0.087506,-0.73309,0.55821,-0.38857,-0.58502,0.41498,-0.28502 +0.014638,-0.6818,0.62358,-0.38247,-0.48502,0.41498,-0.28502 +-0.050272,-0.60351,0.65744,-0.45117,-0.38502,0.41498,-0.28502 +-0.10591,-0.46849,0.74584,-0.47354,-0.28502,0.41498,-0.28502 +-0.1482,-0.30951,0.76037,-0.57099,-0.18502,0.41498,-0.28502 +-0.17368,-0.13652,0.79288,-0.59388,-0.085017,0.41498,-0.28502 +-0.18038,0.045784,0.79895,-0.59965,0.014983,0.41498,-0.28502 +-0.16765,0.22486,0.77825,-0.58632,0.11498,0.41498,-0.28502 +-0.1368,0.39312,0.78283,-0.48232,0.21498,0.41498,-0.28502 +-0.090226,0.53862,0.70758,-0.45739,0.31498,0.41498,-0.28502 +-0.032184,0.60207,0.65878,-0.45114,0.41498,0.41498,-0.28502 +0.036022,0.73449,0.5589,-0.38489,0.51498,0.41498,-0.28502 +0.10997,0.78008,0.48691,-0.39294,0.61498,0.41498,-0.28502 +0.19048,0.80914,0.49516,-0.31639,0.71498,0.41498,-0.28502 +0.27396,0.85016,0.41853,-0.31947,0.81498,0.41498,-0.28502 +0.35977,0.86337,0.42131,-0.27765,0.91498,0.41498,-0.28502 +0.37835,-0.82028,0.50343,-0.27147,-0.88502,0.51498,-0.28502 +0.2969,-0.81063,0.49552,-0.31198,-0.78502,0.51498,-0.28502 +0.21947,-0.76139,0.57143,-0.30618,-0.68502,0.51498,-0.28502 +0.14539,-0.6939,0.63298,-0.34328,-0.58502,0.51498,-0.28502 +0.078707,-0.62397,0.6823,-0.38095,-0.48502,0.51498,-0.28502 +0.019346,-0.55501,0.73538,-0.38883,-0.38502,0.51498,-0.28502 +-0.030677,-0.40318,0.81889,-0.4085,-0.28502,0.51498,-0.28502 +-0.067346,-0.3164,0.80914,-0.49516,-0.18502,0.51498,-0.28502 +-0.089359,-0.13941,0.84573,-0.51509,-0.085017,0.51498,-0.28502 +-0.09537,0.04675,0.85243,-0.52075,0.014983,0.51498,-0.28502 +-0.084835,0.22964,0.82922,-0.50956,0.11498,0.51498,-0.28502 +-0.057842,0.31957,0.85231,-0.41405,0.21498,0.51498,-0.28502 +-0.016536,0.48232,0.78283,-0.39312,0.31498,0.51498,-0.28502 +0.036062,0.55563,0.73695,-0.38495,0.41498,0.51498,-0.28502 +0.097488,0.6531,0.65428,-0.38128,0.51498,0.51498,-0.28502 +0.16649,0.73257,0.60814,-0.30579,0.61498,0.51498,-0.28502 +0.24217,0.76037,0.57099,-0.30951,0.71498,0.51498,-0.28502 +0.32111,0.82039,0.50346,-0.27108,0.81498,0.51498,-0.28502 +0.35275,-0.77016,0.57968,-0.26611,-0.78502,0.61498,-0.28502 +0.2799,-0.70354,0.64198,-0.30479,-0.68502,0.61498,-0.28502 +0.21133,-0.64224,0.70386,-0.3035,-0.58502,0.61498,-0.28502 +0.14903,-0.56541,0.74804,-0.34749,-0.48502,0.61498,-0.28502 +0.095384,-0.48691,0.78008,-0.39294,-0.38502,0.61498,-0.28502 +0.051212,-0.40584,0.81889,-0.40584,-0.28502,0.61498,-0.28502 +0.018668,-0.23531,0.87491,-0.42328,-0.18502,0.61498,-0.28502 +-0.00057238,-0.13997,0.89041,-0.4331,-0.085017,0.61498,-0.28502 +-0.0057636,0.04786,0.89873,-0.43589,0.014983,0.61498,-0.28502 +0.0037461,0.13996,0.89161,-0.43063,0.11498,0.61498,-0.28502 +0.027234,0.32404,0.84861,-0.41817,0.21498,0.61498,-0.28502 +0.063512,0.40806,0.81668,-0.40806,0.31498,0.61498,-0.28502 +0.10998,0.49142,0.7952,-0.35519,0.41498,0.61498,-0.28502 +0.16649,0.60734,0.73323,-0.3058,0.51498,0.61498,-0.28502 +0.23079,0.67321,0.67416,-0.30379,0.61498,0.61498,-0.28502 +0.30097,0.70442,0.64099,-0.30483,0.71498,0.61498,-0.28502 +0.37571,0.77024,0.57973,-0.26579,0.81498,0.61498,-0.28502 +0.34594,-0.64974,0.71329,-0.2628,-0.68502,0.71498,-0.28502 +0.28238,-0.60814,0.73257,-0.30579,-0.58502,0.71498,-0.28502 +0.22542,-0.53571,0.78504,-0.31101,-0.48502,0.71498,-0.28502 +0.1764,-0.41853,0.85016,-0.31947,-0.38502,0.71498,-0.28502 +0.13688,-0.32978,0.88458,-0.32978,-0.28502,0.71498,-0.28502 +0.10792,-0.23698,0.91056,-0.33869,-0.18502,0.71498,-0.28502 +0.090261,-0.14333,0.92817,-0.34345,-0.085017,0.71498,-0.28502 +0.085892,0.048972,0.93712,-0.34555,0.014983,0.71498,-0.28502 +0.094593,0.14332,0.92912,-0.34088,0.11498,0.71498,-0.28502 +0.11507,0.23701,0.91192,-0.33501,0.21498,0.71498,-0.28502 +0.14733,0.37335,0.86844,-0.32623,0.31498,0.71498,-0.28502 +0.19052,0.49895,0.80689,-0.31618,0.41498,0.71498,-0.28502 +0.24221,0.57365,0.75843,-0.30938,0.51498,0.71498,-0.28502 +0.30098,0.64198,0.70354,-0.30479,0.61498,0.71498,-0.28502 +0.36559,0.68219,0.68261,-0.26201,0.71498,0.71498,-0.28502 +0.35838,-0.57973,0.77024,-0.26578,-0.58502,0.81498,-0.28502 +0.30614,-0.49943,0.80826,-0.31192,-0.48502,0.81498,-0.28502 +0.26142,-0.41853,0.85016,-0.31947,-0.38502,0.81498,-0.28502 +0.22534,-0.32978,0.88458,-0.32978,-0.28502,0.81498,-0.28502 +0.19897,-0.23698,0.91056,-0.33869,-0.18502,0.81498,-0.28502 +0.18325,-0.096259,0.93387,-0.34441,-0.085017,0.81498,-0.28502 +0.1796,0.048972,0.93712,-0.34555,0.014983,0.81498,-0.28502 +0.18743,0.14603,0.92778,-0.34337,0.11498,0.81498,-0.28502 +0.20621,0.24073,0.90964,-0.33854,0.21498,0.81498,-0.28502 +0.23535,0.33181,0.88306,-0.33181,0.31498,0.81498,-0.28502 +0.274,0.41817,0.84861,-0.32404,0.41498,0.81498,-0.28502 +0.32111,0.50343,0.82028,-0.27147,0.51498,0.81498,-0.28502 +0.37571,0.57968,0.77016,-0.26611,0.61498,0.81498,-0.28502 +0.38938,-0.46261,0.84307,-0.27427,-0.48502,0.91498,-0.28502 +0.34787,-0.37762,0.88224,-0.28117,-0.38502,0.91498,-0.28502 +0.31485,-0.28778,0.91344,-0.28778,-0.28502,0.91498,-0.28502 +0.29106,-0.19403,0.93612,-0.29332,-0.18502,0.91498,-0.28502 +0.27721,-0.097571,0.94985,-0.29711,-0.085017,0.91498,-0.28502 +0.27374,0.049064,0.95331,-0.29798,0.014983,0.91498,-0.28502 +0.28066,0.14649,0.94406,-0.29544,0.11498,0.91498,-0.28502 +0.29768,0.24185,0.92571,-0.29081,0.21498,0.91498,-0.28502 +0.3243,0.33382,0.8986,-0.28476,0.31498,0.91498,-0.28502 +0.35977,0.42129,0.86326,-0.27802,0.41498,0.91498,-0.28502 +0.38642,-0.14896,0.95756,-0.24675,-0.18502,1.015,-0.28502 +0.37361,-0.04994,0.96705,-0.24966,-0.085017,1.015,-0.28502 +0.37018,0.00045242,0.96803,-0.25083,0.014983,1.015,-0.28502 +0.37621,0.099108,0.96325,-0.24965,0.11498,1.015,-0.28502 +0.39157,0.19632,0.94906,-0.24647,0.21498,1.015,-0.28502 +0.38961,-0.34088,-0.92912,-0.14332,-0.38502,-0.98502,-0.18502 +0.35773,-0.24675,-0.95793,-0.14659,-0.28502,-0.98502,-0.18502 +0.33479,-0.14935,-0.97744,-0.14935,-0.18502,-0.98502,-0.18502 +0.32141,-0.10062,-0.98335,-0.15131,-0.085017,-0.98502,-0.18502 +0.31791,-0.00031716,-0.98837,-0.15204,0.014983,-0.98502,-0.18502 +0.32434,0.10011,-0.9834,-0.15131,0.11498,-0.98502,-0.18502 +0.34048,0.19912,-0.96853,-0.14934,0.21498,-0.98502,-0.18502 +0.36593,0.29531,-0.9441,-0.1465,0.31498,-0.98502,-0.18502 +0.39214,-0.55219,-0.81376,-0.18132,-0.58502,-0.88502,-0.18502 +0.34104,-0.4713,-0.86228,-0.18535,-0.48502,-0.88502,-0.18502 +0.29775,-0.38482,-0.90325,-0.18988,-0.38502,-0.88502,-0.18502 +0.26305,-0.29341,-0.93604,-0.19428,-0.28502,-0.88502,-0.18502 +0.23788,-0.19802,-0.95999,-0.19802,-0.18502,-0.88502,-0.18502 +0.22319,-0.099833,-0.97458,-0.20058,-0.085017,-0.88502,-0.18502 +0.21962,0.050024,-0.97831,-0.201,0.014983,-0.88502,-0.18502 +0.22702,0.14933,-0.96853,-0.19912,0.11498,-0.88502,-0.18502 +0.24506,0.24648,-0.94915,-0.19587,0.21498,-0.88502,-0.18502 +0.27317,0.34014,-0.92062,-0.19173,0.31498,-0.88502,-0.18502 +0.31052,0.42924,-0.88357,-0.18722,0.41498,-0.88502,-0.18502 +0.35609,0.51297,-0.83868,-0.18296,0.51498,-0.88502,-0.18502 +0.37368,-0.66242,-0.72771,-0.17791,-0.68502,-0.78502,-0.18502 +0.3121,-0.59077,-0.7865,-0.18,-0.58502,-0.78502,-0.18502 +0.25708,-0.50956,-0.82922,-0.22964,-0.48502,-0.78502,-0.18502 +0.2099,-0.4268,-0.87323,-0.23519,-0.38502,-0.78502,-0.18502 +0.17174,-0.33854,-0.90964,-0.24073,-0.28502,-0.78502,-0.18502 +0.1437,-0.24556,-0.93776,-0.24556,-0.18502,-0.78502,-0.18502 +0.1267,-0.099107,-0.96325,-0.24965,-0.085017,-0.78502,-0.18502 +0.12276,0.049032,-0.96687,-0.25053,0.014983,-0.78502,-0.18502 +0.13111,0.14896,-0.95756,-0.24675,0.11498,-0.78502,-0.18502 +0.15101,0.24564,-0.93858,-0.24234,0.21498,-0.78502,-0.18502 +0.18184,0.33869,-0.91056,-0.23698,0.31498,-0.78502,-0.18502 +0.22267,0.42704,-0.87414,-0.23133,0.41498,-0.78502,-0.18502 +0.27236,0.51297,-0.83868,-0.18296,0.51498,-0.78502,-0.18502 +0.32977,0.5908,-0.78657,-0.17959,0.61498,-0.78502,-0.18502 +0.39358,0.66244,-0.72773,-0.17774,0.71498,-0.78502,-0.18502 +0.37368,-0.72773,-0.66244,-0.17774,-0.78502,-0.68502,-0.18502 +0.30136,-0.69576,-0.69606,-0.17724,-0.68502,-0.68502,-0.18502 +0.23535,-0.6568,-0.72076,-0.2216,-0.58502,-0.68502,-0.18502 +0.17551,-0.58632,-0.77825,-0.22486,-0.48502,-0.68502,-0.18502 +0.1232,-0.50956,-0.82922,-0.22964,-0.38502,-0.68502,-0.18502 +0.080646,-0.33501,-0.91192,-0.23701,-0.28502,-0.68502,-0.18502 +0.049885,-0.24235,-0.93943,-0.24235,-0.18502,-0.68502,-0.18502 +0.030983,-0.14893,-0.95698,-0.24903,-0.085017,-0.68502,-0.18502 +0.026076,0.049032,-0.96687,-0.25053,0.014983,-0.68502,-0.18502 +0.03535,0.14896,-0.95756,-0.24675,0.11498,-0.68502,-0.18502 +0.057184,0.29061,-0.92577,-0.24185,0.21498,-0.68502,-0.18502 +0.092625,0.42328,-0.87491,-0.23531,0.31498,-0.68502,-0.18502 +0.13837,0.50657,-0.83102,-0.22975,0.41498,-0.68502,-0.18502 +0.19303,0.5866,-0.77876,-0.22231,0.51498,-0.68502,-0.18502 +0.25502,0.65695,-0.72094,-0.2206,0.61498,-0.68502,-0.18502 +0.32274,0.7277,-0.66242,-0.17791,0.71498,-0.68502,-0.18502 +0.39568,0.75824,-0.62709,-0.17841,0.81498,-0.68502,-0.18502 +0.39214,-0.81368,-0.55238,-0.18109,-0.88502,-0.58502,-0.18502 +0.3121,-0.78657,-0.5908,-0.17959,-0.78502,-0.58502,-0.18502 +0.23534,-0.72143,-0.65606,-0.22162,-0.68502,-0.58502,-0.18502 +0.16341,-0.68929,-0.69001,-0.22083,-0.58502,-0.58502,-0.18502 +0.097685,-0.62135,-0.75137,-0.2222,-0.48502,-0.58502,-0.18502 +0.040124,-0.5068,-0.83187,-0.22617,-0.38502,-0.58502,-0.18502 +-0.0075325,-0.42342,-0.87589,-0.23135,-0.28502,-0.58502,-0.18502 +-0.044035,-0.33181,-0.88306,-0.33181,-0.18502,-0.58502,-0.18502 +-0.06464,-0.14603,-0.92778,-0.34337,-0.085017,-0.58502,-0.18502 +-0.070463,0.048974,-0.93747,-0.3446,0.014983,-0.58502,-0.18502 +-0.060275,0.14606,-0.9287,-0.34086,0.11498,-0.58502,-0.18502 +-0.034018,0.33494,-0.91094,-0.24084,0.21498,-0.58502,-0.18502 +0.0051345,0.42328,-0.87491,-0.23531,0.31498,-0.58502,-0.18502 +0.056598,0.58428,-0.77976,-0.22492,0.41498,-0.58502,-0.18502 +0.11725,0.65606,-0.72143,-0.22162,0.51498,-0.58502,-0.18502 +0.18486,0.72162,-0.6562,-0.22059,0.61498,-0.58502,-0.18502 +0.25753,0.75137,-0.62135,-0.2222,0.71498,-0.58502,-0.18502 +0.33563,0.78651,-0.59077,-0.18,0.81498,-0.58502,-0.18502 +0.34104,-0.86228,-0.4714,-0.18508,-0.88502,-0.48502,-0.18502 +0.25708,-0.83,-0.50986,-0.22616,-0.78502,-0.48502,-0.18502 +0.17549,-0.77976,-0.58428,-0.22492,-0.68502,-0.48502,-0.18502 +0.097685,-0.75086,-0.62196,-0.22219,-0.58502,-0.48502,-0.18502 +0.025478,-0.68929,-0.69001,-0.22083,-0.48502,-0.48502,-0.18502 +-0.037696,-0.57254,-0.75991,-0.30778,-0.38502,-0.48502,-0.18502 +-0.091507,-0.49895,-0.80689,-0.31618,-0.28502,-0.48502,-0.18502 +-0.13237,-0.32764,-0.88618,-0.32764,-0.18502,-0.48502,-0.18502 +-0.15746,-0.14332,-0.92912,-0.34088,-0.085017,-0.48502,-0.18502 +-0.16419,0.047929,-0.93717,-0.34557,0.014983,-0.48502,-0.18502 +-0.15195,0.23698,-0.91056,-0.33869,0.11498,-0.48502,-0.18502 +-0.1221,0.41383,-0.85064,-0.32429,0.21498,-0.48502,-0.18502 +-0.076667,0.49943,-0.80826,-0.31192,0.31498,-0.48502,-0.18502 +-0.0197,0.64224,-0.70386,-0.3035,0.41498,-0.48502,-0.18502 +0.047075,0.72162,-0.6562,-0.22059,0.51498,-0.48502,-0.18502 +0.12095,0.78032,-0.58453,-0.22231,0.61498,-0.48502,-0.18502 +0.19911,0.80598,-0.54719,-0.22578,0.71498,-0.48502,-0.18502 +0.282,0.83858,-0.51294,-0.1835,0.81498,-0.48502,-0.18502 +0.36724,0.86228,-0.4713,-0.18535,0.91498,-0.48502,-0.18502 +0.38961,-0.9287,-0.34086,-0.14606,-0.98502,-0.38502,-0.18502 +0.29775,-0.90331,-0.38482,-0.1896,-0.88502,-0.38502,-0.18502 +0.20987,-0.87414,-0.42704,-0.23133,-0.78502,-0.38502,-0.18502 +0.12319,-0.83102,-0.50657,-0.22974,-0.68502,-0.38502,-0.18502 +0.040091,-0.83,-0.50986,-0.22616,-0.58502,-0.38502,-0.18502 +-0.037747,-0.75936,-0.57414,-0.30617,-0.48502,-0.38502,-0.18502 +-0.10932,-0.64125,-0.70476,-0.30348,-0.38502,-0.38502,-0.18502 +-0.17052,-0.55821,-0.73309,-0.38856,-0.28502,-0.38502,-0.18502 +-0.21814,-0.40806,-0.81668,-0.40806,-0.18502,-0.38502,-0.18502 +-0.24827,-0.23519,-0.87323,-0.4268,-0.085017,-0.38502,-0.18502 +-0.25606,0.046815,-0.89877,-0.43591,0.014983,-0.38502,-0.18502 +-0.24134,0.23531,-0.87491,-0.42328,0.11498,-0.38502,-0.18502 +-0.20602,0.48186,-0.78062,-0.39806,0.21498,-0.38502,-0.18502 +-0.15382,0.5589,-0.73449,-0.38489,0.31498,-0.38502,-0.18502 +-0.088206,0.70477,-0.64125,-0.30348,0.41498,-0.38502,-0.18502 +-0.014969,0.75843,-0.57365,-0.30938,0.51498,-0.38502,-0.18502 +0.065052,0.83187,-0.5068,-0.22617,0.61498,-0.38502,-0.18502 +0.14865,0.85358,-0.46705,-0.23078,0.71498,-0.38502,-0.18502 +0.23607,0.87323,-0.4268,-0.23519,0.81498,-0.38502,-0.18502 +0.32485,0.90325,-0.38482,-0.18988,0.91498,-0.38502,-0.18502 +0.35773,-0.95756,-0.24675,-0.14896,-0.98502,-0.28502,-0.18502 +0.26305,-0.93612,-0.29332,-0.19403,-0.88502,-0.28502,-0.18502 +0.17169,-0.91056,-0.33869,-0.23698,-0.78502,-0.28502,-0.18502 +0.080631,-0.91056,-0.33869,-0.23698,-0.68502,-0.28502,-0.18502 +-0.0075496,-0.87491,-0.42328,-0.23531,-0.58502,-0.28502,-0.18502 +-0.091592,-0.80914,-0.49516,-0.3164,-0.48502,-0.28502,-0.18502 +-0.17057,-0.73449,-0.5589,-0.38489,-0.38502,-0.28502,-0.18502 +-0.24107,-0.62275,-0.68343,-0.38092,-0.28502,-0.28502,-0.18502 +-0.29692,-0.46889,-0.74853,-0.46888,-0.18502,-0.28502,-0.18502 +-0.33341,-0.22617,-0.83187,-0.5068,-0.085017,-0.28502,-0.18502 +-0.3435,0.045835,-0.85247,-0.52077,0.014983,-0.28502,-0.18502 +-0.32507,0.31192,-0.80826,-0.49943,0.11498,-0.28502,-0.18502 +-0.28192,0.53797,-0.70546,-0.46142,0.21498,-0.28502,-0.18502 +-0.22059,0.68343,-0.62275,-0.38092,0.31498,-0.28502,-0.18502 +-0.14818,0.75843,-0.57365,-0.30938,0.41498,-0.28502,-0.18502 +-0.067328,0.8069,-0.49895,-0.31618,0.51498,-0.28502,-0.18502 +0.018715,0.87589,-0.42342,-0.23135,0.61498,-0.28502,-0.18502 +0.10797,0.91192,-0.33501,-0.23701,0.71498,-0.28502,-0.18502 +0.19899,0.90964,-0.33854,-0.24073,0.81498,-0.28502,-0.18502 +0.29106,0.93603,-0.29341,-0.19428,0.91498,-0.28502,-0.18502 +0.38643,0.95793,-0.24675,-0.14659,1.015,-0.28502,-0.18502 +0.33479,-0.97718,-0.15019,-0.15019,-0.98502,-0.18502,-0.18502 +0.23788,-0.96007,-0.19782,-0.19782,-0.88502,-0.18502,-0.18502 +0.14365,-0.93858,-0.24399,-0.24399,-0.78502,-0.18502,-0.18502 +0.049793,-0.93858,-0.24399,-0.24399,-0.68502,-0.18502,-0.18502 +-0.044045,-0.88458,-0.33203,-0.32754,-0.58502,-0.18502,-0.18502 +-0.1325,-0.88458,-0.33203,-0.32754,-0.48502,-0.18502,-0.18502 +-0.21827,-0.81889,-0.40318,-0.4085,-0.38502,-0.18502,-0.18502 +-0.29705,-0.74584,-0.47354,-0.46849,-0.28502,-0.18502,-0.18502 +-0.36412,-0.56135,-0.6081,-0.56135,-0.18502,-0.18502,-0.18502 +-0.3984,0.38095,-0.6823,-0.62397,0.11498,-0.18502,-0.18502 +-0.34584,0.67337,-0.52276,-0.52277,0.21498,-0.18502,-0.18502 +-0.27461,0.74346,-0.4729,-0.4729,0.31498,-0.18502,-0.18502 +-0.19366,0.81668,-0.40806,-0.40806,0.41498,-0.18502,-0.18502 +-0.10588,0.88306,-0.33181,-0.33181,0.51498,-0.18502,-0.18502 +-0.015907,0.93943,-0.24235,-0.24235,0.61498,-0.18502,-0.18502 +0.078026,0.93776,-0.24556,-0.24556,0.71498,-0.18502,-0.18502 +0.1718,0.93776,-0.24556,-0.24556,0.81498,-0.18502,-0.18502 +0.26668,0.95999,-0.19802,-0.19802,0.91498,-0.18502,-0.18502 +0.36408,0.97744,-0.14934,-0.14935,1.015,-0.18502,-0.18502 +0.32141,-0.9834,-0.10011,-0.15131,-0.98502,-0.085017,-0.18502 +0.22319,-0.97463,-0.099522,-0.20046,-0.88502,-0.085017,-0.18502 +0.1267,-0.96332,-0.098381,-0.24966,-0.78502,-0.085017,-0.18502 +0.030952,-0.95733,-0.14659,-0.24907,-0.68502,-0.085017,-0.18502 +-0.064652,-0.9287,-0.14606,-0.34086,-0.58502,-0.085017,-0.18502 +-0.15752,-0.9287,-0.14606,-0.34086,-0.48502,-0.085017,-0.18502 +-0.24833,-0.87414,-0.23133,-0.42704,-0.38502,-0.085017,-0.18502 +-0.3335,-0.83,-0.22616,-0.50985,-0.28502,-0.085017,-0.18502 +-0.38778,0.70354,-0.30479,-0.64198,0.21498,-0.085017,-0.18502 +-0.30852,0.82922,-0.22964,-0.50956,0.31498,-0.085017,-0.18502 +-0.22183,0.89161,-0.13996,-0.43063,0.41498,-0.085017,-0.18502 +-0.12962,0.92778,-0.14603,-0.34337,0.51498,-0.085017,-0.18502 +-0.036071,0.95793,-0.14659,-0.24675,0.61498,-0.085017,-0.18502 +0.05966,0.95698,-0.14893,-0.24902,0.71498,-0.085017,-0.18502 +0.15549,0.96325,-0.099107,-0.24965,0.81498,-0.085017,-0.18502 +0.25248,0.97458,-0.099832,-0.20058,0.91498,-0.085017,-0.18502 +0.351,0.98724,-0.049979,-0.15122,1.015,-0.085017,-0.18502 +0.31791,-0.98837,0.0003175,-0.15204,-0.98502,0.014983,-0.18502 +0.21962,-0.97829,0.050022,-0.20113,-0.88502,0.014983,-0.18502 +0.12277,-0.96682,0.049937,-0.25052,-0.78502,0.014983,-0.18502 +0.026088,-0.96682,0.049937,-0.25052,-0.68502,0.014983,-0.18502 +-0.070458,-0.93712,0.048969,-0.34556,-0.58502,0.014983,-0.18502 +-0.16417,-0.93712,0.048969,-0.34556,-0.48502,0.014983,-0.18502 +-0.25603,-0.89873,0.047861,-0.43589,-0.38502,0.014983,-0.18502 +-0.34348,-0.85294,0.045832,-0.52,-0.28502,0.014983,-0.18502 +-0.39965,0.739,0.045107,-0.6722,0.21498,0.014983,-0.18502 +-0.31795,0.85289,0.046752,-0.52,0.31498,0.014983,-0.18502 +-0.22912,0.89917,0.047863,-0.43498,0.41498,0.014983,-0.18502 +-0.13611,0.93717,0.047931,-0.34557,0.51498,0.014983,-0.18502 +-0.041638,0.96687,0.049033,-0.25053,0.61498,0.014983,-0.18502 +0.055049,0.96687,0.049033,-0.25053,0.71498,0.014983,-0.18502 +0.15174,0.96687,0.049033,-0.25053,0.81498,0.014983,-0.18502 +0.24894,0.97831,0.050024,-0.201,0.91498,0.014983,-0.18502 +0.3475,0.98837,-0.0003175,-0.15204,1.015,0.014983,-0.18502 +0.32434,-0.98335,0.10062,-0.15131,-0.98502,0.11498,-0.18502 +0.22702,-0.96846,0.14934,-0.19944,-0.88502,0.11498,-0.18502 +0.13114,-0.95698,0.14894,-0.24902,-0.78502,0.11498,-0.18502 +0.03541,-0.95793,0.14659,-0.24675,-0.68502,0.11498,-0.18502 +-0.060264,-0.92778,0.14603,-0.34337,-0.58502,0.11498,-0.18502 +-0.15187,-0.90964,0.24073,-0.33854,-0.48502,0.11498,-0.18502 +-0.24126,-0.87589,0.23135,-0.42342,-0.38502,0.11498,-0.18502 +-0.32497,-0.81063,0.31199,-0.49553,-0.28502,0.11498,-0.18502 +-0.39837,-0.68343,0.38093,-0.62275,-0.18502,0.11498,-0.18502 +-0.37794,0.68289,0.38255,-0.62235,0.21498,0.11498,-0.18502 +-0.30085,0.80914,0.3164,-0.49516,0.31498,0.11498,-0.18502 +-0.21512,0.87491,0.23531,-0.42328,0.41498,0.11498,-0.18502 +-0.12466,0.91056,0.23698,-0.33869,0.51498,0.11498,-0.18502 +-0.0317,0.95733,0.14659,-0.24907,0.61498,0.11498,-0.18502 +0.064044,0.95756,0.14896,-0.24675,0.71498,0.11498,-0.18502 +0.1598,0.95756,0.14896,-0.24675,0.81498,0.11498,-0.18502 +0.25606,0.96853,0.14933,-0.19912,0.91498,0.11498,-0.18502 +0.35367,0.9834,0.10011,-0.15131,1.015,0.11498,-0.18502 +0.34048,-0.96846,0.19944,-0.14933,-0.98502,0.21498,-0.18502 +0.24506,-0.94906,0.24647,-0.19632,-0.88502,0.21498,-0.18502 +0.15106,-0.93776,0.24556,-0.24556,-0.78502,0.21498,-0.18502 +0.057184,-0.92571,0.29081,-0.24185,-0.68502,0.21498,-0.18502 +-0.034008,-0.91192,0.33501,-0.23701,-0.58502,0.21498,-0.18502 +-0.12205,-0.8486,0.41817,-0.32404,-0.48502,0.21498,-0.18502 +-0.20598,-0.77808,0.48628,-0.39765,-0.38502,0.21498,-0.18502 +-0.28182,-0.70311,0.54144,-0.46095,-0.28502,0.21498,-0.18502 +-0.3459,-0.52644,0.67085,-0.52233,-0.18502,0.21498,-0.18502 +-0.38781,-0.30483,0.70442,-0.64099,-0.085017,0.21498,-0.18502 +-0.39965,0.045106,0.73884,-0.67237,0.014983,0.21498,-0.18502 +-0.37791,0.38248,0.6818,-0.62358,0.11498,0.21498,-0.18502 +-0.32857,0.58002,0.63491,-0.51036,0.21498,0.21498,-0.18502 +-0.26051,0.74584,0.47353,-0.46849,0.31498,0.21498,-0.18502 +-0.18149,0.81889,0.4085,-0.40318,0.41498,0.21498,-0.18502 +-0.096046,0.88458,0.33203,-0.32754,0.51498,0.21498,-0.18502 +-0.0067204,0.91094,0.33494,-0.24084,0.61498,0.21498,-0.18502 +0.085279,0.93858,0.24564,-0.24234,0.71498,0.21498,-0.18502 +0.17914,0.93858,0.24564,-0.24234,0.81498,0.21498,-0.18502 +0.27353,0.94915,0.24648,-0.19587,0.91498,0.21498,-0.18502 +0.36935,0.96853,0.19912,-0.14933,1.015,0.21498,-0.18502 +0.36593,-0.94406,0.29544,-0.14649,-0.98502,0.31498,-0.18502 +0.27317,-0.92051,0.34013,-0.19226,-0.88502,0.31498,-0.18502 +0.18188,-0.91192,0.33501,-0.23701,-0.78502,0.31498,-0.18502 +0.092686,-0.87323,0.4268,-0.23519,-0.68502,0.31498,-0.18502 +0.0051558,-0.87589,0.42342,-0.23135,-0.58502,0.31498,-0.18502 +-0.076589,-0.81063,0.49552,-0.31198,-0.48502,0.31498,-0.18502 +-0.15379,-0.73309,0.55821,-0.38857,-0.38502,0.31498,-0.18502 +-0.22063,-0.62235,0.68289,-0.38255,-0.28502,0.31498,-0.18502 +-0.2747,-0.46849,0.74584,-0.47354,-0.18502,0.31498,-0.18502 +-0.3086,-0.22974,0.83102,-0.50657,-0.085017,0.31498,-0.18502 +-0.31793,0.04675,0.85243,-0.52075,0.014983,0.31498,-0.18502 +-0.30075,0.31618,0.8069,-0.49895,0.11498,0.31498,-0.18502 +-0.26044,0.4729,0.74346,-0.4729,0.21498,0.31498,-0.18502 +-0.20193,0.62275,0.68343,-0.38092,0.31498,0.31498,-0.18502 +-0.13109,0.76037,0.57099,-0.30951,0.41498,0.31498,-0.18502 +-0.052447,0.80826,0.49943,-0.31192,0.51498,0.31498,-0.18502 +0.031352,0.87491,0.42328,-0.23531,0.61498,0.31498,-0.18502 +0.11884,0.87491,0.42328,-0.23531,0.71498,0.31498,-0.18502 +0.20912,0.91056,0.33869,-0.23698,0.81498,0.31498,-0.18502 +0.30081,0.92062,0.34014,-0.19173,0.91498,0.31498,-0.18502 +0.39418,0.9441,0.29531,-0.1465,1.015,0.31498,-0.18502 +0.31052,-0.88346,0.42922,-0.1878,-0.88502,0.41498,-0.18502 +0.22268,-0.87589,0.42342,-0.23135,-0.78502,0.41498,-0.18502 +0.13847,-0.82922,0.50956,-0.22964,-0.68502,0.41498,-0.18502 +0.056626,-0.77825,0.58632,-0.22486,-0.58502,0.41498,-0.18502 +-0.019686,-0.70354,0.64198,-0.30479,-0.48502,0.41498,-0.18502 +-0.08824,-0.64224,0.70386,-0.3035,-0.38502,0.41498,-0.18502 +-0.1482,-0.57099,0.76037,-0.30951,-0.28502,0.41498,-0.18502 +-0.19373,-0.40318,0.81889,-0.4085,-0.18502,0.41498,-0.18502 +-0.22187,-0.14273,0.8912,-0.43058,-0.085017,0.41498,-0.18502 +-0.2291,0.04786,0.89873,-0.43589,0.014983,0.41498,-0.18502 +-0.21506,0.23519,0.87323,-0.4268,0.11498,0.41498,-0.18502 +-0.18144,0.40806,0.81668,-0.40806,0.21498,0.41498,-0.18502 +-0.13104,0.57143,0.76139,-0.30618,0.31498,0.41498,-0.18502 +-0.06899,0.64125,0.70476,-0.30348,0.41498,0.41498,-0.18502 +0.0022125,0.75935,0.57414,-0.30617,0.51498,0.41498,-0.18502 +0.080242,0.80569,0.54762,-0.22577,0.61498,0.41498,-0.18502 +0.16327,0.83102,0.50657,-0.22975,0.71498,0.41498,-0.18502 +0.24886,0.88357,0.42924,-0.18722,0.81498,0.41498,-0.18502 +0.33709,0.88357,0.42924,-0.18722,0.91498,0.41498,-0.18502 +0.35609,-0.83858,0.51294,-0.18351,-0.88502,0.51498,-0.18502 +0.27236,-0.83858,0.51294,-0.18351,-0.78502,0.51498,-0.18502 +0.19308,-0.77825,0.58632,-0.22486,-0.68502,0.51498,-0.18502 +0.11727,-0.72076,0.6568,-0.2216,-0.58502,0.51498,-0.18502 +0.047069,-0.65606,0.72143,-0.22162,-0.48502,0.51498,-0.18502 +-0.014992,-0.57414,0.75936,-0.30617,-0.38502,0.51498,-0.18502 +-0.067346,-0.49516,0.80914,-0.3164,-0.28502,0.51498,-0.18502 +-0.106,-0.33203,0.88458,-0.32754,-0.18502,0.51498,-0.18502 +-0.12969,-0.14606,0.9287,-0.34086,-0.085017,0.51498,-0.18502 +-0.13609,0.048972,0.93712,-0.34555,0.014983,0.51498,-0.18502 +-0.12461,0.24073,0.90964,-0.33854,0.11498,0.51498,-0.18502 +-0.095995,0.32764,0.88618,-0.32764,0.21498,0.51498,-0.18502 +-0.052376,0.49895,0.80689,-0.31618,0.31498,0.51498,-0.18502 +0.0022212,0.57365,0.75843,-0.30938,0.41498,0.51498,-0.18502 +0.06681,0.68929,0.69001,-0.22083,0.51498,0.51498,-0.18502 +0.13889,0.75086,0.62196,-0.22219,0.61498,0.51498,-0.18502 +0.21637,0.77876,0.5866,-0.22231,0.71498,0.51498,-0.18502 +0.29733,0.83868,0.51297,-0.18296,0.81498,0.51498,-0.18502 +0.38139,0.86228,0.4714,-0.18508,0.91498,0.51498,-0.18502 +0.32977,-0.7865,0.59077,-0.18,-0.78502,0.61498,-0.18502 +0.25503,-0.72076,0.6568,-0.2216,-0.68502,0.61498,-0.18502 +0.18484,-0.65695,0.72094,-0.2206,-0.58502,0.61498,-0.18502 +0.12092,-0.5866,0.77876,-0.22231,-0.48502,0.61498,-0.18502 +0.064992,-0.50657,0.83102,-0.22974,-0.38502,0.61498,-0.18502 +0.018668,-0.42328,0.87491,-0.23531,-0.28502,0.61498,-0.18502 +-0.01594,-0.24564,0.93858,-0.24234,-0.18502,0.61498,-0.18502 +-0.036093,-0.14659,0.95733,-0.24907,-0.085017,0.61498,-0.18502 +-0.041629,0.049032,0.96709,-0.24965,0.014983,0.61498,-0.18502 +-0.031678,0.14659,0.95793,-0.24675,0.11498,0.61498,-0.18502 +-0.0066814,0.33501,0.91192,-0.23701,0.21498,0.61498,-0.18502 +0.031403,0.42342,0.87589,-0.23135,0.31498,0.61498,-0.18502 +0.080243,0.54719,0.80598,-0.22578,0.41498,0.61498,-0.18502 +0.13889,0.62135,0.75137,-0.2222,0.51498,0.61498,-0.18502 +0.20474,0.68929,0.69001,-0.22083,0.61498,0.61498,-0.18502 +0.27662,0.72094,0.65695,-0.2206,0.71498,0.61498,-0.18502 +0.35334,0.78657,0.5908,-0.17959,0.81498,0.61498,-0.18502 +0.39358,-0.72771,0.66242,-0.17791,-0.78502,0.71498,-0.18502 +0.32274,-0.66244,0.72773,-0.17774,-0.68502,0.71498,-0.18502 +0.25753,-0.62196,0.75086,-0.22219,-0.58502,0.71498,-0.18502 +0.19911,-0.54762,0.80569,-0.22577,-0.48502,0.71498,-0.18502 +0.14865,-0.46728,0.85346,-0.23077,-0.38502,0.71498,-0.18502 +0.10792,-0.33869,0.91056,-0.23698,-0.28502,0.71498,-0.18502 +0.077919,-0.24399,0.93858,-0.24399,-0.18502,0.71498,-0.18502 +0.05964,-0.14659,0.95733,-0.24907,-0.085017,0.71498,-0.18502 +0.05506,0.049937,0.96682,-0.25052,0.014983,0.71498,-0.18502 +0.064115,0.14659,0.95793,-0.24675,0.11498,0.71498,-0.18502 +0.085298,0.24235,0.93943,-0.24235,0.21498,0.71498,-0.18502 +0.11885,0.4268,0.87323,-0.23519,0.31498,0.71498,-0.18502 +0.16332,0.50956,0.82922,-0.22964,0.41498,0.71498,-0.18502 +0.2164,0.58632,0.77825,-0.22486,0.51498,0.71498,-0.18502 +0.27663,0.6568,0.72076,-0.22161,0.61498,0.71498,-0.18502 +0.34291,0.69576,0.69606,-0.17724,0.71498,0.71498,-0.18502 +0.39568,-0.62736,0.75805,-0.17827,-0.68502,0.81498,-0.18502 +0.33563,-0.5908,0.78657,-0.17959,-0.58502,0.81498,-0.18502 +0.282,-0.51297,0.83868,-0.18296,-0.48502,0.81498,-0.18502 +0.23606,-0.42704,0.87414,-0.23133,-0.38502,0.81498,-0.18502 +0.19897,-0.33869,0.91056,-0.23698,-0.28502,0.81498,-0.18502 +0.17178,-0.24399,0.93858,-0.24399,-0.18502,0.81498,-0.18502 +0.15549,-0.098382,0.96332,-0.24966,-0.085017,0.81498,-0.18502 +0.15174,0.049937,0.96682,-0.25052,0.014983,0.81498,-0.18502 +0.15982,0.14893,0.95698,-0.24903,0.11498,0.81498,-0.18502 +0.17916,0.24556,0.93776,-0.24556,0.21498,0.81498,-0.18502 +0.20914,0.33854,0.90964,-0.24073,0.31498,0.81498,-0.18502 +0.24886,0.42922,0.88346,-0.1878,0.41498,0.81498,-0.18502 +0.29733,0.51294,0.83858,-0.18351,0.51498,0.81498,-0.18502 +0.35334,0.59077,0.78651,-0.18,0.61498,0.81498,-0.18502 +0.36724,-0.4714,0.86228,-0.18508,-0.48502,0.91498,-0.18502 +0.32485,-0.38482,0.90331,-0.1896,-0.38502,0.91498,-0.18502 +0.29106,-0.29332,0.93612,-0.19403,-0.28502,0.91498,-0.18502 +0.26668,-0.19782,0.96007,-0.19782,-0.18502,0.91498,-0.18502 +0.25248,-0.099522,0.97463,-0.20046,-0.085017,0.91498,-0.18502 +0.24894,0.050023,0.97829,-0.20113,0.014983,0.91498,-0.18502 +0.25606,0.14933,0.96846,-0.19944,0.11498,0.91498,-0.18502 +0.27353,0.24647,0.94906,-0.19632,0.21498,0.91498,-0.18502 +0.30081,0.34013,0.92051,-0.19226,0.31498,0.91498,-0.18502 +0.33709,0.42922,0.88346,-0.1878,0.41498,0.91498,-0.18502 +0.38139,0.4713,0.86228,-0.18535,0.51498,0.91498,-0.18502 +0.38642,-0.24675,0.95756,-0.14896,-0.28502,1.015,-0.18502 +0.36408,-0.15019,0.97718,-0.15018,-0.18502,1.015,-0.18502 +0.35099,-0.050618,0.9872,-0.15122,-0.085017,1.015,-0.18502 +0.3475,0.00031717,0.98837,-0.15204,0.014983,1.015,-0.18502 +0.35367,0.10062,0.98335,-0.15131,0.11498,1.015,-0.18502 +0.36935,0.19944,0.96846,-0.14933,0.21498,1.015,-0.18502 +0.39418,0.29544,0.94406,-0.1465,0.31498,1.015,-0.18502 +0.37688,-0.34441,-0.93379,-0.097097,-0.38502,-0.98502,-0.085017 +0.34463,-0.24965,-0.96325,-0.099108,-0.28502,-0.98502,-0.085017 +0.32141,-0.15131,-0.98335,-0.10062,-0.18502,-0.98502,-0.085017 +0.30786,-0.1011,-0.98973,-0.1011,-0.085017,-0.98502,-0.085017 +0.30431,-0.00011897,-0.9987,-0.050943,0.014983,-0.98502,-0.085017 +0.31082,0.10118,-0.99358,-0.050695,0.11498,-0.98502,-0.085017 +0.32717,0.20046,-0.97463,-0.099523,0.21498,-0.98502,-0.085017 +0.35292,0.29711,-0.94985,-0.097571,0.31498,-0.98502,-0.085017 +0.3875,0.38965,-0.91602,-0.095334,0.41498,-0.98502,-0.085017 +0.37956,-0.55888,-0.82419,-0.091479,-0.58502,-0.88502,-0.085017 +0.32786,-0.47709,-0.87387,-0.093492,-0.48502,-0.88502,-0.085017 +0.284,-0.38964,-0.91598,-0.095752,-0.38502,-0.88502,-0.085017 +0.24878,-0.29716,-0.94979,-0.097961,-0.28502,-0.88502,-0.085017 +0.22319,-0.20058,-0.97458,-0.099833,-0.18502,-0.88502,-0.085017 +0.20824,-0.1011,-0.98973,-0.1011,-0.085017,-0.88502,-0.085017 +0.20463,0.050694,-0.99358,-0.10118,0.014983,-0.88502,-0.085017 +0.21216,0.15131,-0.9834,-0.10011,0.11498,-0.88502,-0.085017 +0.2305,0.24966,-0.96332,-0.098382,0.21498,-0.88502,-0.085017 +0.25906,0.34442,-0.93387,-0.096258,0.31498,-0.88502,-0.085017 +0.29696,0.43451,-0.89575,-0.094015,0.41498,-0.88502,-0.085017 +0.34312,0.51915,-0.84972,-0.091952,0.51498,-0.88502,-0.085017 +0.39631,0.55899,-0.82415,-0.091161,0.61498,-0.88502,-0.085017 +0.36092,-0.67035,-0.73659,-0.089783,-0.68502,-0.78502,-0.085017 +0.29848,-0.59783,-0.79645,-0.090914,-0.58502,-0.78502,-0.085017 +0.24243,-0.51912,-0.84966,-0.092706,-0.48502,-0.78502,-0.085017 +0.19426,-0.43449,-0.89567,-0.094863,-0.38502,-0.78502,-0.085017 +0.15531,-0.34441,-0.93379,-0.097097,-0.28502,-0.78502,-0.085017 +0.1267,-0.24965,-0.96325,-0.099108,-0.18502,-0.78502,-0.085017 +0.10932,-0.1011,-0.98973,-0.1011,-0.085017,-0.78502,-0.085017 +0.10531,0.050694,-0.99358,-0.10118,0.014983,-0.78502,-0.085017 +0.11385,0.15131,-0.9834,-0.10011,0.11498,-0.78502,-0.085017 +0.13417,0.24966,-0.96332,-0.098382,0.21498,-0.78502,-0.085017 +0.16562,0.34442,-0.93387,-0.096258,0.31498,-0.78502,-0.085017 +0.20728,0.43451,-0.89575,-0.094015,0.41498,-0.78502,-0.085017 +0.25799,0.51915,-0.84972,-0.091952,0.51498,-0.78502,-0.085017 +0.31641,0.59785,-0.7965,-0.090368,0.61498,-0.78502,-0.085017 +0.38105,0.67036,-0.73661,-0.08957,0.71498,-0.78502,-0.085017 +0.36092,-0.73661,-0.67036,-0.089571,-0.78502,-0.68502,-0.085017 +0.28747,-0.7042,-0.70436,-0.089379,-0.68502,-0.68502,-0.085017 +0.22014,-0.67035,-0.73659,-0.089783,-0.58502,-0.68502,-0.085017 +0.15921,-0.59523,-0.79188,-0.13651,-0.48502,-0.68502,-0.085017 +0.10596,-0.5171,-0.8445,-0.13937,-0.38502,-0.68502,-0.085017 +0.062456,-0.34088,-0.92912,-0.14332,-0.28502,-0.68502,-0.085017 +0.030983,-0.24902,-0.95698,-0.14894,-0.18502,-0.68502,-0.085017 +0.011625,-0.151,-0.97693,-0.151,-0.085017,-0.68502,-0.085017 +0.0065842,0.050618,-0.9872,-0.15122,0.014983,-0.68502,-0.085017 +0.016126,0.15102,-0.97718,-0.14935,0.11498,-0.68502,-0.085017 +0.038469,0.29531,-0.9441,-0.1465,0.21498,-0.68502,-0.085017 +0.074765,0.4331,-0.89041,-0.13997,0.31498,-0.68502,-0.085017 +0.12145,0.51723,-0.84482,-0.13696,0.41498,-0.68502,-0.085017 +0.17706,0.59785,-0.7965,-0.090368,0.51498,-0.68502,-0.085017 +0.24021,0.67036,-0.73661,-0.08957,0.61498,-0.68502,-0.085017 +0.30925,0.73659,-0.67035,-0.089782,0.71498,-0.68502,-0.085017 +0.38317,0.76755,-0.63464,-0.090006,0.81498,-0.68502,-0.085017 +0.37956,-0.82415,-0.55899,-0.09116,-0.88502,-0.58502,-0.085017 +0.29848,-0.7965,-0.59785,-0.090368,-0.78502,-0.58502,-0.085017 +0.22014,-0.73661,-0.67036,-0.089571,-0.68502,-0.58502,-0.085017 +0.14693,-0.7005,-0.70096,-0.134,-0.58502,-0.58502,-0.085017 +0.080123,-0.63127,-0.76376,-0.1348,-0.48502,-0.58502,-0.085017 +0.021486,-0.51518,-0.84607,-0.13696,-0.38502,-0.58502,-0.085017 +-0.027188,-0.43299,-0.89003,-0.14269,-0.28502,-0.58502,-0.085017 +-0.06464,-0.34337,-0.92778,-0.14603,-0.18502,-0.58502,-0.085017 +-0.086069,-0.151,-0.97693,-0.151,-0.085017,-0.58502,-0.085017 +-0.09213,0.049983,-0.98714,-0.15185,0.014983,-0.58502,-0.085017 +-0.081592,0.15102,-0.97718,-0.14935,0.11498,-0.58502,-0.085017 +-0.054423,0.34345,-0.92817,-0.14333,0.21498,-0.58502,-0.085017 +-0.014276,0.4331,-0.89041,-0.13997,0.31498,-0.58502,-0.085017 +0.038318,0.59388,-0.79289,-0.13652,0.41498,-0.58502,-0.085017 +0.10005,0.66719,-0.73276,-0.13386,0.51498,-0.58502,-0.085017 +0.16873,0.73269,-0.66714,-0.13452,0.61498,-0.58502,-0.085017 +0.24275,0.76755,-0.63464,-0.090006,0.71498,-0.58502,-0.085017 +0.32238,0.79645,-0.59783,-0.090914,0.81498,-0.58502,-0.085017 +0.32786,-0.87387,-0.47715,-0.093098,-0.88502,-0.48502,-0.085017 +0.24243,-0.84972,-0.51915,-0.091952,-0.78502,-0.48502,-0.085017 +0.15921,-0.79208,-0.59535,-0.13477,-0.68502,-0.48502,-0.085017 +0.080123,-0.76342,-0.63168,-0.13479,-0.58502,-0.48502,-0.085017 +0.0067866,-0.7005,-0.70096,-0.134,-0.48502,-0.48502,-0.085017 +-0.058713,-0.59398,-0.79311,-0.13477,-0.38502,-0.48502,-0.085017 +-0.11465,-0.5171,-0.8445,-0.13937,-0.28502,-0.48502,-0.085017 +-0.15746,-0.34088,-0.92912,-0.14332,-0.18502,-0.48502,-0.085017 +-0.18379,-0.14935,-0.97744,-0.14935,-0.085017,-0.48502,-0.085017 +-0.19084,0.049983,-0.98714,-0.15185,0.014983,-0.48502,-0.085017 +-0.17791,0.24675,-0.95756,-0.14896,0.11498,-0.48502,-0.085017 +-0.14655,0.43057,-0.8912,-0.14273,0.21498,-0.48502,-0.085017 +-0.099241,0.51723,-0.84482,-0.13696,0.31498,-0.48502,-0.085017 +-0.039935,0.66666,-0.73312,-0.13453,0.41498,-0.48502,-0.085017 +0.02875,0.7332,-0.66671,-0.13385,0.51498,-0.48502,-0.085017 +0.10376,0.79188,-0.59523,-0.1365,0.61498,-0.48502,-0.085017 +0.18319,0.82419,-0.55888,-0.091478,0.71498,-0.48502,-0.085017 +0.26791,0.84966,-0.51912,-0.092706,0.81498,-0.48502,-0.085017 +0.35436,0.87387,-0.47709,-0.093492,0.91498,-0.48502,-0.085017 +0.37688,-0.93387,-0.34442,-0.096258,-0.98502,-0.38502,-0.085017 +0.284,-0.91602,-0.38965,-0.095334,-0.88502,-0.38502,-0.085017 +0.19426,-0.89575,-0.43451,-0.094015,-0.78502,-0.38502,-0.085017 +0.10595,-0.84572,-0.51509,-0.1394,-0.68502,-0.38502,-0.085017 +0.021464,-0.84482,-0.51723,-0.13696,-0.58502,-0.38502,-0.085017 +-0.058739,-0.79208,-0.59535,-0.13477,-0.48502,-0.38502,-0.085017 +-0.13321,-0.66671,-0.7332,-0.13385,-0.38502,-0.38502,-0.085017 +-0.19742,-0.59398,-0.79311,-0.13477,-0.28502,-0.38502,-0.085017 +-0.24827,-0.4268,-0.87323,-0.23519,-0.18502,-0.38502,-0.085017 +-0.28052,-0.24556,-0.93776,-0.24556,-0.085017,-0.38502,-0.085017 +-0.28903,0.04994,-0.96705,-0.24966,0.014983,-0.38502,-0.085017 +-0.27322,0.24564,-0.93858,-0.24234,0.11498,-0.38502,-0.085017 +-0.23522,0.50986,-0.83,-0.22616,0.21498,-0.38502,-0.085017 +-0.17964,0.59535,-0.79208,-0.13477,0.31498,-0.38502,-0.085017 +-0.11124,0.7332,-0.66671,-0.13385,0.41498,-0.38502,-0.085017 +-0.034955,0.79188,-0.59523,-0.1365,0.51498,-0.38502,-0.085017 +0.046817,0.8445,-0.5171,-0.13937,0.61498,-0.38502,-0.085017 +0.13178,0.86911,-0.47444,-0.13984,0.71498,-0.38502,-0.085017 +0.2211,0.89567,-0.43449,-0.094864,0.81498,-0.38502,-0.085017 +0.31145,0.91598,-0.38964,-0.095752,0.91498,-0.38502,-0.085017 +0.34463,-0.96332,-0.24965,-0.098382,-0.98502,-0.28502,-0.085017 +0.24878,-0.94985,-0.29711,-0.097571,-0.88502,-0.28502,-0.085017 +0.15531,-0.93387,-0.34442,-0.096258,-0.78502,-0.28502,-0.085017 +0.062447,-0.92817,-0.34345,-0.14333,-0.68502,-0.28502,-0.085017 +-0.027254,-0.89041,-0.4331,-0.13996,-0.58502,-0.28502,-0.085017 +-0.1147,-0.84572,-0.51509,-0.1394,-0.48502,-0.28502,-0.085017 +-0.19744,-0.79289,-0.59388,-0.13652,-0.38502,-0.28502,-0.085017 +-0.27217,-0.6562,-0.72162,-0.22059,-0.28502,-0.28502,-0.085017 +-0.33341,-0.5068,-0.83187,-0.22617,-0.18502,-0.28502,-0.085017 +-0.37436,-0.24235,-0.93943,-0.24235,-0.085017,-0.28502,-0.085017 +-0.38572,0.049032,-0.96687,-0.25053,0.014983,-0.28502,-0.085017 +-0.36488,0.33494,-0.91094,-0.24084,0.11498,-0.28502,-0.085017 +-0.31668,0.58428,-0.77976,-0.22492,0.21498,-0.28502,-0.085017 +-0.25056,0.72076,-0.6568,-0.22161,0.31498,-0.28502,-0.085017 +-0.17367,0.79188,-0.59523,-0.1365,0.41498,-0.28502,-0.085017 +-0.089343,0.8445,-0.5171,-0.13937,0.51498,-0.28502,-0.085017 +-0.00051677,0.89003,-0.43299,-0.1427,0.61498,-0.28502,-0.085017 +0.090277,0.92778,-0.34337,-0.14603,0.71498,-0.28502,-0.085017 +0.18325,0.93379,-0.34441,-0.097095,0.81498,-0.28502,-0.085017 +0.27721,0.94979,-0.29716,-0.09796,0.91498,-0.28502,-0.085017 +0.37361,0.96709,-0.24965,-0.049031,1.015,-0.28502,-0.085017 +0.32141,-0.9834,-0.15131,-0.10011,-0.98502,-0.18502,-0.085017 +0.22319,-0.97463,-0.20046,-0.099522,-0.88502,-0.18502,-0.085017 +0.1267,-0.96332,-0.24965,-0.098382,-0.78502,-0.18502,-0.085017 +0.030952,-0.95733,-0.24907,-0.14659,-0.68502,-0.18502,-0.085017 +-0.064652,-0.9287,-0.34086,-0.14606,-0.58502,-0.18502,-0.085017 +-0.15752,-0.9287,-0.34086,-0.14606,-0.48502,-0.18502,-0.085017 +-0.24833,-0.87414,-0.42704,-0.23133,-0.38502,-0.18502,-0.085017 +-0.3335,-0.83,-0.50986,-0.22616,-0.28502,-0.18502,-0.085017 +-0.38778,0.70354,-0.64198,-0.30479,0.21498,-0.18502,-0.085017 +-0.30852,0.82922,-0.50956,-0.22964,0.31498,-0.18502,-0.085017 +-0.22183,0.89161,-0.43063,-0.13996,0.41498,-0.18502,-0.085017 +-0.12962,0.92778,-0.34337,-0.14603,0.51498,-0.18502,-0.085017 +-0.036071,0.95793,-0.24675,-0.14659,0.61498,-0.18502,-0.085017 +0.05966,0.95698,-0.24903,-0.14893,0.71498,-0.18502,-0.085017 +0.15549,0.96325,-0.24965,-0.099107,0.81498,-0.18502,-0.085017 +0.25248,0.97458,-0.20058,-0.099833,0.91498,-0.18502,-0.085017 +0.351,0.98724,-0.15122,-0.049981,1.015,-0.18502,-0.085017 +0.30786,-0.98976,-0.10092,-0.10092,-0.98502,-0.085017,-0.085017 +0.20824,-0.98976,-0.10092,-0.10092,-0.88502,-0.085017,-0.085017 +0.10932,-0.98976,-0.10092,-0.10092,-0.78502,-0.085017,-0.085017 +0.011601,-0.97718,-0.15019,-0.15019,-0.68502,-0.085017,-0.085017 +-0.086118,-0.97718,-0.15102,-0.14935,-0.58502,-0.085017,-0.085017 +-0.18384,-0.97718,-0.15102,-0.14935,-0.48502,-0.085017,-0.085017 +-0.28058,-0.93858,-0.24234,-0.24564,-0.38502,-0.085017,-0.085017 +-0.37444,-0.93858,-0.24234,-0.24564,-0.28502,-0.085017,-0.085017 +-0.34621,0.93943,-0.24235,-0.24235,0.31498,-0.085017,-0.085017 +-0.25225,0.97744,-0.14934,-0.14935,0.41498,-0.085017,-0.085017 +-0.1545,0.97744,-0.14934,-0.14935,0.51498,-0.085017,-0.085017 +-0.056794,0.97693,-0.151,-0.151,0.61498,-0.085017,-0.085017 +0.040899,0.97693,-0.151,-0.151,0.71498,-0.085017,-0.085017 +0.1388,0.98973,-0.1011,-0.1011,0.81498,-0.085017,-0.085017 +0.23806,0.98973,-0.1011,-0.1011,0.91498,-0.085017,-0.085017 +0.33775,0.99743,-0.05064,-0.050639,1.015,-0.085017,-0.085017 +0.30431,-0.9987,0.00011852,-0.050943,-0.98502,0.014983,-0.085017 +0.20463,-0.99356,0.050695,-0.10137,-0.88502,0.014983,-0.085017 +0.10531,-0.99356,0.050695,-0.10137,-0.78502,0.014983,-0.085017 +0.0065933,-0.98711,0.050618,-0.15185,-0.68502,0.014983,-0.085017 +-0.092117,-0.98711,0.050618,-0.15185,-0.58502,0.014983,-0.085017 +-0.19083,-0.98717,0.050299,-0.15153,-0.48502,0.014983,-0.085017 +-0.28901,-0.96682,0.049937,-0.25052,-0.38502,0.014983,-0.085017 +-0.3857,-0.96709,0.049029,-0.24965,-0.28502,0.014983,-0.085017 +-0.35675,0.96687,0.049033,-0.25053,0.31498,0.014983,-0.085017 +-0.25998,0.98714,0.049984,-0.15185,0.41498,0.014983,-0.085017 +-0.16126,0.98714,0.049984,-0.15185,0.51498,0.014983,-0.085017 +-0.062549,0.98714,0.049984,-0.15185,0.61498,0.014983,-0.085017 +0.036167,0.9872,0.050618,-0.15122,0.71498,0.014983,-0.085017 +0.13498,0.99358,0.050694,-0.10118,0.81498,0.014983,-0.085017 +0.23448,0.99358,0.050694,-0.10118,0.91498,0.014983,-0.085017 +0.3342,0.9987,-0.00011799,-0.050943,1.015,0.014983,-0.085017 +0.31082,-0.99356,0.10137,-0.050693,-0.98502,0.11498,-0.085017 +0.21216,-0.98335,0.15131,-0.10062,-0.88502,0.11498,-0.085017 +0.11385,-0.98335,0.15131,-0.10062,-0.78502,0.11498,-0.085017 +0.01615,-0.97693,0.151,-0.151,-0.68502,0.11498,-0.085017 +-0.081575,-0.97744,0.14935,-0.14935,-0.58502,0.11498,-0.085017 +-0.17785,-0.95698,0.24902,-0.14893,-0.48502,0.11498,-0.085017 +-0.27316,-0.93776,0.24556,-0.24556,-0.38502,0.11498,-0.085017 +-0.36479,-0.91192,0.33501,-0.23701,-0.28502,0.11498,-0.085017 +-0.33758,0.91094,0.33494,-0.24084,0.31498,0.11498,-0.085017 +-0.24497,0.95756,0.24675,-0.14896,0.41498,0.11498,-0.085017 +-0.14921,0.95756,0.24675,-0.14896,0.51498,0.11498,-0.085017 +-0.05231,0.97718,0.15102,-0.14935,0.61498,0.11498,-0.085017 +0.045409,0.97718,0.15102,-0.14935,0.71498,0.11498,-0.085017 +0.14323,0.9834,0.15131,-0.10011,0.81498,0.11498,-0.085017 +0.24171,0.9834,0.15131,-0.10011,0.91498,0.11498,-0.085017 +0.34046,0.99358,0.10118,-0.050694,1.015,0.11498,-0.085017 +0.32717,-0.97458,0.20058,-0.099833,-0.98502,0.21498,-0.085017 +0.2305,-0.96325,0.24965,-0.099106,-0.88502,0.21498,-0.085017 +0.13417,-0.96325,0.24965,-0.099106,-0.78502,0.21498,-0.085017 +0.038469,-0.94406,0.29544,-0.14649,-0.68502,0.21498,-0.085017 +-0.05435,-0.92778,0.34337,-0.14603,-0.58502,0.21498,-0.085017 +-0.14651,-0.89003,0.43299,-0.1427,-0.48502,0.21498,-0.085017 +-0.23517,-0.82922,0.50956,-0.22964,-0.38502,0.21498,-0.085017 +-0.3166,-0.78032,0.58453,-0.2223,-0.28502,0.21498,-0.085017 +-0.38781,-0.64099,0.70442,-0.30483,-0.18502,0.21498,-0.085017 +-0.36854,0.64125,0.70476,-0.30348,0.21498,0.21498,-0.085017 +-0.29331,0.77976,0.58428,-0.22492,0.31498,0.21498,-0.085017 +-0.20897,0.8912,0.43057,-0.14273,0.41498,0.21498,-0.085017 +-0.11943,0.92817,0.34345,-0.14333,0.51498,0.21498,-0.085017 +-0.026608,0.9287,0.34086,-0.14606,0.61498,0.21498,-0.085017 +0.067103,0.95733,0.24907,-0.14659,0.71498,0.21498,-0.085017 +0.16297,0.96332,0.24966,-0.098382,0.81498,0.21498,-0.085017 +0.25945,0.96332,0.24966,-0.098382,0.91498,0.21498,-0.085017 +0.35632,0.97831,0.201,-0.050024,1.015,0.21498,-0.085017 +0.35292,-0.94979,0.29716,-0.09796,-0.98502,0.31498,-0.085017 +0.25906,-0.93379,0.34441,-0.097095,-0.88502,0.31498,-0.085017 +0.16562,-0.93379,0.34441,-0.097095,-0.78502,0.31498,-0.085017 +0.074791,-0.89003,0.43299,-0.1427,-0.68502,0.31498,-0.085017 +-0.014262,-0.89161,0.43062,-0.13996,-0.58502,0.31498,-0.085017 +-0.099201,-0.84607,0.51518,-0.13696,-0.48502,0.31498,-0.085017 +-0.17962,-0.79311,0.59398,-0.13477,-0.38502,0.31498,-0.085017 +-0.25058,-0.65695,0.72094,-0.2206,-0.28502,0.31498,-0.085017 +-0.3086,-0.50657,0.83102,-0.22974,-0.18502,0.31498,-0.085017 +-0.34631,-0.24234,0.93858,-0.24564,-0.085017,0.31498,-0.085017 +-0.35672,0.049032,0.96709,-0.24965,0.014983,0.31498,-0.085017 +-0.33746,0.33677,0.91078,-0.23887,0.11498,0.31498,-0.085017 +-0.29328,0.58632,0.77825,-0.22486,0.21498,0.31498,-0.085017 +-0.23089,0.6562,0.72162,-0.22059,0.31498,0.31498,-0.085017 +-0.15589,0.79289,0.59388,-0.13652,0.41498,0.31498,-0.085017 +-0.073924,0.84572,0.51509,-0.1394,0.51498,0.31498,-0.085017 +0.012406,0.89041,0.4331,-0.13996,0.61498,0.31498,-0.085017 +0.10145,0.8912,0.43057,-0.14273,0.71498,0.31498,-0.085017 +0.19357,0.93387,0.34442,-0.096258,0.81498,0.31498,-0.085017 +0.28712,0.93387,0.34442,-0.096258,0.91498,0.31498,-0.085017 +0.38144,0.95333,0.29793,-0.049062,1.015,0.31498,-0.085017 +0.3875,-0.91598,0.38964,-0.095752,-0.98502,0.41498,-0.085017 +0.29696,-0.89567,0.43449,-0.094864,-0.88502,0.41498,-0.085017 +0.20728,-0.89567,0.43449,-0.094864,-0.78502,0.41498,-0.085017 +0.12146,-0.8445,0.5171,-0.13937,-0.68502,0.41498,-0.085017 +0.03834,-0.79188,0.59523,-0.1365,-0.58502,0.41498,-0.085017 +-0.039927,-0.73269,0.66714,-0.13452,-0.48502,0.41498,-0.085017 +-0.11126,-0.66666,0.73312,-0.13453,-0.38502,0.41498,-0.085017 +-0.17368,-0.59388,0.79289,-0.13652,-0.28502,0.41498,-0.085017 +-0.22187,-0.43057,0.8912,-0.14273,-0.18502,0.41498,-0.085017 +-0.25227,-0.15102,0.97718,-0.14935,-0.085017,0.41498,-0.085017 +-0.25997,0.049981,0.98724,-0.15122,0.014983,0.41498,-0.085017 +-0.24494,0.24675,0.95793,-0.14659,0.11498,0.41498,-0.085017 +-0.20893,0.43063,0.89161,-0.13996,0.21498,0.41498,-0.085017 +-0.15586,0.59398,0.79311,-0.13476,0.31498,0.41498,-0.085017 +-0.091262,0.66671,0.7332,-0.13385,0.41498,0.41498,-0.085017 +-0.017163,0.79208,0.59535,-0.13477,0.51498,0.41498,-0.085017 +0.062283,0.81973,0.55615,-0.13689,0.61498,0.41498,-0.085017 +0.14676,0.84482,0.51723,-0.13696,0.71498,0.41498,-0.085017 +0.23412,0.89575,0.43451,-0.094015,0.81498,0.41498,-0.085017 +0.32388,0.89575,0.43451,-0.094015,0.91498,0.41498,-0.085017 +0.34312,-0.84966,0.51912,-0.092706,-0.88502,0.51498,-0.085017 +0.25799,-0.84966,0.51912,-0.092706,-0.78502,0.51498,-0.085017 +0.17706,-0.79645,0.59783,-0.090914,-0.68502,0.51498,-0.085017 +0.10005,-0.73269,0.66714,-0.13452,-0.58502,0.51498,-0.085017 +0.028737,-0.66719,0.73276,-0.13386,-0.48502,0.51498,-0.085017 +-0.035004,-0.59535,0.79208,-0.13477,-0.38502,0.51498,-0.085017 +-0.089359,-0.51509,0.84572,-0.1394,-0.28502,0.51498,-0.085017 +-0.12969,-0.34086,0.9287,-0.14606,-0.18502,0.51498,-0.085017 +-0.15455,-0.15102,0.97718,-0.14935,-0.085017,0.51498,-0.085017 +-0.16125,0.050616,0.98711,-0.15185,0.014983,0.51498,-0.085017 +-0.14918,0.24902,0.95698,-0.14893,0.11498,0.51498,-0.085017 +-0.1194,0.34088,0.92912,-0.14332,0.21498,0.51498,-0.085017 +-0.073847,0.51614,0.84529,-0.13817,0.31498,0.51498,-0.085017 +-0.017147,0.59398,0.79311,-0.13476,0.41498,0.51498,-0.085017 +0.048783,0.7005,0.70096,-0.134,0.51498,0.51498,-0.085017 +0.12202,0.76342,0.63168,-0.13479,0.61498,0.51498,-0.085017 +0.20084,0.7965,0.59785,-0.090368,0.71498,0.51498,-0.085017 +0.28348,0.84972,0.51915,-0.091952,0.81498,0.51498,-0.085017 +0.36868,0.87387,0.47715,-0.093098,0.91498,0.51498,-0.085017 +0.39631,-0.82419,0.55888,-0.091478,-0.88502,0.61498,-0.085017 +0.31641,-0.79645,0.59783,-0.090914,-0.78502,0.61498,-0.085017 +0.24021,-0.73659,0.67035,-0.089783,-0.68502,0.61498,-0.085017 +0.16873,-0.66719,0.73276,-0.13386,-0.58502,0.61498,-0.085017 +0.10374,-0.59535,0.79208,-0.13477,-0.48502,0.61498,-0.085017 +0.04678,-0.51723,0.84482,-0.13696,-0.38502,0.61498,-0.085017 +-0.00057236,-0.4331,0.89041,-0.13997,-0.28502,0.61498,-0.085017 +-0.036093,-0.24907,0.95733,-0.14659,-0.18502,0.61498,-0.085017 +-0.056835,-0.15102,0.97718,-0.14935,-0.085017,0.61498,-0.085017 +-0.062538,0.050616,0.98711,-0.15185,0.014983,0.61498,-0.085017 +-0.052285,0.14935,0.97744,-0.14935,0.11498,0.61498,-0.085017 +-0.026548,0.34337,0.92778,-0.14603,0.21498,0.61498,-0.085017 +0.012456,0.43063,0.89161,-0.13996,0.31498,0.61498,-0.085017 +0.062283,0.55585,0.81993,-0.13689,0.41498,0.61498,-0.085017 +0.12202,0.63127,0.76376,-0.1348,0.51498,0.61498,-0.085017 +0.18894,0.7042,0.70436,-0.089379,0.61498,0.61498,-0.085017 +0.26227,0.73661,0.67036,-0.089571,0.71498,0.61498,-0.085017 +0.34032,0.7965,0.59785,-0.090368,0.81498,0.61498,-0.085017 +0.38105,-0.73659,0.67035,-0.089783,-0.78502,0.71498,-0.085017 +0.30925,-0.67036,0.73661,-0.08957,-0.68502,0.71498,-0.085017 +0.24275,-0.63479,0.76745,-0.089821,-0.58502,0.71498,-0.085017 +0.18319,-0.55899,0.82415,-0.09116,-0.48502,0.71498,-0.085017 +0.13178,-0.47461,0.86902,-0.13984,-0.38502,0.71498,-0.085017 +0.090261,-0.34345,0.92817,-0.14333,-0.28502,0.71498,-0.085017 +0.05964,-0.24907,0.95733,-0.14659,-0.18502,0.71498,-0.085017 +0.040883,-0.15019,0.97718,-0.15018,-0.085017,0.71498,-0.085017 +0.036173,0.050616,0.98711,-0.15185,0.014983,0.71498,-0.085017 +0.045424,0.151,0.97693,-0.151,0.11498,0.71498,-0.085017 +0.067116,0.24675,0.95793,-0.14659,0.21498,0.71498,-0.085017 +0.10146,0.43299,0.89003,-0.14269,0.31498,0.71498,-0.085017 +0.14676,0.5171,0.8445,-0.13937,0.41498,0.71498,-0.085017 +0.20084,0.59783,0.79645,-0.090914,0.51498,0.71498,-0.085017 +0.26227,0.67035,0.73659,-0.089782,0.61498,0.71498,-0.085017 +0.32973,0.7042,0.70436,-0.089379,0.71498,0.71498,-0.085017 +0.38317,-0.63479,0.76745,-0.089821,-0.68502,0.81498,-0.085017 +0.32238,-0.59785,0.7965,-0.090368,-0.58502,0.81498,-0.085017 +0.26791,-0.51915,0.84972,-0.091952,-0.48502,0.81498,-0.085017 +0.2211,-0.43451,0.89575,-0.094015,-0.38502,0.81498,-0.085017 +0.18325,-0.34442,0.93387,-0.096258,-0.28502,0.81498,-0.085017 +0.15549,-0.24966,0.96332,-0.098382,-0.18502,0.81498,-0.085017 +0.1388,-0.10092,0.98976,-0.10092,-0.085017,0.81498,-0.085017 +0.13498,0.050693,0.99356,-0.10137,0.014983,0.81498,-0.085017 +0.14323,0.15131,0.98335,-0.10062,0.11498,0.81498,-0.085017 +0.16297,0.24965,0.96325,-0.099107,0.21498,0.81498,-0.085017 +0.19357,0.34441,0.93379,-0.097096,0.31498,0.81498,-0.085017 +0.23412,0.43449,0.89567,-0.094863,0.41498,0.81498,-0.085017 +0.28348,0.51912,0.84966,-0.092705,0.51498,0.81498,-0.085017 +0.34032,0.59783,0.79645,-0.090914,0.61498,0.81498,-0.085017 +0.35436,-0.47715,0.87387,-0.093098,-0.48502,0.91498,-0.085017 +0.31145,-0.38965,0.91602,-0.095334,-0.38502,0.91498,-0.085017 +0.27721,-0.29711,0.94985,-0.097571,-0.28502,0.91498,-0.085017 +0.25248,-0.20046,0.97463,-0.099521,-0.18502,0.91498,-0.085017 +0.23806,-0.10092,0.98976,-0.10092,-0.085017,0.91498,-0.085017 +0.23448,0.050693,0.99356,-0.10137,0.014983,0.91498,-0.085017 +0.24171,0.15131,0.98335,-0.10062,0.11498,0.91498,-0.085017 +0.25945,0.24965,0.96325,-0.099107,0.21498,0.91498,-0.085017 +0.28712,0.34441,0.93379,-0.097096,0.31498,0.91498,-0.085017 +0.32388,0.43449,0.89567,-0.094863,0.41498,0.91498,-0.085017 +0.36868,0.47709,0.87387,-0.093492,0.51498,0.91498,-0.085017 +0.37361,-0.24966,0.96705,-0.049939,-0.28502,1.015,-0.085017 +0.35099,-0.15122,0.9872,-0.050618,-0.18502,1.015,-0.085017 +0.33775,-0.050759,0.99742,-0.050758,-0.085017,1.015,-0.085017 +0.3342,0.00011897,0.9987,-0.050944,0.014983,1.015,-0.085017 +0.34046,0.10137,0.99356,-0.050695,0.11498,1.015,-0.085017 +0.35632,0.20113,0.97829,-0.050024,0.21498,1.015,-0.085017 +0.38144,0.29798,0.95331,-0.049061,0.31498,1.015,-0.085017 +0.37352,-0.34597,-0.93824,-0.00052078,-0.38502,-0.98502,0.014983 +0.34119,-0.25083,-0.96803,-0.00045243,-0.28502,-0.98502,0.014983 +0.31791,-0.15204,-0.98837,-0.00031734,-0.18502,-0.98502,0.014983 +0.30431,-0.050943,-0.9987,-0.00011814,-0.085017,-0.98502,0.014983 +0.30075,1.0493e-07,-1,4.6363e-07,0.014983,-0.98502,0.014983 +0.30728,0.10151,-0.99483,0.00010841,0.11498,-0.98502,0.014983 +0.32368,0.20149,-0.97949,0.00019152,0.21498,-0.98502,0.014983 +0.34949,0.29852,-0.9544,0.0002403,0.31498,-0.98502,0.014983 +0.38415,0.39139,-0.92022,0.00025763,0.41498,-0.98502,0.014983 +0.37632,-0.56126,-0.82764,-0.00019247,-0.58502,-0.88502,0.014983 +0.32454,-0.47918,-0.87772,-0.00024079,-0.48502,-0.88502,0.014983 +0.28059,-0.39074,-0.91925,0.047953,-0.38502,-0.88502,0.014983 +0.24528,-0.29793,-0.95333,0.049064,-0.28502,-0.88502,0.014983 +0.21962,-0.201,-0.97831,0.050024,-0.18502,-0.88502,0.014983 +0.20463,-0.10118,-0.99358,0.050693,-0.085017,-0.88502,0.014983 +0.20101,0.050877,-0.99741,0.050881,0.014983,-0.88502,0.014983 +0.20856,0.15185,-0.98711,0.050618,0.11498,-0.88502,0.014983 +0.22696,0.25052,-0.96682,0.049938,0.21498,-0.88502,0.014983 +0.25559,0.34555,-0.93712,0.048967,0.31498,-0.88502,0.014983 +0.29357,0.43589,-0.89873,0.047861,0.41498,-0.88502,0.014983 +0.33981,0.52132,-0.85336,0.00045754,0.51498,-0.88502,0.014983 +0.39309,0.56126,-0.82764,0.0001919,0.61498,-0.88502,0.014983 +0.3577,-0.67306,-0.73959,-0.00012318,-0.68502,-0.78502,0.014983 +0.29515,-0.59967,-0.79897,0.045134,-0.58502,-0.78502,0.014983 +0.23896,-0.52077,-0.85247,0.045834,-0.48502,-0.78502,0.014983 +0.19063,-0.43591,-0.89877,0.046815,-0.38502,-0.78502,0.014983 +0.15151,-0.34557,-0.93717,0.04793,-0.28502,-0.78502,0.014983 +0.12276,-0.25053,-0.96687,0.049034,-0.18502,-0.78502,0.014983 +0.10531,-0.10118,-0.99358,0.050693,-0.085017,-0.78502,0.014983 +0.10127,0.050877,-0.99741,0.050881,0.014983,-0.78502,0.014983 +0.10985,0.15185,-0.98711,0.050618,0.11498,-0.78502,0.014983 +0.13028,0.25052,-0.96682,0.049938,0.21498,-0.78502,0.014983 +0.16188,0.34555,-0.93712,0.048967,0.31498,-0.78502,0.014983 +0.2037,0.43498,-0.89922,0.046811,0.41498,-0.78502,0.014983 +0.25457,0.52,-0.85293,0.045834,0.51498,-0.78502,0.014983 +0.31312,0.59965,-0.79895,0.045784,0.61498,-0.78502,0.014983 +0.37785,0.67306,-0.73959,0.00012334,0.71498,-0.78502,0.014983 +0.3577,-0.73959,-0.67306,0.00012392,-0.78502,-0.68502,0.014983 +0.28413,-0.70648,-0.70631,0.044909,-0.68502,-0.68502,0.014983 +0.21658,-0.6722,-0.739,0.045107,-0.58502,-0.68502,0.014983 +0.15529,-0.59967,-0.79897,0.045134,-0.48502,-0.68502,0.014983 +0.10164,-0.52,-0.85289,0.046754,-0.38502,-0.68502,0.014983 +0.057797,-0.34557,-0.93717,0.04793,-0.28502,-0.68502,0.014983 +0.026076,-0.25053,-0.96687,0.049034,-0.18502,-0.68502,0.014983 +0.0065842,-0.15123,-0.9872,0.050616,-0.085017,-0.68502,0.014983 +0.0015246,0.050877,-0.99741,0.050881,0.014983,-0.68502,0.014983 +0.011144,0.15185,-0.98711,0.050618,0.11498,-0.68502,0.014983 +0.033639,0.29798,-0.95331,0.049061,0.21498,-0.68502,0.014983 +0.07024,0.43589,-0.89873,0.047861,0.31498,-0.68502,0.014983 +0.11725,0.52075,-0.85243,0.046748,0.41498,-0.68502,0.014983 +0.17326,0.59965,-0.79895,0.045784,0.51498,-0.68502,0.014983 +0.23673,0.67237,-0.73884,0.045106,0.61498,-0.68502,0.014983 +0.30596,0.73884,-0.67238,0.04486,0.71498,-0.68502,0.014983 +0.37997,0.77063,-0.63729,-0.00010961,0.81498,-0.68502,0.014983 +0.37632,-0.82764,-0.56126,0.00019172,-0.88502,-0.58502,0.014983 +0.29515,-0.79895,-0.59965,0.045783,-0.78502,-0.58502,0.014983 +0.21658,-0.73884,-0.67237,0.045106,-0.68502,-0.58502,0.014983 +0.14285,-0.70648,-0.70631,0.044909,-0.58502,-0.58502,0.014983 +0.075512,-0.63664,-0.76984,0.045171,-0.48502,-0.58502,0.014983 +0.016391,-0.52077,-0.85247,0.045834,-0.38502,-0.58502,0.014983 +-0.032712,-0.43591,-0.89877,0.046815,-0.28502,-0.58502,0.014983 +-0.070463,-0.3446,-0.93747,0.048975,-0.18502,-0.58502,0.014983 +-0.09213,-0.15185,-0.98714,0.049984,-0.085017,-0.58502,0.014983 +-0.098216,0.050877,-0.99741,0.050881,0.014983,-0.58502,0.014983 +-0.087573,0.15122,-0.98724,0.049982,0.11498,-0.58502,0.014983 +-0.060103,0.34555,-0.93712,0.048967,0.21498,-0.58502,0.014983 +-0.019644,0.43498,-0.89922,0.046811,0.31498,-0.58502,0.014983 +0.033401,0.59965,-0.79895,0.045784,0.41498,-0.58502,0.014983 +0.095607,0.67237,-0.73884,0.045106,0.51498,-0.58502,0.014983 +0.16483,0.73884,-0.67238,0.04486,0.61498,-0.58502,0.014983 +0.23928,0.76984,-0.63664,0.04517,0.71498,-0.58502,0.014983 +0.31909,0.79897,-0.59967,0.045134,0.81498,-0.58502,0.014983 +0.32454,-0.87772,-0.47918,0.00024068,-0.88502,-0.48502,0.014983 +0.23896,-0.85243,-0.52075,0.046749,-0.78502,-0.48502,0.014983 +0.15529,-0.79895,-0.59965,0.045783,-0.68502,-0.48502,0.014983 +0.075512,-0.76996,-0.63649,0.045171,-0.58502,-0.48502,0.014983 +0.0015725,-0.70648,-0.70631,0.044909,-0.48502,-0.48502,0.014983 +-0.064474,-0.59967,-0.79897,0.045134,-0.38502,-0.48502,0.014983 +-0.12093,-0.52077,-0.85247,0.045834,-0.28502,-0.48502,0.014983 +-0.16419,-0.34557,-0.93717,0.04793,-0.18502,-0.48502,0.014983 +-0.19084,-0.15185,-0.98714,0.049984,-0.085017,-0.48502,0.014983 +-0.19796,0.050877,-0.99741,0.050881,0.014983,-0.48502,0.014983 +-0.18482,0.25052,-0.96682,0.049938,0.11498,-0.48502,0.014983 +-0.15309,0.43589,-0.89873,0.047861,0.21498,-0.48502,0.014983 +-0.10531,0.52,-0.85293,0.045834,0.31498,-0.48502,0.014983 +-0.045514,0.67237,-0.73884,0.045106,0.41498,-0.48502,0.014983 +0.023711,0.73884,-0.67238,0.04486,0.51498,-0.48502,0.014983 +0.099332,0.79897,-0.59967,0.045134,0.61498,-0.48502,0.014983 +0.17945,0.82682,-0.56059,0.045861,0.71498,-0.48502,0.014983 +0.26451,0.85247,-0.52077,0.045834,0.81498,-0.48502,0.014983 +0.35106,0.87772,-0.47918,-0.00024113,0.91498,-0.48502,0.014983 +0.37352,-0.93825,-0.34597,0.00052048,-0.98502,-0.38502,0.014983 +0.28059,-0.91926,-0.39073,0.047953,-0.88502,-0.38502,0.014983 +0.19064,-0.89873,-0.43589,0.04786,-0.78502,-0.38502,0.014983 +0.10165,-0.85243,-0.52075,0.046749,-0.68502,-0.38502,0.014983 +0.016399,-0.85293,-0.52,0.045832,-0.58502,-0.38502,0.014983 +-0.064465,-0.79935,-0.59916,0.045133,-0.48502,-0.38502,0.014983 +-0.13955,-0.73901,-0.6722,0.044859,-0.38502,-0.38502,0.014983 +-0.20434,-0.59967,-0.79897,0.045134,-0.28502,-0.38502,0.014983 +-0.25606,-0.43591,-0.89877,0.046815,-0.18502,-0.38502,0.014983 +-0.28903,-0.24966,-0.96705,0.049939,-0.085017,-0.38502,0.014983 +-0.2977,0.050877,-0.99741,0.050881,0.014983,-0.38502,0.014983 +-0.28151,0.24965,-0.96709,0.04903,0.11498,-0.38502,0.014983 +-0.24263,0.52075,-0.85243,0.046748,0.21498,-0.38502,0.014983 +-0.18636,0.59916,-0.79935,0.045133,0.31498,-0.38502,0.014983 +-0.11741,0.73884,-0.67238,0.04486,0.41498,-0.38502,0.014983 +-0.040532,0.79897,-0.59967,0.045134,0.51498,-0.38502,0.014983 +0.041936,0.85247,-0.52077,0.045834,0.61498,-0.38502,0.014983 +0.12769,0.87684,-0.4785,0.046836,0.71498,-0.38502,0.014983 +0.21757,0.89877,-0.43591,0.046814,0.81498,-0.38502,0.014983 +0.30806,0.91925,-0.39074,0.047953,0.91498,-0.38502,0.014983 +0.34119,-0.96803,-0.25083,0.0004536,-0.98502,-0.28502,0.014983 +0.24528,-0.95331,-0.29798,0.049062,-0.88502,-0.28502,0.014983 +0.15152,-0.93712,-0.34556,0.04897,-0.78502,-0.28502,0.014983 +0.057801,-0.93752,-0.3446,0.047929,-0.68502,-0.28502,0.014983 +-0.032695,-0.89873,-0.43589,0.04786,-0.58502,-0.28502,0.014983 +-0.12091,-0.85243,-0.52075,0.046749,-0.48502,-0.28502,0.014983 +-0.20432,-0.79895,-0.59965,0.045783,-0.38502,-0.28502,0.014983 +-0.28067,-0.73901,-0.6722,0.044859,-0.28502,-0.28502,0.014983 +-0.3435,-0.52077,-0.85247,0.045834,-0.18502,-0.28502,0.014983 +-0.38572,-0.25053,-0.96687,0.049034,-0.085017,-0.28502,0.014983 +-0.39744,0.050639,-0.99743,0.050639,0.014983,-0.28502,0.014983 +-0.3758,0.3446,-0.93753,0.04793,0.11498,-0.28502,0.014983 +-0.32621,0.59965,-0.79895,0.045784,0.21498,-0.28502,0.014983 +-0.25853,0.73884,-0.67238,0.04486,0.31498,-0.28502,0.014983 +-0.18039,0.79932,-0.59915,0.045784,0.41498,-0.28502,0.014983 +-0.095376,0.85289,-0.52,0.046751,0.51498,-0.28502,0.014983 +-0.0057795,0.89877,-0.43591,0.046814,0.61498,-0.28502,0.014983 +0.08588,0.93717,-0.34557,0.04793,0.71498,-0.28502,0.014983 +0.1796,0.93717,-0.34557,0.04793,0.81498,-0.28502,0.014983 +0.27374,0.95333,-0.29793,0.049064,0.91498,-0.28502,0.014983 +0.37018,0.96803,-0.25083,-0.00045249,1.015,-0.28502,0.014983 +0.31791,-0.98837,-0.15204,0.00031713,-0.98502,-0.18502,0.014983 +0.21962,-0.97829,-0.20113,0.050024,-0.88502,-0.18502,0.014983 +0.12277,-0.96682,-0.25052,0.049938,-0.78502,-0.18502,0.014983 +0.026088,-0.96682,-0.25052,0.049938,-0.68502,-0.18502,0.014983 +-0.070458,-0.93712,-0.34556,0.04897,-0.58502,-0.18502,0.014983 +-0.16417,-0.93712,-0.34556,0.04897,-0.48502,-0.18502,0.014983 +-0.25603,-0.89873,-0.43589,0.04786,-0.38502,-0.18502,0.014983 +-0.34348,-0.85293,-0.52,0.045832,-0.28502,-0.18502,0.014983 +-0.39965,0.739,-0.6722,0.045106,0.21498,-0.18502,0.014983 +-0.31795,0.85289,-0.52,0.046751,0.31498,-0.18502,0.014983 +-0.22912,0.89917,-0.43498,0.047863,0.41498,-0.18502,0.014983 +-0.13611,0.93717,-0.34557,0.04793,0.51498,-0.18502,0.014983 +-0.041638,0.96687,-0.25053,0.049033,0.61498,-0.18502,0.014983 +0.055049,0.96687,-0.25053,0.049033,0.71498,-0.18502,0.014983 +0.15174,0.96687,-0.25053,0.049033,0.81498,-0.18502,0.014983 +0.24894,0.97831,-0.201,0.050024,0.91498,-0.18502,0.014983 +0.3475,0.98837,-0.15204,-0.00031716,1.015,-0.18502,0.014983 +0.30431,-0.9987,-0.050943,0.00011897,-0.98502,-0.085017,0.014983 +0.20463,-0.99356,-0.10138,0.050693,-0.88502,-0.085017,0.014983 +0.10531,-0.99356,-0.10138,0.050693,-0.78502,-0.085017,0.014983 +0.0065933,-0.98711,-0.15185,0.050616,-0.68502,-0.085017,0.014983 +-0.092117,-0.98711,-0.15185,0.050616,-0.58502,-0.085017,0.014983 +-0.19083,-0.98717,-0.15153,0.050299,-0.48502,-0.085017,0.014983 +-0.28901,-0.96682,-0.25052,0.049938,-0.38502,-0.085017,0.014983 +-0.3857,-0.96709,-0.24965,0.04903,-0.28502,-0.085017,0.014983 +-0.35675,0.96687,-0.25053,0.049033,0.31498,-0.085017,0.014983 +-0.25998,0.98714,-0.15185,0.049983,0.41498,-0.085017,0.014983 +-0.16126,0.98714,-0.15185,0.049983,0.51498,-0.085017,0.014983 +-0.062549,0.98714,-0.15185,0.049983,0.61498,-0.085017,0.014983 +0.036167,0.9872,-0.15123,0.050617,0.71498,-0.085017,0.014983 +0.13498,0.99358,-0.10118,0.050693,0.81498,-0.085017,0.014983 +0.23448,0.99358,-0.10118,0.050693,0.91498,-0.085017,0.014983 +0.3342,0.9987,-0.050943,-0.0001194,1.015,-0.085017,0.014983 +0.30075,-1,3.6746e-07,-1.0692e-07,-0.98502,0.014983,0.014983 +0.20101,-0.99742,0.050758,0.050759,-0.88502,0.014983,0.014983 +0.10126,-0.99742,0.050758,0.050759,-0.78502,0.014983,0.014983 +0.001521,-0.99742,0.050758,0.050759,-0.68502,0.014983,0.014983 +-0.098221,-0.99742,0.050639,0.050878,-0.58502,0.014983,0.014983 +-0.19796,-0.99742,0.050639,0.050878,-0.48502,0.014983,0.014983 +-0.29771,-0.99742,0.050639,0.050878,-0.38502,0.014983,0.014983 +-0.39745,-0.99742,0.050639,0.050878,-0.28502,0.014983,0.014983 +-0.36755,0.99741,0.050878,0.050878,0.31498,0.014983,0.014983 +-0.26781,0.99741,0.050878,0.050878,0.41498,0.014983,0.014983 +-0.16807,0.99741,0.050878,0.050878,0.51498,0.014983,0.014983 +-0.068328,0.99741,0.050878,0.050878,0.61498,0.014983,0.014983 +0.031413,0.99741,0.050878,0.050878,0.71498,0.014983,0.014983 +0.13115,0.99741,0.050878,0.050878,0.81498,0.014983,0.014983 +0.23089,0.99741,0.050878,0.050878,0.91498,0.014983,0.014983 +0.33065,1,3.715e-07,-1.08e-07,1.015,0.014983,0.014983 +0.30728,-0.99483,0.10151,-0.00010898,-0.98502,0.11498,0.014983 +0.20856,-0.98714,0.15185,0.049982,-0.88502,0.11498,0.014983 +0.10985,-0.98714,0.15185,0.049982,-0.78502,0.11498,0.014983 +0.011134,-0.98714,0.15185,0.049982,-0.68502,0.11498,0.014983 +-0.08758,-0.98714,0.15185,0.049982,-0.58502,0.11498,0.014983 +-0.18484,-0.96705,0.24966,0.04994,-0.48502,0.11498,0.014983 +-0.28153,-0.96687,0.25053,0.049031,-0.38502,0.11498,0.014983 +-0.37583,-0.93717,0.34557,0.04793,-0.28502,0.11498,0.014983 +-0.34771,0.93712,0.34556,0.04897,0.31498,0.11498,0.014983 +-0.25253,0.96709,0.24965,0.04903,0.41498,0.11498,0.014983 +-0.15585,0.96682,0.25052,0.049938,0.51498,0.11498,0.014983 +-0.05799,0.98724,0.15122,0.049982,0.61498,0.11498,0.014983 +0.040723,0.98711,0.15184,0.050616,0.71498,0.11498,0.014983 +0.13943,0.98711,0.15184,0.050616,0.81498,0.11498,0.014983 +0.23814,0.98711,0.15184,0.050616,0.91498,0.11498,0.014983 +0.33691,0.99483,0.10151,0.00010856,1.015,0.11498,0.014983 +0.32368,-0.97949,0.20149,-0.00019176,-0.98502,0.21498,0.014983 +0.22696,-0.96687,0.25053,0.049031,-0.88502,0.21498,0.014983 +0.13027,-0.96687,0.25053,0.049031,-0.78502,0.21498,0.014983 +0.033639,-0.95333,0.29793,0.049062,-0.68502,0.21498,0.014983 +-0.060121,-0.93717,0.34557,0.04793,-0.58502,0.21498,0.014983 +-0.15311,-0.89917,0.43498,0.047863,-0.48502,0.21498,0.014983 +-0.24264,-0.85289,0.52,0.046751,-0.38502,0.21498,0.014983 +-0.32623,-0.79897,0.59967,0.045134,-0.28502,0.21498,0.014983 +-0.39965,-0.67237,0.73884,0.045106,-0.18502,0.21498,0.014983 +-0.3795,0.73901,0.6722,0.044859,0.21498,0.21498,0.014983 +-0.30227,0.79895,0.59965,0.045784,0.31498,0.21498,0.014983 +-0.21604,0.89922,0.43498,0.046813,0.41498,0.21498,0.014983 +-0.12574,0.93753,0.3446,0.047929,0.51498,0.21498,0.014983 +-0.032021,0.93712,0.34556,0.04897,0.61498,0.21498,0.014983 +0.062561,0.96709,0.24965,0.04903,0.71498,0.21498,0.014983 +0.15925,0.96682,0.25052,0.049938,0.81498,0.21498,0.014983 +0.25593,0.96682,0.25052,0.049938,0.91498,0.21498,0.014983 +0.35283,0.97949,0.20149,0.00019141,1.015,0.21498,0.014983 +0.34949,-0.9544,0.29852,-0.00024112,-0.98502,0.31498,0.014983 +0.25559,-0.93717,0.34557,0.04793,-0.88502,0.31498,0.014983 +0.16187,-0.93717,0.34557,0.04793,-0.78502,0.31498,0.014983 +0.070228,-0.89877,0.43591,0.046815,-0.68502,0.31498,0.014983 +-0.01965,-0.89877,0.43591,0.046815,-0.58502,0.31498,0.014983 +-0.10533,-0.85247,0.52077,0.045834,-0.48502,0.31498,0.014983 +-0.18637,-0.79897,0.59967,0.045134,-0.38502,0.31498,0.014983 +-0.25853,-0.67237,0.73884,0.045106,-0.28502,0.31498,0.014983 +-0.31793,-0.52075,0.85243,0.04675,-0.18502,0.31498,0.014983 +-0.35672,-0.24965,0.96709,0.049029,-0.085017,0.31498,0.014983 +-0.36756,0.050639,0.99742,0.050881,0.014983,0.31498,0.014983 +-0.34775,0.3446,0.93747,0.048972,0.11498,0.31498,0.014983 +-0.30228,0.59915,0.79932,0.045784,0.21498,0.31498,0.014983 +-0.23838,0.73901,0.6722,0.044859,0.31498,0.31498,0.014983 +-0.16241,0.79895,0.59965,0.045784,0.41498,0.31498,0.014983 +-0.079765,0.85243,0.52075,0.046749,0.51498,0.31498,0.014983 +0.0072983,0.89873,0.43589,0.04786,0.61498,0.31498,0.014983 +0.097171,0.89873,0.43589,0.04786,0.71498,0.31498,0.014983 +0.18996,0.93712,0.34556,0.04897,0.81498,0.31498,0.014983 +0.28367,0.93712,0.34556,0.04897,0.91498,0.31498,0.014983 +0.37802,0.9544,0.29852,0.00024107,1.015,0.31498,0.014983 +0.38415,-0.92022,0.39139,-0.00025736,-0.98502,0.41498,0.014983 +0.29357,-0.89877,0.43591,0.046815,-0.88502,0.41498,0.014983 +0.2037,-0.89877,0.43591,0.046815,-0.78502,0.41498,0.014983 +0.11724,-0.85247,0.52077,0.045834,-0.68502,0.41498,0.014983 +0.033393,-0.79932,0.59915,0.045784,-0.58502,0.41498,0.014983 +-0.045517,-0.739,0.6722,0.045106,-0.48502,0.41498,0.014983 +-0.11741,-0.67237,0.73884,0.045106,-0.38502,0.41498,0.014983 +-0.18038,-0.59965,0.79895,0.045782,-0.28502,0.41498,0.014983 +-0.2291,-0.43589,0.89873,0.047861,-0.18502,0.41498,0.014983 +-0.25997,-0.15122,0.98724,0.049979,-0.085017,0.41498,0.014983 +-0.26782,0.050639,0.99742,0.050881,0.014983,0.41498,0.014983 +-0.25256,0.25053,0.96687,0.049034,0.11498,0.41498,0.014983 +-0.21606,0.43591,0.89877,0.046815,0.21498,0.41498,0.014983 +-0.16243,0.59967,0.79897,0.045134,0.31498,0.41498,0.014983 +-0.097262,0.73901,0.6722,0.044859,0.41498,0.41498,0.014983 +-0.022557,0.79935,0.59916,0.045133,0.51498,0.41498,0.014983 +0.057545,0.8269,0.56048,0.045861,0.61498,0.41498,0.014983 +0.1428,0.85243,0.52075,0.046749,0.71498,0.41498,0.014983 +0.23063,0.89873,0.43589,0.04786,0.81498,0.41498,0.014983 +0.32051,0.89976,0.43639,0.00052278,0.91498,0.41498,0.014983 +0.33981,-0.85336,0.52131,-0.00045781,-0.88502,0.51498,0.014983 +0.25457,-0.85247,0.52077,0.045834,-0.78502,0.51498,0.014983 +0.17326,-0.79897,0.59967,0.045134,-0.68502,0.51498,0.014983 +0.095604,-0.73885,0.67238,0.04486,-0.58502,0.51498,0.014983 +0.023714,-0.67237,0.73884,0.045106,-0.48502,0.51498,0.014983 +-0.040521,-0.59965,0.79895,0.045782,-0.38502,0.51498,0.014983 +-0.09537,-0.52075,0.85243,0.04675,-0.28502,0.51498,0.014983 +-0.13609,-0.34556,0.93712,0.048967,-0.18502,0.51498,0.014983 +-0.16125,-0.15185,0.98711,0.050619,-0.085017,0.51498,0.014983 +-0.16807,0.050639,0.99742,0.050881,0.014983,0.51498,0.014983 +-0.15586,0.24966,0.96705,0.049937,0.11498,0.51498,0.014983 +-0.12575,0.34557,0.93717,0.047929,0.21498,0.51498,0.014983 +-0.079782,0.52077,0.85247,0.045834,0.31498,0.51498,0.014983 +-0.022563,0.59967,0.79897,0.045134,0.41498,0.51498,0.014983 +0.043908,0.70648,0.70631,0.044909,0.51498,0.51498,0.014983 +0.11775,0.76996,0.63649,0.045171,0.61498,0.51498,0.014983 +0.1972,0.79895,0.59965,0.045784,0.71498,0.51498,0.014983 +0.28011,0.85243,0.52075,0.046749,0.81498,0.51498,0.014983 +0.36539,0.87772,0.47918,0.00024063,0.91498,0.51498,0.014983 +0.39309,-0.82764,0.56126,-0.00019226,-0.88502,0.61498,0.014983 +0.31312,-0.79897,0.59967,0.045134,-0.78502,0.61498,0.014983 +0.23673,-0.73885,0.67238,0.04486,-0.68502,0.61498,0.014983 +0.16484,-0.67237,0.73884,0.045106,-0.58502,0.61498,0.014983 +0.099339,-0.59965,0.79895,0.045782,-0.48502,0.61498,0.014983 +0.041948,-0.52075,0.85243,0.04675,-0.38502,0.61498,0.014983 +-0.0057636,-0.43589,0.89873,0.047861,-0.28502,0.61498,0.014983 +-0.041629,-0.24965,0.96709,0.049029,-0.18502,0.61498,0.014983 +-0.062538,-0.15185,0.98711,0.050619,-0.085017,0.61498,0.014983 +-0.068332,0.050639,0.99742,0.050881,0.014983,0.61498,0.014983 +-0.057999,0.15185,0.98714,0.049984,0.11498,0.61498,0.014983 +-0.032038,0.34557,0.93717,0.047929,0.21498,0.61498,0.014983 +0.0072829,0.43591,0.89877,0.046815,0.31498,0.61498,0.014983 +0.057545,0.56059,0.82682,0.045861,0.41498,0.61498,0.014983 +0.11775,0.63664,0.76984,0.045171,0.51498,0.61498,0.014983 +0.18519,0.70648,0.70631,0.044909,0.61498,0.61498,0.014983 +0.25887,0.73884,0.67237,0.045106,0.71498,0.61498,0.014983 +0.33706,0.79979,0.60028,0.00032505,0.81498,0.61498,0.014983 +0.37785,-0.73959,0.67306,-0.00012282,-0.78502,0.71498,0.014983 +0.30596,-0.67237,0.73884,0.045106,-0.68502,0.71498,0.014983 +0.23928,-0.63649,0.76996,0.045171,-0.58502,0.71498,0.014983 +0.17945,-0.56048,0.8269,0.045861,-0.48502,0.71498,0.014983 +0.12769,-0.47843,0.87687,0.046837,-0.38502,0.71498,0.014983 +0.085892,-0.34556,0.93712,0.048967,-0.28502,0.71498,0.014983 +0.05506,-0.25052,0.96682,0.049939,-0.18502,0.71498,0.014983 +0.036173,-0.15185,0.98711,0.050619,-0.085017,0.71498,0.014983 +0.03141,0.050759,0.99742,0.05076,0.014983,0.71498,0.014983 +0.040715,0.15185,0.98714,0.049984,0.11498,0.71498,0.014983 +0.062556,0.25053,0.96687,0.049034,0.21498,0.71498,0.014983 +0.097166,0.43498,0.89917,0.047862,0.31498,0.71498,0.014983 +0.14279,0.52077,0.85247,0.045834,0.41498,0.71498,0.014983 +0.1972,0.59967,0.79897,0.045134,0.51498,0.71498,0.014983 +0.25887,0.67238,0.73885,0.044859,0.61498,0.71498,0.014983 +0.32647,0.70648,0.70631,0.044909,0.71498,0.71498,0.014983 +0.37997,-0.63729,0.77063,0.0001097,-0.68502,0.81498,0.014983 +0.31909,-0.59965,0.79895,0.045782,-0.58502,0.81498,0.014983 +0.26451,-0.52075,0.85243,0.04675,-0.48502,0.81498,0.014983 +0.21757,-0.43589,0.89873,0.047861,-0.38502,0.81498,0.014983 +0.1796,-0.34556,0.93712,0.048967,-0.28502,0.81498,0.014983 +0.15174,-0.25052,0.96682,0.049939,-0.18502,0.81498,0.014983 +0.13498,-0.10137,0.99356,0.050695,-0.085017,0.81498,0.014983 +0.13115,0.050759,0.99742,0.05076,0.014983,0.81498,0.014983 +0.13943,0.15185,0.98714,0.049984,0.11498,0.81498,0.014983 +0.15924,0.25053,0.96687,0.049034,0.21498,0.81498,0.014983 +0.18995,0.34557,0.93717,0.047929,0.31498,0.81498,0.014983 +0.23063,0.43591,0.89877,0.046815,0.41498,0.81498,0.014983 +0.28011,0.52077,0.85247,0.045834,0.51498,0.81498,0.014983 +0.33706,0.60028,0.79979,-0.00032545,0.61498,0.81498,0.014983 +0.35106,-0.47918,0.87772,0.00024077,-0.48502,0.91498,0.014983 +0.30806,-0.39072,0.91926,0.047955,-0.38502,0.91498,0.014983 +0.27374,-0.29798,0.95331,0.04906,-0.28502,0.91498,0.014983 +0.24894,-0.20113,0.97829,0.050023,-0.18502,0.91498,0.014983 +0.23448,-0.10137,0.99356,0.050695,-0.085017,0.91498,0.014983 +0.23089,0.050759,0.99742,0.05076,0.014983,0.91498,0.014983 +0.23814,0.15185,0.98714,0.049984,0.11498,0.91498,0.014983 +0.25593,0.25053,0.96687,0.049034,0.21498,0.91498,0.014983 +0.28367,0.34557,0.93717,0.047929,0.31498,0.91498,0.014983 +0.32051,0.43639,0.89976,-0.00052336,0.41498,0.91498,0.014983 +0.36539,0.47918,0.87772,-0.00024081,0.51498,0.91498,0.014983 +0.37018,-0.25083,0.96803,0.00045344,-0.28502,1.015,0.014983 +0.3475,-0.15204,0.98837,0.000318,-0.18502,1.015,0.014983 +0.3342,-0.050943,0.9987,0.00011847,-0.085017,1.015,0.014983 +0.33065,-1.1029e-07,1,-2.9334e-07,0.014983,1.015,0.014983 +0.33691,0.10151,0.99483,-0.00010994,0.11498,1.015,0.014983 +0.35283,0.20149,0.97949,-0.00019183,0.21498,1.015,0.014983 +0.37802,0.29852,0.9544,-0.0002403,0.31498,1.015,0.014983 +0.37958,-0.34441,-0.93387,0.096259,-0.38502,-0.98502,0.11498 +0.34747,-0.24966,-0.96332,0.098382,-0.28502,-0.98502,0.11498 +0.32434,-0.15131,-0.9834,0.10011,-0.18502,-0.98502,0.11498 +0.31082,-0.050693,-0.99358,0.10118,-0.085017,-0.98502,0.11498 +0.30728,0.00010899,-0.99483,0.10151,0.014983,-0.98502,0.11498 +0.31376,0.1011,-0.98973,0.1011,0.11498,-0.98502,0.11498 +0.33005,0.20058,-0.97458,0.099834,0.21498,-0.98502,0.11498 +0.3557,0.29716,-0.94979,0.09796,0.31498,-0.98502,0.11498 +0.39015,0.38964,-0.91598,0.095752,0.41498,-0.98502,0.11498 +0.38249,-0.55899,-0.82415,0.09116,-0.58502,-0.88502,0.11498 +0.3311,-0.47461,-0.86902,0.13984,-0.48502,-0.88502,0.11498 +0.28748,-0.38745,-0.9107,0.14319,-0.38502,-0.88502,0.11498 +0.25247,-0.29531,-0.9441,0.1465,-0.28502,-0.88502,0.11498 +0.22702,-0.19912,-0.96853,0.14933,-0.18502,-0.88502,0.11498 +0.21216,-0.10011,-0.9834,0.15131,-0.085017,-0.88502,0.11498 +0.20856,0.050616,-0.98711,0.15185,0.014983,-0.88502,0.11498 +0.21606,0.151,-0.97693,0.151,0.11498,-0.88502,0.11498 +0.2343,0.24902,-0.95698,0.14893,0.21498,-0.88502,0.11498 +0.2627,0.34337,-0.92778,0.14603,0.31498,-0.88502,0.11498 +0.30037,0.43299,-0.89003,0.1427,0.41498,-0.88502,0.11498 +0.34624,0.5171,-0.8445,0.13937,0.51498,-0.88502,0.11498 +0.39911,0.55888,-0.82419,0.091479,0.61498,-0.88502,0.11498 +0.36406,-0.66719,-0.73276,0.13386,-0.68502,-0.78502,0.11498 +0.30199,-0.59535,-0.79208,0.13477,-0.58502,-0.78502,0.11498 +0.24625,-0.51723,-0.84482,0.13696,-0.48502,-0.78502,0.11498 +0.19833,-0.4331,-0.89041,0.13996,-0.38502,-0.78502,0.11498 +0.15956,-0.34345,-0.92817,0.14333,-0.28502,-0.78502,0.11498 +0.13111,-0.24675,-0.95756,0.14896,-0.18502,-0.78502,0.11498 +0.11385,-0.10011,-0.9834,0.15131,-0.085017,-0.78502,0.11498 +0.10985,0.050616,-0.98711,0.15185,0.014983,-0.78502,0.11498 +0.11837,0.151,-0.97693,0.151,0.11498,-0.78502,0.11498 +0.1386,0.24675,-0.95793,0.14659,0.21498,-0.78502,0.11498 +0.16988,0.34088,-0.92912,0.14332,0.31498,-0.78502,0.11498 +0.21132,0.43063,-0.89161,0.13997,0.41498,-0.78502,0.11498 +0.26176,0.51518,-0.84607,0.13696,0.51498,-0.78502,0.11498 +0.31985,0.59523,-0.79188,0.13651,0.61498,-0.78502,0.11498 +0.38405,0.66714,-0.73269,0.13452,0.71498,-0.78502,0.11498 +0.36406,-0.73269,-0.66714,0.13452,-0.78502,-0.68502,0.11498 +0.29109,-0.70096,-0.7005,0.134,-0.68502,-0.68502,0.11498 +0.22407,-0.66666,-0.73312,0.13453,-0.58502,-0.68502,0.11498 +0.16329,-0.59388,-0.79289,0.13652,-0.48502,-0.68502,0.11498 +0.11013,-0.51509,-0.84572,0.1394,-0.38502,-0.68502,0.11498 +0.066742,-0.34345,-0.92817,0.14333,-0.28502,-0.68502,0.11498 +0.03535,-0.24675,-0.95756,0.14896,-0.18502,-0.68502,0.11498 +0.016126,-0.14935,-0.97718,0.15102,-0.085017,-0.68502,0.11498 +0.011144,0.050616,-0.98711,0.15185,0.014983,-0.68502,0.11498 +0.020644,0.14935,-0.97744,0.14935,0.11498,-0.68502,0.11498 +0.042859,0.29544,-0.94406,0.14649,0.21498,-0.68502,0.11498 +0.079067,0.43299,-0.89003,0.1427,0.31498,-0.68502,0.11498 +0.12563,0.5171,-0.8445,0.13937,0.41498,-0.68502,0.11498 +0.18114,0.59523,-0.79188,0.13651,0.51498,-0.68502,0.11498 +0.24407,0.66714,-0.73269,0.13452,0.61498,-0.68502,0.11498 +0.31274,0.73276,-0.6672,0.13386,0.71498,-0.68502,0.11498 +0.38614,0.76342,-0.63168,0.13479,0.81498,-0.68502,0.11498 +0.38249,-0.82419,-0.55888,0.091478,-0.88502,-0.58502,0.11498 +0.30201,-0.79188,-0.59523,0.1365,-0.78502,-0.58502,0.11498 +0.22408,-0.73269,-0.66714,0.13452,-0.68502,-0.58502,0.11498 +0.15095,-0.70096,-0.7005,0.134,-0.58502,-0.58502,0.11498 +0.084162,-0.63168,-0.76342,0.1348,-0.48502,-0.58502,0.11498 +0.025568,-0.51723,-0.84482,0.13696,-0.38502,-0.58502,0.11498 +-0.023002,-0.43057,-0.8912,0.14273,-0.28502,-0.58502,0.11498 +-0.060275,-0.34086,-0.9287,0.14606,-0.18502,-0.58502,0.11498 +-0.081592,-0.14935,-0.97718,0.15102,-0.085017,-0.58502,0.11498 +-0.087573,0.049981,-0.98724,0.15122,0.014983,-0.58502,0.11498 +-0.0771,0.14935,-0.97744,0.14935,0.11498,-0.58502,0.11498 +-0.050034,0.34088,-0.92912,0.14332,0.21498,-0.58502,0.11498 +-0.010068,0.43063,-0.89161,0.13997,0.31498,-0.58502,0.11498 +0.04243,0.59523,-0.79188,0.13651,0.41498,-0.58502,0.11498 +0.10409,0.66714,-0.73269,0.13452,0.51498,-0.58502,0.11498 +0.17274,0.73276,-0.6672,0.13386,0.61498,-0.58502,0.11498 +0.2466,0.76342,-0.63168,0.13479,0.71498,-0.58502,0.11498 +0.32573,0.79208,-0.59535,0.13477,0.81498,-0.58502,0.11498 +0.3311,-0.86911,-0.47444,0.13984,-0.88502,-0.48502,0.11498 +0.2463,-0.8445,-0.5171,0.13937,-0.78502,-0.48502,0.11498 +0.1633,-0.79188,-0.59523,0.1365,-0.68502,-0.48502,0.11498 +0.084162,-0.76376,-0.63127,0.1348,-0.58502,-0.48502,0.11498 +0.010802,-0.70096,-0.7005,0.134,-0.48502,-0.48502,0.11498 +-0.054527,-0.5866,-0.77876,0.22231,-0.38502,-0.48502,0.11498 +-0.10973,-0.50986,-0.83,0.22616,-0.28502,-0.48502,0.11498 +-0.15195,-0.33869,-0.91056,0.23698,-0.18502,-0.48502,0.11498 +-0.17791,-0.14896,-0.95756,0.24675,-0.085017,-0.48502,0.11498 +-0.18482,0.049938,-0.96682,0.25052,0.014983,-0.48502,0.11498 +-0.17202,0.24556,-0.93776,0.24556,0.11498,-0.48502,0.11498 +-0.14111,0.4268,-0.87323,0.23519,0.21498,-0.48502,0.11498 +-0.094414,0.50956,-0.82922,0.22964,0.31498,-0.48502,0.11498 +-0.035902,0.66671,-0.7332,0.13385,0.41498,-0.48502,0.11498 +0.032753,0.73312,-0.66666,0.13453,0.51498,-0.48502,0.11498 +0.10778,0.79208,-0.59535,0.13477,0.61498,-0.48502,0.11498 +0.18727,0.81973,-0.55615,0.13689,0.71498,-0.48502,0.11498 +0.27157,0.84482,-0.51723,0.13696,0.81498,-0.48502,0.11498 +0.35738,0.86902,-0.47461,0.13984,0.91498,-0.48502,0.11498 +0.37958,-0.93379,-0.34441,0.097095,-0.98502,-0.38502,0.11498 +0.28748,-0.91072,-0.38742,0.14319,-0.88502,-0.38502,0.11498 +0.19839,-0.89003,-0.43299,0.1427,-0.78502,-0.38502,0.11498 +0.11014,-0.8445,-0.5171,0.13937,-0.68502,-0.38502,0.11498 +0.02559,-0.84607,-0.51518,0.13696,-0.58502,-0.38502,0.11498 +-0.054516,-0.77825,-0.58632,0.22486,-0.48502,-0.38502,0.11498 +-0.12778,-0.72162,-0.6562,0.22059,-0.38502,-0.38502,0.11498 +-0.19104,-0.58428,-0.77976,0.22492,-0.28502,-0.38502,0.11498 +-0.24134,-0.42328,-0.87491,0.2353,-0.18502,-0.38502,0.11498 +-0.27322,-0.24234,-0.93858,0.24564,-0.085017,-0.38502,0.11498 +-0.28151,0.049031,-0.96709,0.24965,0.014983,-0.38502,0.11498 +-0.26589,0.24235,-0.93943,0.24235,0.11498,-0.38502,0.11498 +-0.22829,0.50956,-0.82922,0.22964,0.21498,-0.38502,0.11498 +-0.17346,0.58453,-0.78032,0.2223,0.31498,-0.38502,0.11498 +-0.10618,0.72094,-0.65695,0.2206,0.41498,-0.38502,0.11498 +-0.030916,0.79288,-0.59388,0.13652,0.51498,-0.38502,0.11498 +0.0509,0.84572,-0.51509,0.1394,0.61498,-0.38502,0.11498 +0.13598,0.86902,-0.47461,0.13984,0.71498,-0.38502,0.11498 +0.22501,0.89041,-0.4331,0.13997,0.81498,-0.38502,0.11498 +0.31471,0.9107,-0.38745,0.14319,0.91498,-0.38502,0.11498 +0.34747,-0.96325,-0.24965,0.099107,-0.98502,-0.28502,0.11498 +0.25247,-0.94406,-0.29544,0.14649,-0.88502,-0.28502,0.11498 +0.15963,-0.92778,-0.34337,0.14603,-0.78502,-0.28502,0.11498 +0.066751,-0.92912,-0.34088,0.14332,-0.68502,-0.28502,0.11498 +-0.022972,-0.89161,-0.43063,0.13997,-0.58502,-0.28502,0.11498 +-0.10968,-0.82922,-0.50956,0.22964,-0.48502,-0.28502,0.11498 +-0.19097,-0.77929,-0.58542,0.22358,-0.38502,-0.28502,0.11498 +-0.26518,-0.70476,-0.64125,0.30348,-0.28502,-0.28502,0.11498 +-0.32507,-0.49943,-0.80826,0.31192,-0.18502,-0.28502,0.11498 +-0.36488,-0.24084,-0.91094,0.33494,-0.085017,-0.28502,0.11498 +-0.3758,0.047927,-0.93753,0.3446,0.014983,-0.28502,0.11498 +-0.35549,0.32764,-0.88618,0.32764,0.11498,-0.28502,0.11498 +-0.30859,0.57365,-0.75843,0.30938,0.21498,-0.28502,0.11498 +-0.24395,0.72143,-0.65606,0.22162,0.31498,-0.28502,0.11498 +-0.16768,0.77976,-0.58428,0.22492,0.41498,-0.28502,0.11498 +-0.084858,0.83102,-0.50657,0.22975,0.51498,-0.28502,0.11498 +0.003704,0.8912,-0.43057,0.14273,0.61498,-0.28502,0.11498 +0.094556,0.92817,-0.34345,0.14333,0.71498,-0.28502,0.11498 +0.18738,0.9287,-0.34086,0.14606,0.81498,-0.28502,0.11498 +0.28066,0.9441,-0.2953,0.1465,0.91498,-0.28502,0.11498 +0.37621,0.96332,-0.24966,0.098382,1.015,-0.28502,0.11498 +0.32434,-0.98335,-0.15131,0.10062,-0.98502,-0.18502,0.11498 +0.22702,-0.96846,-0.19944,0.14933,-0.88502,-0.18502,0.11498 +0.13114,-0.95698,-0.24902,0.14893,-0.78502,-0.18502,0.11498 +0.03541,-0.95793,-0.24675,0.14659,-0.68502,-0.18502,0.11498 +-0.060264,-0.92778,-0.34337,0.14603,-0.58502,-0.18502,0.11498 +-0.15187,-0.90964,-0.33854,0.24073,-0.48502,-0.18502,0.11498 +-0.24126,-0.87589,-0.42342,0.23135,-0.38502,-0.18502,0.11498 +-0.32497,-0.81063,-0.49553,0.31198,-0.28502,-0.18502,0.11498 +-0.39837,-0.68343,-0.62275,0.38092,-0.18502,-0.18502,0.11498 +-0.37794,0.68289,-0.62235,0.38255,0.21498,-0.18502,0.11498 +-0.30085,0.80914,-0.49516,0.3164,0.31498,-0.18502,0.11498 +-0.21512,0.87491,-0.42328,0.2353,0.41498,-0.18502,0.11498 +-0.12466,0.91056,-0.33869,0.23698,0.51498,-0.18502,0.11498 +-0.0317,0.95733,-0.24907,0.14659,0.61498,-0.18502,0.11498 +0.064044,0.95756,-0.24675,0.14896,0.71498,-0.18502,0.11498 +0.1598,0.95756,-0.24675,0.14896,0.81498,-0.18502,0.11498 +0.25606,0.96853,-0.19913,0.14933,0.91498,-0.18502,0.11498 +0.35367,0.9834,-0.15131,0.10011,1.015,-0.18502,0.11498 +0.31082,-0.99356,-0.050695,0.10137,-0.98502,-0.085017,0.11498 +0.21216,-0.98335,-0.10062,0.15131,-0.88502,-0.085017,0.11498 +0.11385,-0.98335,-0.10062,0.15131,-0.78502,-0.085017,0.11498 +0.01615,-0.97693,-0.151,0.151,-0.68502,-0.085017,0.11498 +-0.081575,-0.97744,-0.14935,0.14935,-0.58502,-0.085017,0.11498 +-0.17785,-0.95698,-0.14894,0.24902,-0.48502,-0.085017,0.11498 +-0.27316,-0.93776,-0.24556,0.24556,-0.38502,-0.085017,0.11498 +-0.36479,-0.91192,-0.23701,0.33501,-0.28502,-0.085017,0.11498 +-0.33758,0.91094,-0.24084,0.33494,0.31498,-0.085017,0.11498 +-0.24497,0.95756,-0.14896,0.24675,0.41498,-0.085017,0.11498 +-0.14921,0.95756,-0.14896,0.24675,0.51498,-0.085017,0.11498 +-0.05231,0.97718,-0.14935,0.15102,0.61498,-0.085017,0.11498 +0.045409,0.97718,-0.14935,0.15102,0.71498,-0.085017,0.11498 +0.14323,0.9834,-0.10011,0.15131,0.81498,-0.085017,0.11498 +0.24171,0.9834,-0.10011,0.15131,0.91498,-0.085017,0.11498 +0.34046,0.99358,-0.050692,0.10118,1.015,-0.085017,0.11498 +0.30728,-0.99483,-0.00010936,0.10151,-0.98502,0.014983,0.11498 +0.20856,-0.98714,0.049984,0.15185,-0.88502,0.014983,0.11498 +0.10985,-0.98714,0.049984,0.15185,-0.78502,0.014983,0.11498 +0.011134,-0.98714,0.049984,0.15185,-0.68502,0.014983,0.11498 +-0.08758,-0.98714,0.049984,0.15185,-0.58502,0.014983,0.11498 +-0.18484,-0.96705,0.049937,0.24966,-0.48502,0.014983,0.11498 +-0.28153,-0.96687,0.049033,0.25053,-0.38502,0.014983,0.11498 +-0.37583,-0.93717,0.047929,0.34557,-0.28502,0.014983,0.11498 +-0.34771,0.93712,0.048969,0.34556,0.31498,0.014983,0.11498 +-0.25253,0.96709,0.049029,0.24965,0.41498,0.014983,0.11498 +-0.15585,0.96682,0.049939,0.25052,0.51498,0.014983,0.11498 +-0.05799,0.98724,0.049979,0.15122,0.61498,0.014983,0.11498 +0.040723,0.98711,0.050619,0.15185,0.71498,0.014983,0.11498 +0.13943,0.98711,0.050619,0.15185,0.81498,0.014983,0.11498 +0.23814,0.98711,0.050619,0.15185,0.91498,0.014983,0.11498 +0.33691,0.99483,0.0001096,0.10151,1.015,0.014983,0.11498 +0.31376,-0.98976,0.10092,0.10092,-0.98502,0.11498,0.11498 +0.21604,-0.97718,0.15019,0.15019,-0.88502,0.11498,0.11498 +0.11832,-0.97718,0.15019,0.15019,-0.78502,0.11498,0.11498 +0.020602,-0.97718,0.15019,0.15019,-0.68502,0.11498,0.11498 +-0.077117,-0.97718,0.14935,0.15102,-0.58502,0.11498,0.11498 +-0.1721,-0.93858,0.24564,0.24234,-0.48502,0.11498,0.11498 +-0.26596,-0.93858,0.24564,0.24234,-0.38502,0.11498,0.11498 +-0.35561,-0.88458,0.33203,0.32754,-0.28502,0.11498,0.11498 +-0.32897,0.88306,0.33181,0.33181,0.31498,0.11498,0.11498 +-0.23774,0.93943,0.24235,0.24235,0.41498,0.11498,0.11498 +-0.14392,0.93776,0.24556,0.24556,0.51498,0.11498,0.11498 +-0.04781,0.97744,0.14935,0.14935,0.61498,0.11498,0.11498 +0.049934,0.97744,0.14935,0.14935,0.71498,0.11498,0.11498 +0.14764,0.97693,0.151,0.151,0.81498,0.11498,0.11498 +0.24534,0.97693,0.151,0.151,0.91498,0.11498,0.11498 +0.34315,0.98973,0.1011,0.1011,1.015,0.11498,0.11498 +0.33005,-0.97463,0.20046,0.099522,-0.98502,0.21498,0.11498 +0.23427,-0.95733,0.24907,0.14659,-0.88502,0.21498,0.11498 +0.13854,-0.95733,0.24907,0.14659,-0.78502,0.21498,0.11498 +0.042859,-0.9441,0.29531,0.1465,-0.68502,0.21498,0.11498 +-0.050061,-0.9287,0.34086,0.14606,-0.58502,0.21498,0.11498 +-0.14116,-0.87491,0.42328,0.2353,-0.48502,0.21498,0.11498 +-0.22834,-0.83102,0.50657,0.22975,-0.38502,0.21498,0.11498 +-0.30868,-0.75936,0.57414,0.30617,-0.28502,0.21498,0.11498 +-0.37791,-0.62358,0.6818,0.38248,-0.18502,0.21498,0.11498 +-0.35923,0.68343,0.62275,0.38092,0.21498,0.21498,0.11498 +-0.28583,0.81063,0.49553,0.31198,0.31498,0.21498,0.11498 +-0.20232,0.87589,0.42342,0.23135,0.41498,0.21498,0.11498 +-0.11447,0.91192,0.33501,0.23701,0.51498,0.21498,0.11498 +-0.022192,0.92912,0.34088,0.14332,0.61498,0.21498,0.11498 +0.071509,0.95793,0.24675,0.14659,0.71498,0.21498,0.11498 +0.16728,0.95698,0.24902,0.14893,0.81498,0.21498,0.11498 +0.26298,0.95698,0.24902,0.14893,0.91498,0.21498,0.11498 +0.35897,0.97458,0.20058,0.099833,1.015,0.21498,0.11498 +0.3557,-0.94985,0.29711,0.097571,-0.98502,0.31498,0.11498 +0.26267,-0.92817,0.34345,0.14333,-0.88502,0.31498,0.11498 +0.16985,-0.92817,0.34345,0.14333,-0.78502,0.31498,0.11498 +0.079021,-0.8912,0.43057,0.14273,-0.68502,0.31498,0.11498 +-0.010082,-0.89041,0.4331,0.13997,-0.58502,0.31498,0.11498 +-0.094455,-0.83,0.50986,0.22616,-0.48502,0.31498,0.11498 +-0.17349,-0.77876,0.5866,0.22231,-0.38502,0.31498,0.11498 +-0.24394,-0.6562,0.72162,0.22059,-0.28502,0.31498,0.11498 +-0.30075,-0.49895,0.80689,0.31618,-0.18502,0.31498,0.11498 +-0.33746,-0.23887,0.91078,0.33677,-0.085017,0.31498,0.11498 +-0.34775,0.048974,0.93747,0.3446,0.014983,0.31498,0.11498 +-0.3291,0.32754,0.88458,0.33203,0.11498,0.31498,0.11498 +-0.28589,0.49943,0.80826,0.31192,0.21498,0.31498,0.11498 +-0.22427,0.72162,0.6562,0.22059,0.31498,0.31498,0.11498 +-0.15008,0.77825,0.58632,0.22486,0.41498,0.31498,0.11498 +-0.069566,0.82923,0.50956,0.22964,0.51498,0.31498,0.11498 +0.01665,0.89161,0.43063,0.13997,0.61498,0.31498,0.11498 +0.10574,0.89003,0.43298,0.1427,0.71498,0.31498,0.11498 +0.19772,0.92912,0.34088,0.14332,0.81498,0.31498,0.11498 +0.2905,0.92778,0.34337,0.14603,0.91498,0.31498,0.11498 +0.38402,0.94979,0.29716,0.09796,1.015,0.31498,0.11498 +0.39015,-0.91602,0.38965,0.095335,-0.98502,0.41498,0.11498 +0.30035,-0.89041,0.4331,0.13997,-0.88502,0.41498,0.11498 +0.21131,-0.89041,0.4331,0.13997,-0.78502,0.41498,0.11498 +0.12556,-0.84572,0.51509,0.1394,-0.68502,0.41498,0.11498 +0.042409,-0.79288,0.59388,0.13652,-0.58502,0.41498,0.11498 +-0.035904,-0.73313,0.66666,0.13453,-0.48502,0.41498,0.11498 +-0.10617,-0.6568,0.72076,0.22161,-0.38502,0.41498,0.11498 +-0.16765,-0.58632,0.77825,0.22486,-0.28502,0.41498,0.11498 +-0.21506,-0.4268,0.87323,0.23519,-0.18502,0.41498,0.11498 +-0.24494,-0.14659,0.95793,0.24675,-0.085017,0.41498,0.11498 +-0.25256,0.049033,0.96687,0.25053,0.014983,0.41498,0.11498 +-0.23783,0.24234,0.93858,0.24564,0.11498,0.41498,0.11498 +-0.2024,0.42703,0.87414,0.23133,0.21498,0.41498,0.11498 +-0.15015,0.5866,0.77876,0.22231,0.31498,0.41498,0.11498 +-0.086492,0.72162,0.6562,0.22059,0.41498,0.41498,0.11498 +-0.013109,0.79311,0.59398,0.13476,0.51498,0.41498,0.11498 +0.066388,0.81993,0.55585,0.13689,0.61498,0.41498,0.11498 +0.15094,0.8445,0.5171,0.13937,0.71498,0.41498,0.11498 +0.23804,0.89161,0.43063,0.13997,0.81498,0.41498,0.11498 +0.32704,0.89003,0.43298,0.1427,0.91498,0.41498,0.11498 +0.34624,-0.84482,0.51723,0.13696,-0.88502,0.51498,0.11498 +0.26175,-0.84482,0.51723,0.13696,-0.78502,0.51498,0.11498 +0.18109,-0.79208,0.59535,0.13477,-0.68502,0.51498,0.11498 +0.10407,-0.73313,0.66666,0.13453,-0.58502,0.51498,0.11498 +0.032761,-0.66671,0.7332,0.13385,-0.48502,0.51498,0.11498 +-0.030908,-0.59398,0.79311,0.13477,-0.38502,0.51498,0.11498 +-0.084835,-0.50956,0.82922,0.22965,-0.28502,0.51498,0.11498 +-0.12461,-0.33854,0.90964,0.24073,-0.18502,0.51498,0.11498 +-0.14918,-0.14893,0.95698,0.24902,-0.085017,0.51498,0.11498 +-0.15586,0.04994,0.96705,0.24966,0.014983,0.51498,0.11498 +-0.14397,0.24234,0.93858,0.24564,0.11498,0.51498,0.11498 +-0.11451,0.33869,0.91056,0.23698,0.21498,0.51498,0.11498 +-0.069584,0.50986,0.83,0.22616,0.31498,0.51498,0.11498 +-0.01312,0.59388,0.79289,0.13652,0.41498,0.51498,0.11498 +0.052798,0.70096,0.7005,0.134,0.51498,0.51498,0.11498 +0.12605,0.76376,0.63127,0.1348,0.61498,0.51498,0.11498 +0.20487,0.79188,0.59523,0.13651,0.71498,0.51498,0.11498 +0.2871,0.8445,0.5171,0.13937,0.81498,0.51498,0.11498 +0.37159,0.87387,0.47709,0.093493,0.91498,0.51498,0.11498 +0.39911,-0.82415,0.55899,0.091161,-0.88502,0.61498,0.11498 +0.31983,-0.79208,0.59535,0.13477,-0.78502,0.61498,0.11498 +0.24405,-0.73276,0.6672,0.13386,-0.68502,0.61498,0.11498 +0.17275,-0.66671,0.7332,0.13385,-0.58502,0.61498,0.11498 +0.1078,-0.59398,0.79311,0.13477,-0.48502,0.61498,0.11498 +0.050944,-0.51518,0.84607,0.13696,-0.38502,0.61498,0.11498 +0.0037461,-0.43063,0.89161,0.13997,-0.28502,0.61498,0.11498 +-0.031678,-0.24675,0.95793,0.14659,-0.18502,0.61498,0.11498 +-0.052285,-0.14935,0.97744,0.14935,-0.085017,0.61498,0.11498 +-0.057999,0.049982,0.98714,0.15185,0.014983,0.61498,0.11498 +-0.047834,0.14935,0.97718,0.15102,0.11498,0.61498,0.11498 +-0.022231,0.34086,0.9287,0.14606,0.21498,0.61498,0.11498 +0.016606,0.43057,0.8912,0.14273,0.31498,0.61498,0.11498 +0.066388,0.55615,0.81973,0.13689,0.41498,0.61498,0.11498 +0.12605,0.63168,0.76342,0.1348,0.51498,0.61498,0.11498 +0.19294,0.70096,0.7005,0.134,0.61498,0.61498,0.11498 +0.26602,0.73269,0.66714,0.13452,0.71498,0.61498,0.11498 +0.34358,0.79188,0.59523,0.13651,0.81498,0.61498,0.11498 +0.38405,-0.73276,0.6672,0.13386,-0.78502,0.71498,0.11498 +0.31274,-0.66671,0.7332,0.13385,-0.68502,0.71498,0.11498 +0.2466,-0.63127,0.76376,0.1348,-0.58502,0.71498,0.11498 +0.18727,-0.55585,0.81993,0.13689,-0.48502,0.71498,0.11498 +0.13598,-0.47444,0.86911,0.13984,-0.38502,0.71498,0.11498 +0.094593,-0.34088,0.92912,0.14332,-0.28502,0.71498,0.11498 +0.064115,-0.24675,0.95793,0.14659,-0.18502,0.71498,0.11498 +0.045424,-0.151,0.97693,0.151,-0.085017,0.71498,0.11498 +0.040715,0.049982,0.98714,0.15185,0.014983,0.71498,0.11498 +0.049884,0.15019,0.97718,0.15019,0.11498,0.71498,0.11498 +0.071496,0.24907,0.95733,0.14659,0.21498,0.71498,0.11498 +0.10573,0.43057,0.8912,0.14273,0.31498,0.71498,0.11498 +0.15091,0.51509,0.84572,0.1394,0.41498,0.71498,0.11498 +0.20485,0.59388,0.79289,0.13652,0.51498,0.71498,0.11498 +0.26602,0.66666,0.73312,0.13453,0.61498,0.71498,0.11498 +0.33309,0.70096,0.7005,0.134,0.71498,0.71498,0.11498 +0.38614,-0.63127,0.76376,0.1348,-0.68502,0.81498,0.11498 +0.32574,-0.59523,0.79188,0.1365,-0.58502,0.81498,0.11498 +0.2716,-0.5171,0.8445,0.13937,-0.48502,0.81498,0.11498 +0.22506,-0.43299,0.89003,0.1427,-0.38502,0.81498,0.11498 +0.18743,-0.34337,0.92778,0.14603,-0.28502,0.81498,0.11498 +0.15982,-0.24902,0.95698,0.14893,-0.18502,0.81498,0.11498 +0.14323,-0.10062,0.98335,0.15131,-0.085017,0.81498,0.11498 +0.13943,0.049982,0.98714,0.15185,0.014983,0.81498,0.11498 +0.1476,0.15019,0.97718,0.15019,0.11498,0.81498,0.11498 +0.16723,0.24907,0.95733,0.14659,0.21498,0.81498,0.11498 +0.19766,0.34345,0.92817,0.14333,0.31498,0.81498,0.11498 +0.23799,0.4331,0.89041,0.13996,0.41498,0.81498,0.11498 +0.28707,0.51723,0.84482,0.13696,0.51498,0.81498,0.11498 +0.34357,0.59535,0.79208,0.13477,0.61498,0.81498,0.11498 +0.35738,-0.47444,0.86911,0.13984,-0.48502,0.91498,0.11498 +0.31471,-0.38742,0.91072,0.14319,-0.38502,0.91498,0.11498 +0.28066,-0.29544,0.94406,0.1465,-0.28502,0.91498,0.11498 +0.25606,-0.19944,0.96846,0.14933,-0.18502,0.91498,0.11498 +0.24171,-0.10062,0.98335,0.15131,-0.085017,0.91498,0.11498 +0.23814,0.049982,0.98714,0.15185,0.014983,0.91498,0.11498 +0.24532,0.15019,0.97718,0.15019,0.11498,0.91498,0.11498 +0.26296,0.24907,0.95733,0.14659,0.21498,0.91498,0.11498 +0.29048,0.34345,0.92817,0.14333,0.31498,0.91498,0.11498 +0.32703,0.4331,0.89041,0.13996,0.41498,0.91498,0.11498 +0.37159,0.47715,0.87387,0.093098,0.51498,0.91498,0.11498 +0.37621,-0.24965,0.96325,0.099107,-0.28502,1.015,0.11498 +0.35367,-0.15131,0.98335,0.10062,-0.18502,1.015,0.11498 +0.34046,-0.050693,0.99356,0.10137,-0.085017,1.015,0.11498 +0.33691,-0.00010899,0.99483,0.10151,0.014983,1.015,0.11498 +0.34315,0.10092,0.98976,0.10092,0.11498,1.015,0.11498 +0.35897,0.20046,0.97463,0.099522,0.21498,1.015,0.11498 +0.38402,0.29711,0.94985,0.09757,0.31498,1.015,0.11498 +0.39489,-0.34014,-0.92062,0.19173,-0.38502,-0.98502,0.21498 +0.36326,-0.24648,-0.94915,0.19587,-0.28502,-0.98502,0.21498 +0.34048,-0.14933,-0.96853,0.19912,-0.18502,-0.98502,0.21498 +0.32717,-0.099522,-0.97463,0.20047,-0.085017,-0.98502,0.21498 +0.32368,0.0001916,-0.97949,0.20149,0.014983,-0.98502,0.21498 +0.33005,0.099833,-0.97458,0.20058,0.11498,-0.98502,0.21498 +0.34608,0.19802,-0.95999,0.19802,0.21498,-0.98502,0.21498 +0.37135,0.29341,-0.93604,0.19428,0.31498,-0.98502,0.21498 +0.39786,-0.54762,-0.80569,0.22577,-0.58502,-0.88502,0.21498 +0.34728,-0.46728,-0.85346,0.23077,-0.48502,-0.88502,0.21498 +0.3044,-0.38139,-0.89368,0.23639,-0.38502,-0.88502,0.21498 +0.27001,-0.29061,-0.92577,0.24185,-0.28502,-0.88502,0.21498 +0.24506,-0.19587,-0.94915,0.24648,-0.18502,-0.88502,0.21498 +0.2305,-0.098382,-0.96332,0.24966,-0.085017,-0.88502,0.21498 +0.22696,0.049938,-0.96682,0.25052,0.014983,-0.88502,0.21498 +0.2343,0.14893,-0.95698,0.24902,0.11498,-0.88502,0.21498 +0.25219,0.24556,-0.93776,0.24556,0.21498,-0.88502,0.21498 +0.28006,0.33854,-0.90964,0.24073,0.31498,-0.88502,0.21498 +0.31706,0.4268,-0.87323,0.23519,0.41498,-0.88502,0.21498 +0.36215,0.50956,-0.82922,0.22964,0.51498,-0.88502,0.21498 +0.37973,-0.65695,-0.72094,0.2206,-0.68502,-0.78502,0.21498 +0.31865,-0.5866,-0.77876,0.22231,-0.58502,-0.78502,0.21498 +0.26385,-0.50986,-0.83,0.22616,-0.48502,-0.78502,0.21498 +0.21681,-0.42328,-0.87491,0.2353,-0.38502,-0.78502,0.21498 +0.17884,-0.33494,-0.91094,0.24084,-0.28502,-0.78502,0.21498 +0.15101,-0.24234,-0.93858,0.24564,-0.18502,-0.78502,0.21498 +0.13417,-0.098382,-0.96332,0.24966,-0.085017,-0.78502,0.21498 +0.13028,0.049938,-0.96682,0.25052,0.014983,-0.78502,0.21498 +0.1386,0.14659,-0.95793,0.24675,0.11498,-0.78502,0.21498 +0.15835,0.24235,-0.93943,0.24235,0.21498,-0.78502,0.21498 +0.18898,0.33501,-0.91192,0.23701,0.31498,-0.78502,0.21498 +0.22961,0.42342,-0.87589,0.23135,0.41498,-0.78502,0.21498 +0.27914,0.5068,-0.83187,0.22617,0.51498,-0.78502,0.21498 +0.33626,0.58453,-0.78032,0.2223,0.61498,-0.78502,0.21498 +0.39942,0.6568,-0.72076,0.22161,0.71498,-0.78502,0.21498 +0.37974,-0.72076,-0.6568,0.2216,-0.78502,-0.68502,0.21498 +0.30796,-0.69001,-0.68929,0.22083,-0.68502,-0.68502,0.21498 +0.24198,-0.65606,-0.72143,0.22162,-0.58502,-0.68502,0.21498 +0.18223,-0.58428,-0.77976,0.22492,-0.48502,-0.68502,0.21498 +0.13008,-0.50657,-0.83102,0.22975,-0.38502,-0.68502,0.21498 +0.087752,-0.33383,-0.89868,0.28448,-0.28502,-0.68502,0.21498 +0.057184,-0.24185,-0.92577,0.29061,-0.18502,-0.68502,0.21498 +0.038469,-0.1465,-0.9441,0.29531,-0.085017,-0.68502,0.21498 +0.033639,0.049063,-0.95331,0.29798,0.014983,-0.68502,0.21498 +0.042859,0.14649,-0.94406,0.29544,0.11498,-0.68502,0.21498 +0.064464,0.28791,-0.91335,0.28791,0.21498,-0.68502,0.21498 +0.099678,0.42342,-0.87589,0.23135,0.31498,-0.68502,0.21498 +0.14527,0.5068,-0.83187,0.22617,0.41498,-0.68502,0.21498 +0.19978,0.58453,-0.78032,0.2223,0.51498,-0.68502,0.21498 +0.26167,0.6568,-0.72076,0.22161,0.61498,-0.68502,0.21498 +0.32924,0.72094,-0.65695,0.2206,0.71498,-0.68502,0.21498 +0.39786,-0.80598,-0.54719,0.22578,-0.88502,-0.58502,0.21498 +0.31871,-0.77825,-0.58632,0.22486,-0.78502,-0.58502,0.21498 +0.24199,-0.72076,-0.6568,0.2216,-0.68502,-0.58502,0.21498 +0.17003,-0.69001,-0.68929,0.22083,-0.58502,-0.58502,0.21498 +0.10487,-0.60814,-0.73257,0.30579,-0.48502,-0.58502,0.21498 +0.048482,-0.49943,-0.80826,0.31192,-0.38502,-0.58502,0.21498 +0.0016842,-0.41853,-0.85016,0.31947,-0.28502,-0.58502,0.21498 +-0.034018,-0.24084,-0.91094,0.33494,-0.18502,-0.58502,0.21498 +-0.054423,-0.14333,-0.92817,0.34345,-0.085017,-0.58502,0.21498 +-0.060103,0.048971,-0.93712,0.34555,0.014983,-0.58502,0.21498 +-0.050034,0.14333,-0.92912,0.34088,0.11498,-0.58502,0.21498 +-0.024149,0.33181,-0.88306,0.33181,0.21498,-0.58502,0.21498 +0.014256,0.41405,-0.85231,0.31957,0.31498,-0.58502,0.21498 +0.064608,0.57365,-0.75843,0.30938,0.41498,-0.58502,0.21498 +0.12407,0.64971,-0.71326,0.26294,0.51498,-0.58502,0.21498 +0.19146,0.72143,-0.65606,0.22162,0.61498,-0.58502,0.21498 +0.26419,0.75086,-0.62196,0.22219,0.71498,-0.58502,0.21498 +0.342,0.77976,-0.58428,0.22492,0.81498,-0.58502,0.21498 +0.34728,-0.85358,-0.46705,0.23078,-0.88502,-0.48502,0.21498 +0.26395,-0.83187,-0.5068,0.22617,-0.78502,-0.48502,0.21498 +0.18225,-0.77825,-0.58632,0.22486,-0.68502,-0.48502,0.21498 +0.10487,-0.73323,-0.60734,0.3058,-0.58502,-0.48502,0.21498 +0.034406,-0.67416,-0.67321,0.30379,-0.48502,-0.48502,0.21498 +-0.028572,-0.57414,-0.75936,0.30617,-0.38502,-0.48502,0.21498 +-0.082111,-0.49516,-0.80914,0.3164,-0.28502,-0.48502,0.21498 +-0.1221,-0.32429,-0.85064,0.41383,-0.18502,-0.48502,0.21498 +-0.14655,-0.14273,-0.8912,0.43057,-0.085017,-0.48502,0.21498 +-0.15309,0.047859,-0.89873,0.43589,0.014983,-0.48502,0.21498 +-0.14111,0.23519,-0.87323,0.4268,0.11498,-0.48502,0.21498 +-0.11201,0.40806,-0.81668,0.40806,0.21498,-0.48502,0.21498 +-0.06724,0.49553,-0.81063,0.31198,0.31498,-0.48502,0.21498 +-0.010553,0.64198,-0.70353,0.30479,0.41498,-0.48502,0.21498 +0.055465,0.70386,-0.64224,0.3035,0.51498,-0.48502,0.21498 +0.1277,0.77024,-0.57973,0.26579,0.61498,-0.48502,0.21498 +0.20587,0.80569,-0.54762,0.22577,0.71498,-0.48502,0.21498 +0.28874,0.83102,-0.50657,0.22975,0.81498,-0.48502,0.21498 +0.37312,0.85346,-0.46728,0.23077,0.91498,-0.48502,0.21498 +0.39489,-0.92051,-0.34013,0.19227,-0.98502,-0.38502,0.21498 +0.3044,-0.89368,-0.38138,0.23639,-0.88502,-0.38502,0.21498 +0.21692,-0.87589,-0.42342,0.23135,-0.78502,-0.38502,0.21498 +0.13008,-0.82922,-0.50956,0.22964,-0.68502,-0.38502,0.21498 +0.048526,-0.81063,-0.49553,0.31198,-0.58502,-0.38502,0.21498 +-0.028521,-0.76139,-0.57144,0.30618,-0.48502,-0.38502,0.21498 +-0.099038,-0.68343,-0.62275,0.38092,-0.38502,-0.38502,0.21498 +-0.15896,-0.55501,-0.73537,0.38883,-0.28502,-0.38502,0.21498 +-0.20602,-0.39806,-0.78062,0.48186,-0.18502,-0.38502,0.21498 +-0.23522,-0.22616,-0.83,0.50986,-0.085017,-0.38502,0.21498 +-0.24263,0.046749,-0.85243,0.52074,0.014983,-0.38502,0.21498 +-0.22829,0.22965,-0.82922,0.50956,0.11498,-0.38502,0.21498 +-0.19389,0.40343,-0.82127,0.40343,0.21498,-0.38502,0.21498 +-0.14224,0.55563,-0.73695,0.38495,0.31498,-0.38502,0.21498 +-0.078599,0.6823,-0.62397,0.38095,0.41498,-0.38502,0.21498 +-0.0057884,0.76037,-0.57099,0.30951,0.51498,-0.38502,0.21498 +0.072703,0.80826,-0.49943,0.31192,0.61498,-0.38502,0.21498 +0.15558,0.85346,-0.46728,0.23077,0.71498,-0.38502,0.21498 +0.24303,0.87491,-0.42328,0.2353,0.81498,-0.38502,0.21498 +0.33115,0.89368,-0.38139,0.23639,0.91498,-0.38502,0.21498 +0.36326,-0.94906,-0.24647,0.19632,-0.98502,-0.28502,0.21498 +0.27001,-0.92571,-0.29081,0.24185,-0.88502,-0.28502,0.21498 +0.17894,-0.91192,-0.33501,0.23701,-0.78502,-0.28502,0.21498 +0.087752,-0.8986,-0.33382,0.28476,-0.68502,-0.28502,0.21498 +0.0018043,-0.84861,-0.41817,0.32404,-0.58502,-0.28502,0.21498 +-0.082089,-0.81063,-0.49553,0.31198,-0.48502,-0.28502,0.21498 +-0.15889,-0.73695,-0.55563,0.38494,-0.38502,-0.28502,0.21498 +-0.22765,-0.65878,-0.60207,0.45114,-0.28502,-0.28502,0.21498 +-0.28192,-0.46142,-0.70546,0.53797,-0.18502,-0.28502,0.21498 +-0.31668,-0.22492,-0.77976,0.58428,-0.085017,-0.28502,0.21498 +-0.32621,0.045784,-0.79895,0.59965,0.014983,-0.28502,0.21498 +-0.30859,0.30937,-0.75843,0.57365,0.11498,-0.28502,0.21498 +-0.26742,0.5257,-0.66879,0.5257,0.21498,-0.28502,0.21498 +-0.20796,0.65799,-0.60154,0.453,0.31498,-0.28502,0.21498 +-0.13684,0.78008,-0.48691,0.39294,0.41498,-0.28502,0.21498 +-0.057856,0.85016,-0.41853,0.31947,0.51498,-0.28502,0.21498 +0.02716,0.85016,-0.41853,0.31947,0.61498,-0.28502,0.21498 +0.11505,0.91094,-0.33494,0.24084,0.71498,-0.28502,0.21498 +0.20614,0.91094,-0.33494,0.24084,0.81498,-0.28502,0.21498 +0.29768,0.92577,-0.29061,0.24185,0.91498,-0.28502,0.21498 +0.39157,0.94915,-0.24648,0.19587,1.015,-0.28502,0.21498 +0.34048,-0.96846,-0.14933,0.19944,-0.98502,-0.18502,0.21498 +0.24506,-0.94906,-0.19632,0.24647,-0.88502,-0.18502,0.21498 +0.15106,-0.93776,-0.24556,0.24556,-0.78502,-0.18502,0.21498 +0.057184,-0.92571,-0.24185,0.29081,-0.68502,-0.18502,0.21498 +-0.034008,-0.91192,-0.23701,0.33501,-0.58502,-0.18502,0.21498 +-0.12205,-0.84861,-0.32404,0.41817,-0.48502,-0.18502,0.21498 +-0.20598,-0.77808,-0.39765,0.48628,-0.38502,-0.18502,0.21498 +-0.28182,-0.70311,-0.46096,0.54144,-0.28502,-0.18502,0.21498 +-0.3459,-0.52233,-0.52644,0.67085,-0.18502,-0.18502,0.21498 +-0.38781,-0.30483,-0.64099,0.70442,-0.085017,-0.18502,0.21498 +-0.39965,0.045107,-0.67237,0.73884,0.014983,-0.18502,0.21498 +-0.37791,0.38248,-0.62358,0.6818,0.11498,-0.18502,0.21498 +-0.32857,0.58002,-0.51036,0.63491,0.21498,-0.18502,0.21498 +-0.26051,0.74584,-0.46849,0.47353,0.31498,-0.18502,0.21498 +-0.18149,0.81889,-0.40318,0.4085,0.41498,-0.18502,0.21498 +-0.096046,0.88458,-0.32753,0.33203,0.51498,-0.18502,0.21498 +-0.0067205,0.91094,-0.24084,0.33494,0.61498,-0.18502,0.21498 +0.085279,0.93858,-0.24234,0.24564,0.71498,-0.18502,0.21498 +0.17914,0.93858,-0.24234,0.24564,0.81498,-0.18502,0.21498 +0.27353,0.94915,-0.19587,0.24648,0.91498,-0.18502,0.21498 +0.36935,0.96853,-0.14934,0.19912,1.015,-0.18502,0.21498 +0.32717,-0.97458,-0.099833,0.20058,-0.98502,-0.085017,0.21498 +0.2305,-0.96325,-0.099107,0.24965,-0.88502,-0.085017,0.21498 +0.13417,-0.96325,-0.099107,0.24965,-0.78502,-0.085017,0.21498 +0.038469,-0.94406,-0.14649,0.29544,-0.68502,-0.085017,0.21498 +-0.05435,-0.92778,-0.14603,0.34337,-0.58502,-0.085017,0.21498 +-0.14651,-0.89003,-0.1427,0.43299,-0.48502,-0.085017,0.21498 +-0.23517,-0.82922,-0.22964,0.50956,-0.38502,-0.085017,0.21498 +-0.3166,-0.78032,-0.2223,0.58453,-0.28502,-0.085017,0.21498 +-0.38781,-0.64099,-0.30483,0.70442,-0.18502,-0.085017,0.21498 +-0.36854,0.64125,-0.30348,0.70476,0.21498,-0.085017,0.21498 +-0.29331,0.77976,-0.22492,0.58428,0.31498,-0.085017,0.21498 +-0.20897,0.8912,-0.14273,0.43057,0.41498,-0.085017,0.21498 +-0.11943,0.92817,-0.14333,0.34345,0.51498,-0.085017,0.21498 +-0.026608,0.9287,-0.14606,0.34086,0.61498,-0.085017,0.21498 +0.067103,0.95733,-0.14659,0.24907,0.71498,-0.085017,0.21498 +0.16297,0.96332,-0.098381,0.24966,0.81498,-0.085017,0.21498 +0.25945,0.96332,-0.098381,0.24966,0.91498,-0.085017,0.21498 +0.35632,0.97831,-0.050023,0.201,1.015,-0.085017,0.21498 +0.32368,-0.97949,-0.00019181,0.20149,-0.98502,0.014983,0.21498 +0.22696,-0.96687,0.049033,0.25053,-0.88502,0.014983,0.21498 +0.13027,-0.96687,0.049033,0.25053,-0.78502,0.014983,0.21498 +0.033639,-0.95333,0.049064,0.29793,-0.68502,0.014983,0.21498 +-0.060121,-0.93717,0.047929,0.34557,-0.58502,0.014983,0.21498 +-0.15311,-0.89917,0.047862,0.43498,-0.48502,0.014983,0.21498 +-0.24264,-0.85289,0.046754,0.51999,-0.38502,0.014983,0.21498 +-0.32623,-0.79897,0.045132,0.59967,-0.28502,0.014983,0.21498 +-0.39965,-0.67237,0.045106,0.73884,-0.18502,0.014983,0.21498 +-0.3795,0.73901,0.044856,0.6722,0.21498,0.014983,0.21498 +-0.30227,0.79895,0.045784,0.59965,0.31498,0.014983,0.21498 +-0.21604,0.89922,0.046812,0.43498,0.41498,0.014983,0.21498 +-0.12574,0.93753,0.04793,0.3446,0.51498,0.014983,0.21498 +-0.032021,0.93712,0.048969,0.34556,0.61498,0.014983,0.21498 +0.062561,0.96709,0.049029,0.24965,0.71498,0.014983,0.21498 +0.15925,0.96682,0.049939,0.25052,0.81498,0.014983,0.21498 +0.25593,0.96682,0.049939,0.25052,0.91498,0.014983,0.21498 +0.35283,0.97949,0.0001916,0.20149,1.015,0.014983,0.21498 +0.33005,-0.97463,0.099522,0.20046,-0.98502,0.11498,0.21498 +0.23427,-0.95733,0.14659,0.24907,-0.88502,0.11498,0.21498 +0.13854,-0.95733,0.14659,0.24907,-0.78502,0.11498,0.21498 +0.042859,-0.9441,0.1465,0.29531,-0.68502,0.11498,0.21498 +-0.050061,-0.9287,0.14606,0.34086,-0.58502,0.11498,0.21498 +-0.14116,-0.87491,0.23531,0.42328,-0.48502,0.11498,0.21498 +-0.22834,-0.83102,0.22974,0.50657,-0.38502,0.11498,0.21498 +-0.30868,-0.75936,0.30617,0.57414,-0.28502,0.11498,0.21498 +-0.37791,-0.62358,0.38248,0.6818,-0.18502,0.11498,0.21498 +-0.35923,0.68343,0.38092,0.62275,0.21498,0.11498,0.21498 +-0.28583,0.81063,0.31199,0.49553,0.31498,0.11498,0.21498 +-0.20232,0.87589,0.23136,0.42342,0.41498,0.11498,0.21498 +-0.11447,0.91192,0.23701,0.33501,0.51498,0.11498,0.21498 +-0.022192,0.92912,0.14332,0.34088,0.61498,0.11498,0.21498 +0.071509,0.95793,0.14659,0.24675,0.71498,0.11498,0.21498 +0.16728,0.95698,0.14894,0.24902,0.81498,0.11498,0.21498 +0.26298,0.95698,0.14894,0.24902,0.91498,0.11498,0.21498 +0.35897,0.97458,0.099833,0.20058,1.015,0.11498,0.21498 +0.34608,-0.96007,0.19782,0.19782,-0.98502,0.21498,0.21498 +0.25213,-0.93858,0.24399,0.24399,-0.88502,0.21498,0.21498 +0.15827,-0.93858,0.24399,0.24399,-0.78502,0.21498,0.21498 +0.064464,-0.91344,0.28778,0.28778,-0.68502,0.21498,0.21498 +-0.024281,-0.88458,0.32753,0.33203,-0.58502,0.21498,0.21498 +-0.11206,-0.81889,0.4085,0.40318,-0.48502,0.21498,0.21498 +-0.19395,-0.81889,0.4085,0.40318,-0.38502,0.21498,0.21498 +-0.26749,-0.67085,0.52644,0.52233,-0.28502,0.21498,0.21498 +-0.32857,-0.51036,0.63491,0.58002,-0.18502,0.21498,0.21498 +-0.36854,-0.30348,0.70476,0.64125,-0.085017,0.21498,0.21498 +-0.37951,0.044859,0.67238,0.73884,0.014983,0.21498,0.21498 +-0.35925,0.38095,0.62397,0.6823,0.11498,0.21498,0.21498 +-0.31228,0.61653,0.55673,0.55673,0.21498,0.21498,0.21498 +-0.24638,0.74853,0.46889,0.46889,0.31498,0.21498,0.21498 +-0.16928,0.82127,0.40343,0.40343,0.41498,0.21498,0.21498 +-0.086177,0.88618,0.32764,0.32764,0.51498,0.21498,0.21498 +0.002313,0.88306,0.33181,0.33181,0.61498,0.21498,0.21498 +0.09256,0.93943,0.24235,0.24235,0.71498,0.21498,0.21498 +0.1865,0.93943,0.24235,0.24235,0.81498,0.21498,0.21498 +0.2803,0.93776,0.24556,0.24556,0.91498,0.21498,0.21498 +0.37457,0.95999,0.19802,0.19802,1.015,0.21498,0.21498 +0.37135,-0.93612,0.29332,0.19403,-0.98502,0.31498,0.21498 +0.27999,-0.91056,0.33869,0.23698,-0.88502,0.31498,0.21498 +0.18894,-0.91056,0.33869,0.23698,-0.78502,0.31498,0.21498 +0.099676,-0.87491,0.42328,0.2353,-0.68502,0.31498,0.21498 +0.014226,-0.85016,0.41853,0.31947,-0.58502,0.31498,0.21498 +-0.067273,-0.80914,0.49516,0.3164,-0.48502,0.31498,0.21498 +-0.14228,-0.73449,0.5589,0.3849,-0.38502,0.31498,0.21498 +-0.20792,-0.60299,0.65675,0.45286,-0.28502,0.31498,0.21498 +-0.26044,-0.4729,0.74346,0.4729,-0.18502,0.31498,0.21498 +-0.29328,-0.22486,0.77825,0.58632,-0.085017,0.31498,0.21498 +-0.30228,0.045784,0.79932,0.59915,0.014983,0.31498,0.21498 +-0.28589,0.31192,0.80826,0.49943,0.11498,0.31498,0.21498 +-0.24647,0.47353,0.74584,0.46849,0.21498,0.31498,0.21498 +-0.18986,0.65878,0.60207,0.45114,0.31498,0.31498,0.21498 +-0.12018,0.73309,0.55821,0.38857,0.41498,0.31498,0.21498 +-0.042949,0.81063,0.49553,0.31198,0.51498,0.31498,0.21498 +0.039764,0.84861,0.41817,0.32404,0.61498,0.31498,0.21498 +0.1259,0.87323,0.4268,0.23519,0.71498,0.31498,0.21498 +0.21631,0.91192,0.33501,0.23701,0.81498,0.31498,0.21498 +0.30732,0.90964,0.33854,0.24073,0.91498,0.31498,0.21498 +0.39927,0.93604,0.29341,0.19428,1.015,0.31498,0.21498 +0.31701,-0.87414,0.42704,0.23133,-0.88502,0.41498,0.21498 +0.2296,-0.87414,0.42704,0.23133,-0.78502,0.41498,0.21498 +0.14526,-0.83102,0.50657,0.22975,-0.68502,0.41498,0.21498 +0.064574,-0.76037,0.57099,0.30951,-0.58502,0.41498,0.21498 +-0.010566,-0.70442,0.641,0.30483,-0.48502,0.41498,0.21498 +-0.078584,-0.62358,0.6818,0.38248,-0.38502,0.41498,0.21498 +-0.1368,-0.48232,0.78283,0.39312,-0.28502,0.41498,0.21498 +-0.18144,-0.40806,0.81668,0.40806,-0.18502,0.41498,0.21498 +-0.20893,-0.13996,0.89161,0.43063,-0.085017,0.41498,0.21498 +-0.21606,0.046814,0.89877,0.43591,0.014983,0.41498,0.21498 +-0.2024,0.23133,0.87414,0.42704,0.11498,0.41498,0.21498 +-0.16941,0.4085,0.81889,0.40318,0.21498,0.41498,0.21498 +-0.12027,0.5589,0.73449,0.38489,0.31498,0.41498,0.21498 +-0.059896,0.70476,0.64125,0.30348,0.41498,0.41498,0.21498 +0.011419,0.76139,0.57144,0.30618,0.51498,0.41498,0.21498 +0.087669,0.7854,0.53518,0.31102,0.61498,0.41498,0.21498 +0.1702,0.82923,0.50956,0.22964,0.71498,0.41498,0.21498 +0.25586,0.87589,0.42342,0.23135,0.81498,0.41498,0.21498 +0.34323,0.87323,0.4268,0.23519,0.91498,0.41498,0.21498 +0.36213,-0.83,0.50986,0.22616,-0.88502,0.51498,0.21498 +0.27913,-0.83,0.50986,0.22616,-0.78502,0.51498,0.21498 +0.19974,-0.77976,0.58428,0.22492,-0.68502,0.51498,0.21498 +0.12407,-0.71329,0.64974,0.2628,-0.58502,0.51498,0.21498 +0.05549,-0.64198,0.70354,0.30479,-0.48502,0.51498,0.21498 +-0.0057049,-0.57144,0.76139,0.30618,-0.38502,0.51498,0.21498 +-0.057842,-0.41405,0.85231,0.31957,-0.28502,0.51498,0.21498 +-0.095995,-0.32764,0.88618,0.32763,-0.18502,0.51498,0.21498 +-0.1194,-0.14333,0.92912,0.34088,-0.085017,0.51498,0.21498 +-0.12575,0.04793,0.93717,0.34557,0.014983,0.51498,0.21498 +-0.11451,0.23698,0.91056,0.33869,0.11498,0.51498,0.21498 +-0.086231,0.32754,0.88458,0.33203,0.21498,0.51498,0.21498 +-0.043027,0.49516,0.80914,0.3164,0.31498,0.51498,0.21498 +0.011387,0.57414,0.75936,0.30617,0.41498,0.51498,0.21498 +0.074781,0.67416,0.67321,0.30379,0.51498,0.51498,0.21498 +0.14554,0.74298,0.61514,0.26378,0.61498,0.51498,0.21498 +0.22314,0.77825,0.58632,0.22486,0.71498,0.51498,0.21498 +0.30407,0.83187,0.5068,0.22617,0.81498,0.51498,0.21498 +0.38706,0.86228,0.4713,0.18535,0.91498,0.51498,0.21498 +0.33623,-0.77876,0.5866,0.22231,-0.78502,0.61498,0.21498 +0.26164,-0.72143,0.65606,0.22162,-0.68502,0.61498,0.21498 +0.19147,-0.6562,0.72162,0.22059,-0.58502,0.61498,0.21498 +0.1277,-0.57968,0.77016,0.26611,-0.48502,0.61498,0.21498 +0.072731,-0.49895,0.80689,0.31618,-0.38502,0.61498,0.21498 +0.027234,-0.41817,0.84861,0.32404,-0.28502,0.61498,0.21498 +-0.0066813,-0.23701,0.91192,0.33501,-0.18502,0.61498,0.21498 +-0.026548,-0.14603,0.92778,0.34337,-0.085017,0.61498,0.21498 +-0.032038,0.04793,0.93717,0.34557,0.014983,0.61498,0.21498 +-0.022231,0.14606,0.9287,0.34086,0.11498,0.61498,0.21498 +0.0022268,0.32978,0.88458,0.32978,0.21498,0.61498,0.21498 +0.039702,0.41853,0.85016,0.31947,0.31498,0.61498,0.21498 +0.087669,0.53571,0.78504,0.31101,0.41498,0.61498,0.21498 +0.14554,0.61551,0.74271,0.26367,0.51498,0.61498,0.21498 +0.21136,0.69001,0.68929,0.22083,0.61498,0.61498,0.21498 +0.28327,0.72076,0.6568,0.2216,0.71498,0.61498,0.21498 +0.3596,0.77825,0.58632,0.22486,0.81498,0.61498,0.21498 +0.39942,-0.72094,0.65695,0.2206,-0.78502,0.71498,0.21498 +0.32925,-0.6562,0.72162,0.22059,-0.68502,0.71498,0.21498 +0.26419,-0.62135,0.75137,0.2222,-0.58502,0.71498,0.21498 +0.20587,-0.54719,0.80598,0.22578,-0.48502,0.71498,0.21498 +0.15558,-0.46705,0.85358,0.23078,-0.38502,0.71498,0.21498 +0.11507,-0.33501,0.91192,0.23701,-0.28502,0.71498,0.21498 +0.085298,-0.24235,0.93943,0.24235,-0.18502,0.71498,0.21498 +0.067116,-0.14659,0.95793,0.24675,-0.085017,0.71498,0.21498 +0.062556,0.049033,0.96687,0.25053,0.014983,0.71498,0.21498 +0.071496,0.14659,0.95733,0.24907,0.11498,0.71498,0.21498 +0.092541,0.24399,0.93858,0.24399,0.21498,0.71498,0.21498 +0.12589,0.42328,0.87491,0.2353,0.31498,0.71498,0.21498 +0.17016,0.50657,0.83102,0.22975,0.41498,0.71498,0.21498 +0.22311,0.58428,0.77976,0.22492,0.51498,0.71498,0.21498 +0.28326,0.65606,0.72143,0.22162,0.61498,0.71498,0.21498 +0.34929,0.69001,0.68929,0.22083,0.71498,0.71498,0.21498 +0.34203,-0.58632,0.77825,0.22486,-0.58502,0.81498,0.21498 +0.28881,-0.50956,0.82922,0.22965,-0.48502,0.81498,0.21498 +0.24311,-0.4268,0.87323,0.23519,-0.38502,0.81498,0.21498 +0.20621,-0.33854,0.90964,0.24073,-0.28502,0.81498,0.21498 +0.17916,-0.24556,0.93776,0.24556,-0.18502,0.81498,0.21498 +0.16297,-0.099107,0.96325,0.24965,-0.085017,0.81498,0.21498 +0.15924,0.049033,0.96687,0.25053,0.014983,0.81498,0.21498 +0.16723,0.14659,0.95733,0.24907,0.11498,0.81498,0.21498 +0.1864,0.24399,0.93858,0.24399,0.21498,0.81498,0.21498 +0.21622,0.33869,0.91056,0.23698,0.31498,0.81498,0.21498 +0.25579,0.42703,0.87414,0.23133,0.41498,0.81498,0.21498 +0.304,0.50986,0.83,0.22616,0.51498,0.81498,0.21498 +0.35957,0.5866,0.77876,0.22231,0.61498,0.81498,0.21498 +0.37312,-0.46705,0.85358,0.23078,-0.48502,0.91498,0.21498 +0.33115,-0.38138,0.89368,0.23639,-0.38502,0.91498,0.21498 +0.29768,-0.29081,0.92571,0.24185,-0.28502,0.91498,0.21498 +0.27353,-0.19632,0.94906,0.24647,-0.18502,0.91498,0.21498 +0.25945,-0.099107,0.96325,0.24965,-0.085017,0.91498,0.21498 +0.25593,0.049033,0.96687,0.25053,0.014983,0.91498,0.21498 +0.26296,0.14659,0.95733,0.24907,0.11498,0.91498,0.21498 +0.28026,0.24399,0.93858,0.24399,0.21498,0.91498,0.21498 +0.30728,0.33869,0.91056,0.23698,0.31498,0.91498,0.21498 +0.34321,0.42516,0.87453,0.23332,0.41498,0.91498,0.21498 +0.38706,0.4714,0.86228,0.18508,0.51498,0.91498,0.21498 +0.39157,-0.24647,0.94906,0.19632,-0.28502,1.015,0.21498 +0.36935,-0.14933,0.96846,0.19944,-0.18502,1.015,0.21498 +0.35632,-0.050024,0.97829,0.20113,-0.085017,1.015,0.21498 +0.35283,-0.00019162,0.97949,0.20149,0.014983,1.015,0.21498 +0.35897,0.099522,0.97463,0.20046,0.11498,1.015,0.21498 +0.37457,0.19782,0.96007,0.19782,0.21498,1.015,0.21498 +0.39927,0.29332,0.93612,0.19403,0.31498,1.015,0.21498 +0.38818,-0.24185,-0.92577,0.29061,-0.28502,-0.98502,0.31498 +0.36593,-0.1465,-0.9441,0.29531,-0.18502,-0.98502,0.31498 +0.35292,-0.097571,-0.94985,0.29711,-0.085017,-0.98502,0.31498 +0.34949,0.00024104,-0.9544,0.29852,0.014983,-0.98502,0.31498 +0.3557,0.09796,-0.94979,0.29716,0.11498,-0.98502,0.31498 +0.37135,0.19428,-0.93603,0.29341,0.21498,-0.98502,0.31498 +0.39606,0.28791,-0.91335,0.28791,0.31498,-0.98502,0.31498 +0.37266,-0.45728,-0.83044,0.31823,-0.48502,-0.88502,0.31498 +0.33083,-0.3733,-0.86846,0.32623,-0.38502,-0.88502,0.31498 +0.29738,-0.28448,-0.89868,0.33383,-0.28502,-0.88502,0.31498 +0.27317,-0.19173,-0.92062,0.34014,-0.18502,-0.88502,0.31498 +0.25906,-0.096258,-0.93387,0.34441,-0.085017,-0.88502,0.31498 +0.25559,0.048971,-0.93712,0.34555,0.014983,-0.88502,0.31498 +0.2627,0.14603,-0.92778,0.34337,0.11498,-0.88502,0.31498 +0.28006,0.24073,-0.90964,0.33854,0.21498,-0.88502,0.31498 +0.30713,0.33181,-0.88306,0.33181,0.31498,-0.88502,0.31498 +0.34314,0.41817,-0.84861,0.32404,0.41498,-0.88502,0.31498 +0.38708,0.49895,-0.8069,0.31618,0.51498,-0.88502,0.31498 +0.34469,-0.57099,-0.76037,0.30951,-0.58502,-0.78502,0.31498 +0.2913,-0.49516,-0.80914,0.3164,-0.48502,-0.78502,0.31498 +0.2456,-0.41383,-0.85064,0.32429,-0.38502,-0.78502,0.31498 +0.20878,-0.32754,-0.88458,0.33203,-0.28502,-0.78502,0.31498 +0.18184,-0.23698,-0.91056,0.33869,-0.18502,-0.78502,0.31498 +0.16562,-0.096258,-0.93387,0.34441,-0.085017,-0.78502,0.31498 +0.16188,0.048971,-0.93712,0.34555,0.014983,-0.78502,0.31498 +0.16988,0.14333,-0.92912,0.34088,0.11498,-0.78502,0.31498 +0.18898,0.23701,-0.91192,0.33501,0.21498,-0.78502,0.31498 +0.21865,0.32764,-0.88618,0.32764,0.31498,-0.78502,0.31498 +0.25808,0.41405,-0.85231,0.31957,0.41498,-0.78502,0.31498 +0.30625,0.49553,-0.81063,0.31198,0.51498,-0.78502,0.31498 +0.36193,0.57144,-0.76139,0.30618,0.61498,-0.78502,0.31498 +0.33426,-0.67416,-0.67321,0.30379,-0.68502,-0.68502,0.31498 +0.26979,-0.64099,-0.70442,0.30483,-0.58502,-0.68502,0.31498 +0.21174,-0.56541,-0.74804,0.34749,-0.48502,-0.68502,0.31498 +0.16185,-0.44556,-0.80044,0.40096,-0.38502,-0.68502,0.31498 +0.12183,-0.32429,-0.85064,0.41383,-0.28502,-0.68502,0.31498 +0.092625,-0.23531,-0.87491,0.42328,-0.18502,-0.68502,0.31498 +0.074765,-0.13997,-0.89041,0.4331,-0.085017,-0.68502,0.31498 +0.07024,0.047859,-0.89873,0.43589,0.014983,-0.68502,0.31498 +0.079067,0.1427,-0.89003,0.43299,0.11498,-0.68502,0.31498 +0.099678,0.23135,-0.87589,0.42343,0.21498,-0.68502,0.31498 +0.13294,0.40806,-0.81668,0.40806,0.31498,-0.68502,0.31498 +0.17638,0.49142,-0.7952,0.35519,0.41498,-0.68502,0.31498 +0.22872,0.56537,-0.74796,0.34771,0.51498,-0.68502,0.31498 +0.28901,0.64125,-0.70476,0.30348,0.61498,-0.68502,0.31498 +0.35503,0.70386,-0.64224,0.3035,0.71498,-0.68502,0.31498 +0.34477,-0.75843,-0.57365,0.30938,-0.78502,-0.58502,0.31498 +0.26979,-0.70354,-0.64198,0.30479,-0.68502,-0.58502,0.31498 +0.20048,-0.65428,-0.6531,0.38127,-0.58502,-0.58502,0.31498 +0.13818,-0.59112,-0.70928,0.38404,-0.48502,-0.58502,0.31498 +0.083783,-0.48691,-0.78008,0.39294,-0.38502,-0.58502,0.31498 +0.038914,-0.40318,-0.81889,0.4085,-0.28502,-0.58502,0.31498 +0.0051344,-0.23531,-0.87491,0.42328,-0.18502,-0.58502,0.31498 +-0.014276,-0.13997,-0.89041,0.4331,-0.085017,-0.58502,0.31498 +-0.019644,0.046813,-0.89922,0.43498,0.014983,-0.58502,0.31498 +-0.010068,0.13996,-0.89161,0.43063,0.11498,-0.58502,0.31498 +0.014256,0.31957,-0.85231,0.41405,0.21498,-0.58502,0.31498 +0.051049,0.40343,-0.82127,0.40343,0.31498,-0.58502,0.31498 +0.09915,0.55821,-0.73309,0.38857,0.41498,-0.58502,0.31498 +0.15664,0.62358,-0.6818,0.38247,0.51498,-0.58502,0.31498 +0.22082,0.69393,-0.633,0.34317,0.61498,-0.58502,0.31498 +0.29155,0.73257,-0.60814,0.30579,0.71498,-0.58502,0.31498 +0.36747,0.76037,-0.57099,0.30951,0.81498,-0.58502,0.31498 +0.37266,-0.83057,-0.45703,0.31824,-0.88502,-0.48502,0.31498 +0.2914,-0.81063,-0.49553,0.31198,-0.78502,-0.48502,0.31498 +0.21174,-0.74796,-0.56537,0.34771,-0.68502,-0.48502,0.31498 +0.13818,-0.71006,-0.59017,0.38408,-0.58502,-0.48502,0.31498 +0.069769,-0.64343,-0.64278,0.41573,-0.48502,-0.48502,0.31498 +0.010681,-0.54224,-0.70493,0.45723,-0.38502,-0.48502,0.31498 +-0.039489,-0.46849,-0.74584,0.47353,-0.28502,-0.48502,0.31498 +-0.076667,-0.31192,-0.80826,0.49943,-0.18502,-0.48502,0.31498 +-0.099241,-0.13696,-0.84482,0.51723,-0.085017,-0.48502,0.31498 +-0.10531,0.045834,-0.85293,0.52,0.014983,-0.48502,0.31498 +-0.094414,0.22965,-0.82922,0.50956,0.11498,-0.48502,0.31498 +-0.06724,0.31198,-0.81063,0.49552,0.21498,-0.48502,0.31498 +-0.025331,0.46889,-0.74853,0.46889,0.31498,-0.48502,0.31498 +0.027406,0.60299,-0.65675,0.45286,0.41498,-0.48502,0.31498 +0.09014,0.68289,-0.62235,0.38255,0.51498,-0.48502,0.31498 +0.16015,0.73449,-0.5589,0.3849,0.61498,-0.48502,0.31498 +0.23475,0.77287,-0.52881,0.35077,0.71498,-0.48502,0.31498 +0.31555,0.80914,-0.49516,0.3164,0.81498,-0.48502,0.31498 +0.39786,0.84307,-0.46261,0.27427,0.91498,-0.48502,0.31498 +0.33083,-0.86844,-0.37335,0.32623,-0.88502,-0.38502,0.31498 +0.24567,-0.85231,-0.41405,0.31957,-0.78502,-0.38502,0.31498 +0.16185,-0.80055,-0.44534,0.40098,-0.68502,-0.38502,0.31498 +0.083848,-0.78283,-0.48232,0.39312,-0.58502,-0.38502,0.31498 +0.010757,-0.70759,-0.53862,0.45739,-0.48502,-0.38502,0.31498 +-0.055659,-0.63491,-0.58002,0.51036,-0.38502,-0.38502,0.31498 +-0.11118,-0.52233,-0.67085,0.52644,-0.28502,-0.38502,0.31498 +-0.15382,-0.3849,-0.73449,0.5589,-0.18502,-0.38502,0.31498 +-0.17964,-0.13477,-0.79208,0.59535,-0.085017,-0.38502,0.31498 +-0.18636,0.045132,-0.79936,0.59916,0.014983,-0.38502,0.31498 +-0.17346,0.2223,-0.78032,0.58453,0.11498,-0.38502,0.31498 +-0.14224,0.38495,-0.73695,0.55563,0.21498,-0.38502,0.31498 +-0.095458,0.52276,-0.67338,0.52276,0.31498,-0.38502,0.31498 +-0.036711,0.65799,-0.60154,0.453,0.41498,-0.38502,0.31498 +0.031805,0.70493,-0.54224,0.45722,0.51498,-0.38502,0.31498 +0.10716,0.78035,-0.48439,0.3955,0.61498,-0.38502,0.31498 +0.1862,0.83552,-0.41154,0.36406,0.71498,-0.38502,0.31498 +0.27109,0.85064,-0.41383,0.32429,0.81498,-0.38502,0.31498 +0.35691,0.86846,-0.3733,0.32623,0.91498,-0.38502,0.31498 +0.38818,-0.92571,-0.24185,0.29081,-0.98502,-0.28502,0.31498 +0.29738,-0.8986,-0.28476,0.33382,-0.88502,-0.28502,0.31498 +0.20883,-0.88618,-0.32764,0.32764,-0.78502,-0.28502,0.31498 +0.12187,-0.85231,-0.31957,0.41405,-0.68502,-0.28502,0.31498 +0.03896,-0.82128,-0.40343,0.40343,-0.58502,-0.28502,0.31498 +-0.03945,-0.74346,-0.4729,0.4729,-0.48502,-0.28502,0.31498 +-0.11115,-0.66879,-0.5257,0.5257,-0.38502,-0.28502,0.31498 +-0.17308,-0.56837,-0.55703,0.60553,-0.28502,-0.28502,0.31498 +-0.22063,-0.38255,-0.62235,0.68289,-0.18502,-0.28502,0.31498 +-0.25058,-0.2206,-0.65695,0.72094,-0.085017,-0.28502,0.31498 +-0.25853,0.045107,-0.67237,0.73884,0.014983,-0.28502,0.31498 +-0.24394,0.22059,-0.6562,0.72162,0.11498,-0.28502,0.31498 +-0.20792,0.45286,-0.60299,0.65675,0.21498,-0.28502,0.31498 +-0.156,0.56135,-0.56135,0.6081,0.31498,-0.28502,0.31498 +-0.090293,0.70546,-0.46142,0.53797,0.41498,-0.28502,0.31498 +-0.016578,0.78062,-0.39806,0.48186,0.51498,-0.28502,0.31498 +0.063453,0.81889,-0.40318,0.4085,0.61498,-0.28502,0.31498 +0.14733,0.86846,-0.32623,0.3733,0.71498,-0.28502,0.31498 +0.23528,0.88458,-0.32753,0.33203,0.81498,-0.28502,0.31498 +0.3243,0.89868,-0.28448,0.33383,0.91498,-0.28502,0.31498 +0.36593,-0.94406,-0.14649,0.29544,-0.98502,-0.18502,0.31498 +0.27317,-0.92051,-0.19227,0.34013,-0.88502,-0.18502,0.31498 +0.18188,-0.91192,-0.23701,0.33501,-0.78502,-0.18502,0.31498 +0.092686,-0.87323,-0.23519,0.4268,-0.68502,-0.18502,0.31498 +0.0051558,-0.87589,-0.23135,0.42342,-0.58502,-0.18502,0.31498 +-0.076589,-0.81063,-0.31199,0.49553,-0.48502,-0.18502,0.31498 +-0.15379,-0.73309,-0.38856,0.55821,-0.38502,-0.18502,0.31498 +-0.22063,-0.62235,-0.38255,0.68289,-0.28502,-0.18502,0.31498 +-0.2747,-0.46849,-0.47353,0.74584,-0.18502,-0.18502,0.31498 +-0.3086,-0.22975,-0.50657,0.83102,-0.085017,-0.18502,0.31498 +-0.31793,0.04675,-0.52075,0.85243,0.014983,-0.18502,0.31498 +-0.30075,0.31618,-0.49895,0.8069,0.11498,-0.18502,0.31498 +-0.26044,0.4729,-0.4729,0.74346,0.21498,-0.18502,0.31498 +-0.20193,0.62275,-0.38092,0.68343,0.31498,-0.18502,0.31498 +-0.13109,0.76037,-0.30951,0.57099,0.41498,-0.18502,0.31498 +-0.052447,0.80826,-0.31192,0.49943,0.51498,-0.18502,0.31498 +0.031352,0.87491,-0.23531,0.42328,0.61498,-0.18502,0.31498 +0.11884,0.87491,-0.23531,0.42328,0.71498,-0.18502,0.31498 +0.20912,0.91056,-0.23698,0.33869,0.81498,-0.18502,0.31498 +0.30081,0.92062,-0.19173,0.34014,0.91498,-0.18502,0.31498 +0.39418,0.9441,-0.1465,0.29531,1.015,-0.18502,0.31498 +0.35292,-0.94979,-0.09796,0.29716,-0.98502,-0.085017,0.31498 +0.25906,-0.93379,-0.097097,0.3444,-0.88502,-0.085017,0.31498 +0.16562,-0.93379,-0.097097,0.3444,-0.78502,-0.085017,0.31498 +0.074791,-0.89003,-0.1427,0.43299,-0.68502,-0.085017,0.31498 +-0.014262,-0.89161,-0.13996,0.43063,-0.58502,-0.085017,0.31498 +-0.099201,-0.84607,-0.13696,0.51518,-0.48502,-0.085017,0.31498 +-0.17962,-0.79311,-0.13476,0.59398,-0.38502,-0.085017,0.31498 +-0.25058,-0.65695,-0.2206,0.72094,-0.28502,-0.085017,0.31498 +-0.3086,-0.50657,-0.22974,0.83102,-0.18502,-0.085017,0.31498 +-0.34631,-0.24234,-0.24564,0.93858,-0.085017,-0.085017,0.31498 +-0.35672,0.049031,-0.24965,0.96709,0.014983,-0.085017,0.31498 +-0.33746,0.33677,-0.23887,0.91078,0.11498,-0.085017,0.31498 +-0.29328,0.58632,-0.22486,0.77825,0.21498,-0.085017,0.31498 +-0.23089,0.65621,-0.22059,0.72162,0.31498,-0.085017,0.31498 +-0.15589,0.79289,-0.13652,0.59388,0.41498,-0.085017,0.31498 +-0.073924,0.84572,-0.13941,0.51509,0.51498,-0.085017,0.31498 +0.012406,0.89041,-0.13997,0.4331,0.61498,-0.085017,0.31498 +0.10145,0.8912,-0.14273,0.43057,0.71498,-0.085017,0.31498 +0.19357,0.93387,-0.096259,0.34442,0.81498,-0.085017,0.31498 +0.28712,0.93387,-0.096259,0.34442,0.91498,-0.085017,0.31498 +0.38144,0.95333,-0.049064,0.29793,1.015,-0.085017,0.31498 +0.34949,-0.9544,-0.00024039,0.29852,-0.98502,0.014983,0.31498 +0.25559,-0.93717,0.047929,0.34557,-0.88502,0.014983,0.31498 +0.16187,-0.93717,0.047929,0.34557,-0.78502,0.014983,0.31498 +0.070228,-0.89877,0.046817,0.43591,-0.68502,0.014983,0.31498 +-0.01965,-0.89877,0.046817,0.43591,-0.58502,0.014983,0.31498 +-0.10533,-0.85247,0.045832,0.52077,-0.48502,0.014983,0.31498 +-0.18637,-0.79897,0.045132,0.59967,-0.38502,0.014983,0.31498 +-0.25853,-0.67237,0.045106,0.73884,-0.28502,0.014983,0.31498 +-0.31793,-0.52075,0.04675,0.85243,-0.18502,0.014983,0.31498 +-0.35672,-0.24965,0.049031,0.96709,-0.085017,0.014983,0.31498 +-0.36756,0.050878,0.05064,0.99742,0.014983,0.014983,0.31498 +-0.34775,0.3446,0.048974,0.93747,0.11498,0.014983,0.31498 +-0.30228,0.59915,0.045786,0.79932,0.21498,0.014983,0.31498 +-0.23838,0.73901,0.044856,0.6722,0.31498,0.014983,0.31498 +-0.16241,0.79895,0.045784,0.59965,0.41498,0.014983,0.31498 +-0.079765,0.85243,0.04675,0.52075,0.51498,0.014983,0.31498 +0.0072983,0.89873,0.047861,0.43589,0.61498,0.014983,0.31498 +0.097171,0.89873,0.047861,0.43589,0.71498,0.014983,0.31498 +0.18996,0.93712,0.048969,0.34556,0.81498,0.014983,0.31498 +0.28367,0.93712,0.048969,0.34556,0.91498,0.014983,0.31498 +0.37802,0.9544,0.00024041,0.29852,1.015,0.014983,0.31498 +0.3557,-0.94985,0.097571,0.29711,-0.98502,0.11498,0.31498 +0.26267,-0.92817,0.14333,0.34345,-0.88502,0.11498,0.31498 +0.16985,-0.92817,0.14333,0.34345,-0.78502,0.11498,0.31498 +0.079021,-0.8912,0.14273,0.43057,-0.68502,0.11498,0.31498 +-0.010082,-0.89041,0.13997,0.4331,-0.58502,0.11498,0.31498 +-0.094455,-0.83,0.22616,0.50985,-0.48502,0.11498,0.31498 +-0.17349,-0.77876,0.22231,0.5866,-0.38502,0.11498,0.31498 +-0.24394,-0.6562,0.22059,0.72162,-0.28502,0.11498,0.31498 +-0.30075,-0.49895,0.31618,0.8069,-0.18502,0.11498,0.31498 +-0.33746,-0.23887,0.33677,0.91078,-0.085017,0.11498,0.31498 +-0.34775,0.048973,0.3446,0.93747,0.014983,0.11498,0.31498 +-0.3291,0.32754,0.33203,0.88458,0.11498,0.11498,0.31498 +-0.28589,0.49943,0.31192,0.80826,0.21498,0.11498,0.31498 +-0.22427,0.72162,0.22059,0.6562,0.31498,0.11498,0.31498 +-0.15008,0.77825,0.22486,0.58632,0.41498,0.11498,0.31498 +-0.069566,0.82922,0.22964,0.50956,0.51498,0.11498,0.31498 +0.01665,0.89161,0.13997,0.43063,0.61498,0.11498,0.31498 +0.10574,0.89003,0.14269,0.43299,0.71498,0.11498,0.31498 +0.19772,0.92912,0.14332,0.34088,0.81498,0.11498,0.31498 +0.2905,0.92778,0.14603,0.34337,0.91498,0.11498,0.31498 +0.38402,0.94979,0.09796,0.29716,1.015,0.11498,0.31498 +0.37135,-0.93612,0.19403,0.29332,-0.98502,0.21498,0.31498 +0.27999,-0.91056,0.23698,0.33869,-0.88502,0.21498,0.31498 +0.18894,-0.91056,0.23698,0.33869,-0.78502,0.21498,0.31498 +0.099676,-0.87491,0.23531,0.42328,-0.68502,0.21498,0.31498 +0.014226,-0.85016,0.31947,0.41853,-0.58502,0.21498,0.31498 +-0.067273,-0.80914,0.3164,0.49516,-0.48502,0.21498,0.31498 +-0.14228,-0.73449,0.38489,0.5589,-0.38502,0.21498,0.31498 +-0.20792,-0.60299,0.45286,0.65675,-0.28502,0.21498,0.31498 +-0.26044,-0.4729,0.4729,0.74346,-0.18502,0.21498,0.31498 +-0.29328,-0.22486,0.58632,0.77825,-0.085017,0.21498,0.31498 +-0.30228,0.045786,0.59915,0.79932,0.014983,0.21498,0.31498 +-0.28589,0.31192,0.49943,0.80826,0.11498,0.21498,0.31498 +-0.24647,0.46849,0.47353,0.74584,0.21498,0.21498,0.31498 +-0.18986,0.65878,0.45114,0.60207,0.31498,0.21498,0.31498 +-0.12018,0.73309,0.38856,0.55821,0.41498,0.21498,0.31498 +-0.042949,0.81063,0.31199,0.49553,0.51498,0.21498,0.31498 +0.039765,0.84861,0.32404,0.41817,0.61498,0.21498,0.31498 +0.1259,0.87323,0.23519,0.4268,0.71498,0.21498,0.31498 +0.21631,0.91192,0.23701,0.33501,0.81498,0.21498,0.31498 +0.30732,0.90964,0.24073,0.33854,0.91498,0.21498,0.31498 +0.39927,0.93604,0.19428,0.29341,1.015,0.21498,0.31498 +0.39606,-0.91344,0.28778,0.28778,-0.98502,0.31498,0.31498 +0.30705,-0.88458,0.32978,0.32978,-0.88502,0.31498,0.31498 +0.21859,-0.88458,0.32978,0.32978,-0.78502,0.31498,0.31498 +0.13289,-0.81889,0.40584,0.40584,-0.68502,0.31498,0.31498 +0.050996,-0.81889,0.40584,0.40584,-0.58502,0.31498,0.31498 +-0.02545,-0.74584,0.47353,0.46849,-0.48502,0.31498,0.31498 +-0.095529,-0.67085,0.52233,0.52644,-0.38502,0.31498,0.31498 +-0.156,-0.56134,0.56135,0.6081,-0.28502,0.31498,0.31498 +-0.20193,-0.38093,0.68343,0.62275,-0.18502,0.31498,0.31498 +-0.23089,-0.22059,0.72162,0.6562,-0.085017,0.31498,0.31498 +-0.23839,0.044859,0.67238,0.73884,0.014983,0.31498,0.31498 +-0.22429,0.2206,0.65695,0.72094,0.11498,0.31498,0.31498 +-0.18988,0.45117,0.65744,0.60351,0.21498,0.31498,0.31498 +-0.13928,0.61653,0.55673,0.55673,0.31498,0.31498,0.31498 +-0.075356,0.66879,0.5257,0.5257,0.41498,0.31498,0.31498 +-0.0030006,0.74346,0.4729,0.4729,0.51498,0.31498,0.31498 +0.075659,0.82127,0.40343,0.40343,0.61498,0.31498,0.31498 +0.15747,0.85315,0.36888,0.36888,0.71498,0.31498,0.31498 +0.2452,0.88618,0.32764,0.32764,0.81498,0.31498,0.31498 +0.33359,0.88306,0.33181,0.33181,0.91498,0.31498,0.31498 +0.34307,-0.85016,0.41853,0.31947,-0.88502,0.41498,0.31498 +0.25806,-0.85016,0.41853,0.31947,-0.78502,0.41498,0.31498 +0.17638,-0.78008,0.48691,0.39294,-0.68502,0.41498,0.31498 +0.09913,-0.73538,0.55501,0.38883,-0.58502,0.41498,0.31498 +0.027396,-0.65799,0.60154,0.453,-0.48502,0.41498,0.31498 +-0.036707,-0.60207,0.65878,0.45114,-0.38502,0.41498,0.31498 +-0.090226,-0.45739,0.70758,0.53862,-0.28502,0.41498,0.31498 +-0.13104,-0.30618,0.76139,0.57143,-0.18502,0.41498,0.31498 +-0.15586,-0.13477,0.79311,0.59398,-0.085017,0.41498,0.31498 +-0.16243,0.045133,0.79897,0.59967,0.014983,0.41498,0.31498 +-0.15015,0.22231,0.77876,0.5866,0.11498,0.41498,0.31498 +-0.12027,0.3849,0.73449,0.5589,0.21498,0.41498,0.31498 +-0.075427,0.52233,0.67085,0.52644,0.31498,0.41498,0.31498 +-0.018666,0.65878,0.60207,0.45114,0.41498,0.41498,0.31498 +0.048069,0.70311,0.54144,0.46095,0.51498,0.41498,0.31498 +0.12176,0.78283,0.48232,0.39312,0.61498,0.41498,0.31498 +0.20004,0.7952,0.49142,0.35519,0.71498,0.41498,0.31498 +0.28362,0.85231,0.41405,0.31957,0.81498,0.41498,0.31498 +0.36857,0.84861,0.41817,0.32404,0.91498,0.41498,0.31498 +0.38706,-0.8087,0.49729,0.31416,-0.88502,0.51498,0.31498 +0.30623,-0.80826,0.49943,0.31192,-0.78502,0.51498,0.31498 +0.22872,-0.74804,0.56541,0.34749,-0.68502,0.51498,0.31498 +0.15661,-0.68289,0.62235,0.38255,-0.58502,0.51498,0.31498 +0.090152,-0.62275,0.68343,0.38092,-0.48502,0.51498,0.31498 +0.031845,-0.54144,0.70311,0.46095,-0.38502,0.51498,0.31498 +-0.016536,-0.39312,0.78283,0.48232,-0.28502,0.51498,0.31498 +-0.052376,-0.31618,0.8069,0.49895,-0.18502,0.51498,0.31498 +-0.073847,-0.13817,0.84529,0.51614,-0.085017,0.51498,0.31498 +-0.079782,0.045834,0.85247,0.52077,0.014983,0.51498,0.31498 +-0.069584,0.22616,0.83,0.50986,0.11498,0.51498,0.31498 +-0.043027,0.3164,0.80914,0.49516,0.21498,0.51498,0.31498 +-0.0031005,0.47353,0.74584,0.46849,0.31498,0.51498,0.31498 +0.048054,0.54224,0.70493,0.45722,0.41498,0.51498,0.31498 +0.10891,0.65428,0.6531,0.38128,0.51498,0.51498,0.31498 +0.17715,0.71006,0.59017,0.38408,0.61498,0.51498,0.31498 +0.25146,0.76139,0.57144,0.30618,0.71498,0.51498,0.31498 +0.33054,0.81063,0.49553,0.31198,0.81498,0.51498,0.31498 +0.36188,-0.75936,0.57414,0.30617,-0.78502,0.61498,0.31498 +0.289,-0.70442,0.641,0.30483,-0.68502,0.61498,0.31498 +0.22082,-0.63298,0.6939,0.34328,-0.58502,0.61498,0.31498 +0.16021,-0.55563,0.73695,0.38495,-0.48502,0.61498,0.31498 +0.10731,-0.48232,0.78283,0.39312,-0.38502,0.61498,0.31498 +0.063512,-0.40806,0.81668,0.40806,-0.28502,0.61498,0.31498 +0.031403,-0.23135,0.87589,0.42342,-0.18502,0.61498,0.31498 +0.012456,-0.13996,0.89161,0.43063,-0.085017,0.61498,0.31498 +0.0072829,0.046814,0.89877,0.43591,0.014983,0.61498,0.31498 +0.016607,0.14273,0.8912,0.43057,0.11498,0.61498,0.31498 +0.039702,0.31947,0.85016,0.41853,0.21498,0.61498,0.31498 +0.075535,0.40584,0.81889,0.40584,0.31498,0.61498,0.31498 +0.12175,0.48691,0.78008,0.39294,0.41498,0.61498,0.31498 +0.17715,0.59112,0.70928,0.38404,0.51498,0.61498,0.31498 +0.24,0.66471,0.66418,0.34208,0.61498,0.61498,0.31498 +0.31011,0.70354,0.64198,0.30479,0.71498,0.61498,0.31498 +0.38469,0.75843,0.57365,0.30938,0.81498,0.61498,0.31498 +0.35504,-0.64125,0.70476,0.30348,-0.68502,0.71498,0.31498 +0.29155,-0.60734,0.73323,0.3058,-0.58502,0.71498,0.31498 +0.23475,-0.52853,0.77301,0.35088,-0.48502,0.71498,0.31498 +0.1862,-0.41153,0.83545,0.36423,-0.38502,0.71498,0.31498 +0.14733,-0.32623,0.86844,0.37335,-0.28502,0.71498,0.31498 +0.11885,-0.23519,0.87323,0.4268,-0.18502,0.71498,0.31498 +0.10146,-0.1427,0.89003,0.43299,-0.085017,0.71498,0.31498 +0.097166,0.047864,0.89917,0.43498,0.014983,0.71498,0.31498 +0.10573,0.14273,0.8912,0.43057,0.11498,0.71498,0.31498 +0.12589,0.23531,0.87491,0.42328,0.21498,0.71498,0.31498 +0.15747,0.36881,0.8532,0.36881,0.31498,0.71498,0.31498 +0.20004,0.49145,0.79528,0.35497,0.41498,0.71498,0.31498 +0.25145,0.57099,0.76037,0.30951,0.51498,0.71498,0.31498 +0.31011,0.64099,0.70442,0.30483,0.61498,0.71498,0.31498 +0.37464,0.67416,0.67321,0.30379,0.71498,0.71498,0.31498 +0.3675,-0.57365,0.75843,0.30938,-0.58502,0.81498,0.31498 +0.31562,-0.49895,0.80689,0.31618,-0.48502,0.81498,0.31498 +0.27118,-0.41817,0.84861,0.32404,-0.38502,0.81498,0.31498 +0.23535,-0.33181,0.88306,0.33181,-0.28502,0.81498,0.31498 +0.20914,-0.24073,0.90964,0.33854,-0.18502,0.81498,0.31498 +0.19357,-0.097095,0.93379,0.34441,-0.085017,0.81498,0.31498 +0.18995,0.04793,0.93717,0.34557,0.014983,0.81498,0.31498 +0.19766,0.14333,0.92817,0.34345,0.11498,0.81498,0.31498 +0.21622,0.23698,0.91056,0.33869,0.21498,0.81498,0.31498 +0.2451,0.32978,0.88458,0.32978,0.31498,0.81498,0.31498 +0.28353,0.41853,0.85016,0.31947,0.41498,0.81498,0.31498 +0.33045,0.49943,0.80826,0.31192,0.51498,0.81498,0.31498 +0.38464,0.57414,0.75936,0.30617,0.61498,0.81498,0.31498 +0.39786,-0.46249,0.84307,0.27446,-0.48502,0.91498,0.31498 +0.35691,-0.37335,0.86844,0.32623,-0.38502,0.91498,0.31498 +0.3243,-0.28476,0.8986,0.33382,-0.28502,0.91498,0.31498 +0.30081,-0.19227,0.92051,0.34013,-0.18502,0.91498,0.31498 +0.28712,-0.097095,0.93379,0.34441,-0.085017,0.91498,0.31498 +0.28367,0.04793,0.93717,0.34557,0.014983,0.91498,0.31498 +0.29048,0.14333,0.92817,0.34345,0.11498,0.91498,0.31498 +0.30728,0.23698,0.91056,0.33869,0.21498,0.91498,0.31498 +0.33356,0.32978,0.88458,0.32978,0.31498,0.91498,0.31498 +0.36855,0.41618,0.8504,0.32188,0.41498,0.91498,0.31498 +0.39418,-0.14649,0.94406,0.29544,-0.18502,1.015,0.31498 +0.38144,-0.049063,0.95331,0.29798,-0.085017,1.015,0.31498 +0.37802,-0.00024101,0.9544,0.29852,0.014983,1.015,0.31498 +0.38402,0.097571,0.94985,0.29711,0.11498,1.015,0.31498 +0.39927,0.19403,0.93612,0.29332,0.21498,1.015,0.31498 +0.3875,-0.095335,-0.91602,0.38965,-0.085017,-0.98502,0.41498 +0.38415,0.00025697,-0.92022,0.39139,0.014983,-0.98502,0.41498 +0.39015,0.095752,-0.91598,0.38964,0.11498,-0.98502,0.41498 +0.36609,-0.36406,-0.83552,0.41154,-0.38502,-0.88502,0.41498 +0.33381,-0.27765,-0.86337,0.42131,-0.28502,-0.88502,0.41498 +0.31052,-0.18722,-0.88357,0.42924,-0.18502,-0.88502,0.41498 +0.29696,-0.094016,-0.89575,0.43451,-0.085017,-0.88502,0.41498 +0.29357,0.047859,-0.89873,0.43589,0.014983,-0.88502,0.41498 +0.30037,0.1427,-0.89003,0.43299,0.11498,-0.88502,0.41498 +0.31706,0.23519,-0.87323,0.4268,0.21498,-0.88502,0.41498 +0.34314,0.32404,-0.84861,0.41817,0.31498,-0.88502,0.41498 +0.37788,0.40806,-0.81668,0.40806,0.41498,-0.88502,0.41498 +0.37946,-0.55501,-0.73537,0.38883,-0.58502,-0.78502,0.41498 +0.32788,-0.48186,-0.78062,0.39806,-0.48502,-0.78502,0.41498 +0.28386,-0.40318,-0.81889,0.4085,-0.38502,-0.78502,0.41498 +0.24848,-0.31947,-0.85016,0.41853,-0.28502,-0.78502,0.41498 +0.22267,-0.23133,-0.87414,0.42704,-0.18502,-0.78502,0.41498 +0.20728,-0.094016,-0.89575,0.43451,-0.085017,-0.78502,0.41498 +0.2037,0.046813,-0.89922,0.43498,0.014983,-0.78502,0.41498 +0.21132,0.13996,-0.89161,0.43063,0.11498,-0.78502,0.41498 +0.22961,0.23135,-0.87589,0.42343,0.21498,-0.78502,0.41498 +0.25808,0.31957,-0.85231,0.41405,0.31498,-0.78502,0.41498 +0.29599,0.40343,-0.82127,0.40343,0.41498,-0.78502,0.41498 +0.34241,0.48232,-0.78283,0.39312,0.51498,-0.78502,0.41498 +0.39622,0.55563,-0.73695,0.38495,0.61498,-0.78502,0.41498 +0.36934,-0.65428,-0.6531,0.38127,-0.68502,-0.68502,0.41498 +0.30691,-0.58189,-0.69691,0.41918,-0.58502,-0.68502,0.41498 +0.25166,-0.50612,-0.72618,0.4653,-0.48502,-0.68502,0.41498 +0.2042,-0.43361,-0.76383,0.47807,-0.38502,-0.68502,0.41498 +0.16623,-0.3164,-0.80914,0.49516,-0.28502,-0.68502,0.41498 +0.13837,-0.22974,-0.83102,0.50657,-0.18502,-0.68502,0.41498 +0.12145,-0.13696,-0.84482,0.51723,-0.085017,-0.68502,0.41498 +0.11725,0.046749,-0.85243,0.52074,0.014983,-0.68502,0.41498 +0.12563,0.13937,-0.8445,0.5171,0.11498,-0.68502,0.41498 +0.14527,0.22617,-0.83187,0.5068,0.21498,-0.68502,0.41498 +0.17638,0.35519,-0.7952,0.49142,0.31498,-0.68502,0.41498 +0.21799,0.4729,-0.74346,0.4729,0.41498,-0.68502,0.41498 +0.26786,0.54902,-0.72067,0.42333,0.51498,-0.68502,0.41498 +0.32541,0.61335,-0.67062,0.41722,0.61498,-0.68502,0.41498 +0.38947,0.6823,-0.62397,0.38095,0.71498,-0.68502,0.41498 +0.37954,-0.73309,-0.55821,0.38857,-0.78502,-0.58502,0.41498 +0.30691,-0.69731,-0.58141,0.4192,-0.68502,-0.58502,0.41498 +0.24103,-0.63163,-0.63023,0.4515,-0.58502,-0.58502,0.41498 +0.18112,-0.5723,-0.68195,0.45544,-0.48502,-0.58502,0.41498 +0.1296,-0.4653,-0.72618,0.50612,-0.38502,-0.58502,0.41498 +0.087479,-0.38883,-0.73538,0.55501,-0.28502,-0.58502,0.41498 +0.056598,-0.22492,-0.77976,0.58428,-0.18502,-0.58502,0.41498 +0.038318,-0.13652,-0.79289,0.59388,-0.085017,-0.58502,0.41498 +0.033401,0.045784,-0.79895,0.59965,0.014983,-0.58502,0.41498 +0.04243,0.1365,-0.79188,0.59523,0.11498,-0.58502,0.41498 +0.064608,0.30937,-0.75843,0.57365,0.21498,-0.58502,0.41498 +0.09915,0.38857,-0.73309,0.55821,0.31498,-0.58502,0.41498 +0.14364,0.49853,-0.70919,0.49853,0.41498,-0.58502,0.41498 +0.19867,0.60299,-0.65675,0.45286,0.51498,-0.58502,0.41498 +0.26055,0.65744,-0.60351,0.45117,0.61498,-0.58502,0.41498 +0.328,0.69691,-0.58189,0.41918,0.71498,-0.58502,0.41498 +0.32796,-0.78283,-0.48232,0.39312,-0.78502,-0.48502,0.41498 +0.25166,-0.72649,-0.50563,0.46535,-0.68502,-0.48502,0.41498 +0.18112,-0.68274,-0.57129,0.45551,-0.58502,-0.48502,0.41498 +0.11696,-0.60966,-0.60618,0.51074,-0.48502,-0.48502,0.41498 +0.060839,-0.5188,-0.65192,0.55303,-0.38502,-0.48502,0.41498 +0.014627,-0.38255,-0.68289,0.62235,-0.28502,-0.48502,0.41498 +-0.0197,-0.3035,-0.70386,0.64224,-0.18502,-0.48502,0.41498 +-0.039936,-0.13453,-0.73312,0.66666,-0.085017,-0.48502,0.41498 +-0.045514,0.045106,-0.73884,0.67238,0.014983,-0.48502,0.41498 +-0.035902,0.13385,-0.7332,0.66671,0.11498,-0.48502,0.41498 +-0.010553,0.30479,-0.70353,0.64198,0.21498,-0.48502,0.41498 +0.027406,0.45286,-0.65675,0.60299,0.31498,-0.48502,0.41498 +0.076432,0.54543,-0.6364,0.54543,0.41498,-0.48502,0.41498 +0.13582,0.63154,-0.5836,0.51045,0.51498,-0.48502,0.41498 +0.20224,0.7052,-0.54011,0.45933,0.61498,-0.48502,0.41498 +0.27356,0.74364,-0.51371,0.42791,0.71498,-0.48502,0.41498 +0.35127,0.78062,-0.48186,0.39806,0.81498,-0.48502,0.41498 +0.36609,-0.83545,-0.36423,0.41153,-0.88502,-0.38502,0.41498 +0.2839,-0.82128,-0.40343,0.40343,-0.78502,-0.38502,0.41498 +0.2042,-0.76391,-0.43344,0.47809,-0.68502,-0.38502,0.41498 +0.1296,-0.72649,-0.46535,0.50563,-0.58502,-0.38502,0.41498 +0.060839,-0.65199,-0.51882,0.55293,-0.48502,-0.38502,0.41498 +8.9267e-06,-0.56272,-0.56272,0.60555,-0.38502,-0.38502,0.41498 +-0.050272,-0.45117,-0.60351,0.65744,-0.28502,-0.38502,0.41498 +-0.088239,-0.3035,-0.64224,0.70386,-0.18502,-0.38502,0.41498 +-0.11126,-0.13453,-0.66666,0.73312,-0.085017,-0.38502,0.41498 +-0.11741,0.045107,-0.67237,0.73884,0.014983,-0.38502,0.41498 +-0.10617,0.22161,-0.6568,0.72076,0.11498,-0.38502,0.41498 +-0.078584,0.38248,-0.62358,0.6818,0.21498,-0.38502,0.41498 +-0.036707,0.45113,-0.60207,0.65878,0.31498,-0.38502,0.41498 +0.017047,0.58147,-0.55721,0.5928,0.41498,-0.38502,0.41498 +0.080883,0.67085,-0.52233,0.52644,0.51498,-0.38502,0.41498 +0.15165,0.74584,-0.46849,0.47353,0.61498,-0.38502,0.41498 +0.22754,0.78062,-0.39806,0.48186,0.71498,-0.38502,0.41498 +0.3084,0.81889,-0.40318,0.4085,0.81498,-0.38502,0.41498 +0.3913,0.83552,-0.36406,0.41154,0.91498,-0.38502,0.41498 +0.33381,-0.86326,-0.27802,0.42129,-0.88502,-0.28502,0.41498 +0.2485,-0.85231,-0.31957,0.41405,-0.78502,-0.28502,0.41498 +0.16629,-0.81063,-0.31199,0.49553,-0.68502,-0.28502,0.41498 +0.087506,-0.73309,-0.38856,0.55821,-0.58502,-0.28502,0.41498 +0.014638,-0.6818,-0.38248,0.62358,-0.48502,-0.28502,0.41498 +-0.050272,-0.60351,-0.45117,0.65744,-0.38502,-0.28502,0.41498 +-0.10591,-0.46849,-0.47353,0.74584,-0.28502,-0.28502,0.41498 +-0.1482,-0.30951,-0.57099,0.76037,-0.18502,-0.28502,0.41498 +-0.17368,-0.13653,-0.59388,0.79289,-0.085017,-0.28502,0.41498 +-0.18038,0.045785,-0.59965,0.79895,0.014983,-0.28502,0.41498 +-0.16765,0.22486,-0.58632,0.77825,0.11498,-0.28502,0.41498 +-0.1368,0.39312,-0.48232,0.78283,0.21498,-0.28502,0.41498 +-0.090226,0.53862,-0.45739,0.70759,0.31498,-0.28502,0.41498 +-0.032184,0.60207,-0.45114,0.65878,0.41498,-0.28502,0.41498 +0.036022,0.73449,-0.38489,0.5589,0.51498,-0.28502,0.41498 +0.10997,0.78008,-0.39294,0.48691,0.61498,-0.28502,0.41498 +0.19048,0.80914,-0.3164,0.49516,0.71498,-0.28502,0.41498 +0.27396,0.85016,-0.31947,0.41853,0.81498,-0.28502,0.41498 +0.35977,0.86337,-0.27765,0.42131,0.91498,-0.28502,0.41498 +0.31052,-0.88346,-0.1878,0.42922,-0.88502,-0.18502,0.41498 +0.22268,-0.87589,-0.23135,0.42342,-0.78502,-0.18502,0.41498 +0.13847,-0.82922,-0.22964,0.50956,-0.68502,-0.18502,0.41498 +0.056626,-0.77825,-0.22486,0.58632,-0.58502,-0.18502,0.41498 +-0.019686,-0.70354,-0.30479,0.64198,-0.48502,-0.18502,0.41498 +-0.088239,-0.64224,-0.3035,0.70386,-0.38502,-0.18502,0.41498 +-0.1482,-0.57099,-0.30951,0.76037,-0.28502,-0.18502,0.41498 +-0.19373,-0.4085,-0.40318,0.81889,-0.18502,-0.18502,0.41498 +-0.22187,-0.14273,-0.43057,0.8912,-0.085017,-0.18502,0.41498 +-0.2291,0.047861,-0.43589,0.89873,0.014983,-0.18502,0.41498 +-0.21506,0.23519,-0.4268,0.87323,0.11498,-0.18502,0.41498 +-0.18144,0.40806,-0.40806,0.81668,0.21498,-0.18502,0.41498 +-0.13104,0.57144,-0.30618,0.76139,0.31498,-0.18502,0.41498 +-0.06899,0.64125,-0.30348,0.70476,0.41498,-0.18502,0.41498 +0.0022125,0.75936,-0.30617,0.57414,0.51498,-0.18502,0.41498 +0.080243,0.80569,-0.22577,0.54762,0.61498,-0.18502,0.41498 +0.16327,0.83102,-0.22974,0.50658,0.71498,-0.18502,0.41498 +0.24886,0.88357,-0.18722,0.42924,0.81498,-0.18502,0.41498 +0.33709,0.88357,-0.18722,0.42924,0.91498,-0.18502,0.41498 +0.3875,-0.91598,-0.095752,0.38964,-0.98502,-0.085017,0.41498 +0.29696,-0.89567,-0.094864,0.43449,-0.88502,-0.085017,0.41498 +0.20728,-0.89567,-0.094864,0.43449,-0.78502,-0.085017,0.41498 +0.12146,-0.8445,-0.13937,0.5171,-0.68502,-0.085017,0.41498 +0.03834,-0.79188,-0.13651,0.59523,-0.58502,-0.085017,0.41498 +-0.039928,-0.73269,-0.13452,0.66714,-0.48502,-0.085017,0.41498 +-0.11126,-0.66666,-0.13453,0.73312,-0.38502,-0.085017,0.41498 +-0.17368,-0.59388,-0.13652,0.79289,-0.28502,-0.085017,0.41498 +-0.22187,-0.43057,-0.14273,0.8912,-0.18502,-0.085017,0.41498 +-0.25227,-0.14935,-0.15102,0.97718,-0.085017,-0.085017,0.41498 +-0.25997,0.04998,-0.15122,0.98724,0.014983,-0.085017,0.41498 +-0.24494,0.24675,-0.14659,0.95793,0.11498,-0.085017,0.41498 +-0.20893,0.43063,-0.13996,0.89161,0.21498,-0.085017,0.41498 +-0.15586,0.59398,-0.13477,0.79311,0.31498,-0.085017,0.41498 +-0.091262,0.66671,-0.13385,0.7332,0.41498,-0.085017,0.41498 +-0.017163,0.79208,-0.13477,0.59535,0.51498,-0.085017,0.41498 +0.062283,0.81973,-0.13689,0.55615,0.61498,-0.085017,0.41498 +0.14676,0.84481,-0.13696,0.51723,0.71498,-0.085017,0.41498 +0.23412,0.89575,-0.094016,0.4345,0.81498,-0.085017,0.41498 +0.32388,0.89575,-0.094016,0.4345,0.91498,-0.085017,0.41498 +0.38415,-0.92022,-0.00025777,0.39139,-0.98502,0.014983,0.41498 +0.29357,-0.89877,0.046817,0.43591,-0.88502,0.014983,0.41498 +0.2037,-0.89877,0.046817,0.43591,-0.78502,0.014983,0.41498 +0.11724,-0.85247,0.045832,0.52077,-0.68502,0.014983,0.41498 +0.033393,-0.79932,0.045785,0.59915,-0.58502,0.014983,0.41498 +-0.045517,-0.739,0.045107,0.6722,-0.48502,0.014983,0.41498 +-0.11741,-0.67237,0.045106,0.73884,-0.38502,0.014983,0.41498 +-0.18038,-0.59965,0.045784,0.79895,-0.28502,0.014983,0.41498 +-0.2291,-0.43589,0.047859,0.89873,-0.18502,0.014983,0.41498 +-0.25997,-0.15122,0.049982,0.98724,-0.085017,0.014983,0.41498 +-0.26782,0.050878,0.05064,0.99742,0.014983,0.014983,0.41498 +-0.25256,0.25053,0.049032,0.96687,0.11498,0.014983,0.41498 +-0.21606,0.43591,0.046814,0.89877,0.21498,0.014983,0.41498 +-0.16243,0.59967,0.045133,0.79897,0.31498,0.014983,0.41498 +-0.097262,0.73901,0.044856,0.6722,0.41498,0.014983,0.41498 +-0.022557,0.79935,0.045132,0.59916,0.51498,0.014983,0.41498 +0.057545,0.8269,0.045861,0.56048,0.61498,0.014983,0.41498 +0.1428,0.85243,0.04675,0.52075,0.71498,0.014983,0.41498 +0.23063,0.89873,0.047861,0.43589,0.81498,0.014983,0.41498 +0.32051,0.89976,0.0005235,0.43639,0.91498,0.014983,0.41498 +0.39015,-0.91602,0.095335,0.38965,-0.98502,0.11498,0.41498 +0.30035,-0.89041,0.13997,0.4331,-0.88502,0.11498,0.41498 +0.21131,-0.89041,0.13997,0.4331,-0.78502,0.11498,0.41498 +0.12556,-0.84572,0.1394,0.51509,-0.68502,0.11498,0.41498 +0.042409,-0.79289,0.13652,0.59388,-0.58502,0.11498,0.41498 +-0.035904,-0.73312,0.13453,0.66666,-0.48502,0.11498,0.41498 +-0.10617,-0.6568,0.22161,0.72076,-0.38502,0.11498,0.41498 +-0.16765,-0.58632,0.22486,0.77825,-0.28502,0.11498,0.41498 +-0.21506,-0.4268,0.23519,0.87323,-0.18502,0.11498,0.41498 +-0.24494,-0.14659,0.24675,0.95793,-0.085017,0.11498,0.41498 +-0.25256,0.049033,0.25053,0.96687,0.014983,0.11498,0.41498 +-0.23783,0.24564,0.24234,0.93858,0.11498,0.11498,0.41498 +-0.2024,0.42704,0.23133,0.87414,0.21498,0.11498,0.41498 +-0.15015,0.5866,0.22231,0.77876,0.31498,0.11498,0.41498 +-0.086492,0.72162,0.22059,0.6562,0.41498,0.11498,0.41498 +-0.013109,0.79311,0.13476,0.59398,0.51498,0.11498,0.41498 +0.066388,0.81993,0.13689,0.55585,0.61498,0.11498,0.41498 +0.15094,0.8445,0.13937,0.5171,0.71498,0.11498,0.41498 +0.23804,0.89161,0.13997,0.43063,0.81498,0.11498,0.41498 +0.32704,0.89003,0.14269,0.43299,0.91498,0.11498,0.41498 +0.31701,-0.87414,0.23133,0.42704,-0.88502,0.21498,0.41498 +0.2296,-0.87414,0.23133,0.42704,-0.78502,0.21498,0.41498 +0.14526,-0.83102,0.22974,0.50657,-0.68502,0.21498,0.41498 +0.064574,-0.76037,0.30951,0.57099,-0.58502,0.21498,0.41498 +-0.010566,-0.70442,0.30483,0.64099,-0.48502,0.21498,0.41498 +-0.078584,-0.62358,0.38248,0.6818,-0.38502,0.21498,0.41498 +-0.1368,-0.48232,0.39312,0.78283,-0.28502,0.21498,0.41498 +-0.18144,-0.40806,0.40806,0.81668,-0.18502,0.21498,0.41498 +-0.20893,-0.13997,0.43063,0.89161,-0.085017,0.21498,0.41498 +-0.21606,0.046816,0.43591,0.89877,0.014983,0.21498,0.41498 +-0.2024,0.23133,0.42704,0.87414,0.11498,0.21498,0.41498 +-0.16941,0.4085,0.40318,0.81889,0.21498,0.21498,0.41498 +-0.12027,0.5589,0.38489,0.73449,0.31498,0.21498,0.41498 +-0.059896,0.70476,0.30348,0.64125,0.41498,0.21498,0.41498 +0.011419,0.76139,0.30618,0.57143,0.51498,0.21498,0.41498 +0.087669,0.7854,0.31102,0.53518,0.61498,0.21498,0.41498 +0.1702,0.82922,0.22964,0.50956,0.71498,0.21498,0.41498 +0.25586,0.87589,0.23136,0.42342,0.81498,0.21498,0.41498 +0.34323,0.87323,0.23519,0.4268,0.91498,0.21498,0.41498 +0.34307,-0.85016,0.31947,0.41853,-0.88502,0.31498,0.41498 +0.25806,-0.85016,0.31947,0.41853,-0.78502,0.31498,0.41498 +0.17638,-0.78008,0.39294,0.48691,-0.68502,0.31498,0.41498 +0.09913,-0.73538,0.38883,0.55501,-0.58502,0.31498,0.41498 +0.027396,-0.65799,0.453,0.60154,-0.48502,0.31498,0.41498 +-0.036707,-0.60207,0.45114,0.65878,-0.38502,0.31498,0.41498 +-0.090226,-0.45739,0.53862,0.70758,-0.28502,0.31498,0.41498 +-0.13104,-0.30618,0.57143,0.76139,-0.18502,0.31498,0.41498 +-0.15586,-0.13477,0.59398,0.79311,-0.085017,0.31498,0.41498 +-0.16243,0.045133,0.59967,0.79897,0.014983,0.31498,0.41498 +-0.15015,0.22231,0.5866,0.77876,0.11498,0.31498,0.41498 +-0.12027,0.38489,0.5589,0.73449,0.21498,0.31498,0.41498 +-0.075427,0.52644,0.52233,0.67085,0.31498,0.31498,0.41498 +-0.018666,0.65878,0.45114,0.60207,0.41498,0.31498,0.41498 +0.048069,0.70311,0.46096,0.54144,0.51498,0.31498,0.41498 +0.12176,0.78283,0.39312,0.48232,0.61498,0.31498,0.41498 +0.20004,0.7952,0.3552,0.49143,0.71498,0.31498,0.41498 +0.28362,0.85231,0.31957,0.41405,0.81498,0.31498,0.41498 +0.36857,0.84861,0.32404,0.41817,0.91498,0.31498,0.41498 +0.37783,-0.81889,0.40584,0.40584,-0.88502,0.41498,0.41498 +0.29594,-0.81889,0.40584,0.40584,-0.78502,0.41498,0.41498 +0.21792,-0.74585,0.47102,0.47102,-0.68502,0.41498,0.41498 +0.14364,-0.70895,0.49869,0.49869,-0.58502,0.41498,0.41498 +0.076432,-0.67085,0.52438,0.52438,-0.48502,0.41498,0.41498 +0.017047,-0.55722,0.58715,0.58716,-0.38502,0.41498,0.41498 +-0.032184,-0.45114,0.65878,0.60207,-0.28502,0.41498,0.41498 +-0.06899,-0.30348,0.64125,0.70476,-0.18502,0.41498,0.41498 +-0.091262,-0.13385,0.66671,0.7332,-0.085017,0.41498,0.41498 +-0.097263,0.044859,0.67238,0.73884,0.014983,0.41498,0.41498 +-0.086496,0.2206,0.65695,0.72094,0.11498,0.41498,0.41498 +-0.059899,0.30483,0.70442,0.64099,0.21498,0.41498,0.41498 +-0.018667,0.45117,0.65744,0.60351,0.31498,0.41498,0.41498 +0.033755,0.58112,0.57546,0.57546,0.41498,0.41498,0.41498 +0.096611,0.67338,0.52276,0.52276,0.51498,0.41498,0.41498 +0.16573,0.74853,0.46889,0.46889,0.61498,0.41498,0.41498 +0.24027,0.78356,0.43934,0.43934,0.71498,0.41498,0.41498 +0.3206,0.82127,0.40343,0.40343,0.81498,0.41498,0.41498 +0.34237,-0.78008,0.48691,0.39294,-0.78502,0.51498,0.41498 +0.26786,-0.70493,0.54224,0.45722,-0.68502,0.51498,0.41498 +0.19865,-0.65799,0.60154,0.453,-0.58502,0.51498,0.41498 +0.13588,-0.58233,0.62971,0.51415,-0.48502,0.51498,0.41498 +0.080909,-0.5257,0.66879,0.5257,-0.38502,0.51498,0.41498 +0.036062,-0.38495,0.73695,0.55563,-0.28502,0.51498,0.41498 +0.0022212,-0.30938,0.75843,0.57365,-0.18502,0.51498,0.41498 +-0.017147,-0.13477,0.79311,0.59398,-0.085017,0.51498,0.41498 +-0.022563,0.045133,0.79897,0.59967,0.014983,0.51498,0.41498 +-0.01312,0.13652,0.79289,0.59388,0.11498,0.51498,0.41498 +0.011387,0.30617,0.75936,0.57414,0.21498,0.51498,0.41498 +0.048054,0.45723,0.70493,0.54224,0.31498,0.51498,0.41498 +0.096535,0.52438,0.67085,0.52438,0.41498,0.51498,0.41498 +0.15339,0.60966,0.60618,0.51074,0.51498,0.51498,0.41498 +0.21859,0.68274,0.57129,0.45551,0.61498,0.51498,0.41498 +0.28925,0.72067,0.54902,0.42333,0.71498,0.51498,0.41498 +0.36587,0.78283,0.48232,0.39312,0.81498,0.51498,0.41498 +0.39616,-0.73449,0.5589,0.3849,-0.78502,0.61498,0.41498 +0.32541,-0.67064,0.61337,0.41716,-0.68502,0.61498,0.41498 +0.26058,-0.60207,0.65878,0.45114,-0.58502,0.61498,0.41498 +0.20232,-0.53862,0.70759,0.45739,-0.48502,0.61498,0.41498 +0.15168,-0.46889,0.74853,0.46889,-0.38502,0.61498,0.41498 +0.10998,-0.35519,0.7952,0.49143,-0.28502,0.61498,0.41498 +0.080243,-0.22578,0.80598,0.54719,-0.18502,0.61498,0.41498 +0.062283,-0.13689,0.81993,0.55585,-0.085017,0.61498,0.41498 +0.057545,0.045861,0.82682,0.56059,0.014983,0.61498,0.41498 +0.066388,0.13689,0.81973,0.55615,0.11498,0.61498,0.41498 +0.087669,0.31101,0.78504,0.53571,0.21498,0.61498,0.41498 +0.12175,0.39294,0.78008,0.48691,0.31498,0.61498,0.41498 +0.16569,0.47102,0.74585,0.47102,0.41498,0.61498,0.41498 +0.21859,0.5723,0.68195,0.45544,0.51498,0.61498,0.41498 +0.27884,0.63163,0.63023,0.4515,0.61498,0.61498,0.41498 +0.34586,0.71006,0.59017,0.38408,0.71498,0.61498,0.41498 +0.38948,-0.62275,0.68343,0.38092,-0.68502,0.71498,0.41498 +0.328,-0.58141,0.69731,0.4192,-0.58502,0.71498,0.41498 +0.27356,-0.51345,0.74384,0.42788,-0.48502,0.71498,0.41498 +0.22755,-0.39765,0.77808,0.48628,-0.38502,0.71498,0.41498 +0.19052,-0.31618,0.8069,0.49895,-0.28502,0.71498,0.41498 +0.16332,-0.22964,0.82922,0.50956,-0.18502,0.71498,0.41498 +0.14676,-0.13937,0.8445,0.5171,-0.085017,0.71498,0.41498 +0.14279,0.045834,0.85247,0.52077,0.014983,0.71498,0.41498 +0.15091,0.1394,0.84573,0.51509,0.11498,0.71498,0.41498 +0.17016,0.22974,0.83102,0.50657,0.21498,0.71498,0.41498 +0.20004,0.35497,0.79528,0.49145,0.31498,0.71498,0.41498 +0.24027,0.47102,0.74585,0.47102,0.41498,0.71498,0.41498 +0.28925,0.54902,0.72067,0.42333,0.51498,0.71498,0.41498 +0.34586,0.59112,0.70928,0.38404,0.61498,0.71498,0.41498 +0.35133,-0.48628,0.77808,0.39765,-0.48502,0.81498,0.41498 +0.30846,-0.40806,0.81668,0.40806,-0.38502,0.81498,0.41498 +0.274,-0.32404,0.8486,0.41817,-0.28502,0.81498,0.41498 +0.24886,-0.1878,0.88346,0.42922,-0.18502,0.81498,0.41498 +0.23412,-0.094865,0.89567,0.43449,-0.085017,0.81498,0.41498 +0.23063,0.046814,0.89877,0.43591,0.014983,0.81498,0.41498 +0.23799,0.13997,0.89041,0.4331,0.11498,0.81498,0.41498 +0.25579,0.23133,0.87414,0.42704,0.21498,0.81498,0.41498 +0.28353,0.31947,0.85016,0.41853,0.31498,0.81498,0.41498 +0.32048,0.40584,0.81889,0.40584,0.41498,0.81498,0.41498 +0.36575,0.48691,0.78008,0.39294,0.51498,0.81498,0.41498 +0.3913,-0.36423,0.83545,0.41153,-0.38502,0.91498,0.41498 +0.35977,-0.27802,0.86326,0.42129,-0.28502,0.91498,0.41498 +0.33709,-0.1878,0.88346,0.42922,-0.18502,0.91498,0.41498 +0.32388,-0.094865,0.89567,0.43449,-0.085017,0.91498,0.41498 +0.32051,-0.00052316,0.89976,0.43639,0.014983,0.91498,0.41498 +0.32703,0.13997,0.89041,0.4331,0.11498,0.91498,0.41498 +0.34321,0.23332,0.87453,0.42516,0.21498,0.91498,0.41498 +0.36855,0.32188,0.8504,0.41618,0.31498,0.91498,0.41498 +0.37835,-0.27108,-0.82039,0.50346,-0.28502,-0.88502,0.51498 +0.35609,-0.18296,-0.83868,0.51297,-0.18502,-0.88502,0.51498 +0.34312,-0.091951,-0.84973,0.51915,-0.085017,-0.88502,0.51498 +0.33981,0.00045736,-0.85336,0.52131,0.014983,-0.88502,0.51498 +0.34624,0.13937,-0.8445,0.5171,0.11498,-0.88502,0.51498 +0.36215,0.22965,-0.82922,0.50956,0.21498,-0.88502,0.51498 +0.38708,0.31618,-0.8069,0.49895,0.31498,-0.88502,0.51498 +0.37267,-0.46849,-0.74584,0.47353,-0.48502,-0.78502,0.51498 +0.3306,-0.39294,-0.78008,0.48691,-0.38502,-0.78502,0.51498 +0.29689,-0.31192,-0.80826,0.49943,-0.28502,-0.78502,0.51498 +0.27236,-0.18296,-0.83868,0.51297,-0.18502,-0.78502,0.51498 +0.25799,-0.091951,-0.84973,0.51915,-0.085017,-0.78502,0.51498 +0.25457,0.045834,-0.85293,0.52,0.014983,-0.78502,0.51498 +0.26176,0.13696,-0.84607,0.51518,0.11498,-0.78502,0.51498 +0.27914,0.22617,-0.83187,0.5068,0.21498,-0.78502,0.51498 +0.30625,0.31198,-0.81063,0.49552,0.31498,-0.78502,0.51498 +0.34241,0.39312,-0.78283,0.48232,0.41498,-0.78502,0.51498 +0.38678,0.46889,-0.74853,0.46889,0.51498,-0.78502,0.51498 +0.35272,-0.56278,-0.66854,0.48614,-0.58502,-0.68502,0.51498 +0.30017,-0.49218,-0.68859,0.53254,-0.48502,-0.68502,0.51498 +0.2554,-0.38883,-0.73538,0.55501,-0.38502,-0.68502,0.51498 +0.21939,-0.30951,-0.76037,0.57099,-0.28502,-0.68502,0.51498 +0.19303,-0.22231,-0.77876,0.5866,-0.18502,-0.68502,0.51498 +0.17706,-0.090368,-0.7965,0.59785,-0.085017,-0.68502,0.51498 +0.17326,0.045784,-0.79895,0.59965,0.014983,-0.68502,0.51498 +0.18114,0.1365,-0.79188,0.59523,0.11498,-0.68502,0.51498 +0.19978,0.2223,-0.78032,0.58453,0.21498,-0.68502,0.51498 +0.22872,0.34771,-0.74796,0.56537,0.31498,-0.68502,0.51498 +0.26786,0.42333,-0.72067,0.54902,0.41498,-0.68502,0.51498 +0.31552,0.5257,-0.66879,0.5257,0.51498,-0.68502,0.51498 +0.37021,0.59258,-0.64467,0.48296,0.61498,-0.68502,0.51498 +0.35272,-0.66871,-0.56244,0.4863,-0.68502,-0.58502,0.51498 +0.28962,-0.60966,-0.60618,0.51074,-0.58502,-0.58502,0.51498 +0.23343,-0.51472,-0.63229,0.57902,-0.48502,-0.58502,0.51498 +0.18507,-0.453,-0.65799,0.60154,-0.38502,-0.58502,0.51498 +0.14539,-0.34317,-0.69393,0.633,-0.28502,-0.58502,0.51498 +0.11725,-0.22163,-0.72143,0.65606,-0.18502,-0.58502,0.51498 +0.10005,-0.13386,-0.73276,0.66719,-0.085017,-0.58502,0.51498 +0.095607,0.045106,-0.73884,0.67238,0.014983,-0.58502,0.51498 +0.10409,0.13452,-0.73269,0.66714,0.11498,-0.58502,0.51498 +0.12407,0.26294,-0.71326,0.64971,0.21498,-0.58502,0.51498 +0.15664,0.38247,-0.68181,0.62358,0.31498,-0.58502,0.51498 +0.19867,0.45286,-0.65675,0.60299,0.41498,-0.58502,0.51498 +0.24924,0.54543,-0.6364,0.54543,0.51498,-0.58502,0.51498 +0.30838,0.63154,-0.5836,0.51045,0.61498,-0.58502,0.51498 +0.37284,0.68859,-0.53254,0.49219,0.71498,-0.58502,0.51498 +0.37273,-0.74853,-0.46889,0.46889,-0.78502,-0.48502,0.51498 +0.30017,-0.68873,-0.49194,0.53259,-0.68502,-0.48502,0.51498 +0.23344,-0.62971,-0.51415,0.58233,-0.58502,-0.48502,0.51498 +0.17311,-0.56272,-0.56272,0.60555,-0.48502,-0.48502,0.51498 +0.12097,-0.453,-0.60154,0.65799,-0.38502,-0.48502,0.51498 +0.078707,-0.38095,-0.62397,0.6823,-0.28502,-0.48502,0.51498 +0.047069,-0.22162,-0.65606,0.72143,-0.18502,-0.48502,0.51498 +0.028737,-0.13386,-0.66719,0.73276,-0.085017,-0.48502,0.51498 +0.023715,0.045107,-0.67237,0.73884,0.014983,-0.48502,0.51498 +0.032761,0.13385,-0.66671,0.7332,0.11498,-0.48502,0.51498 +0.05549,0.30479,-0.64198,0.70354,0.21498,-0.48502,0.51498 +0.090152,0.38093,-0.62275,0.68343,0.31498,-0.48502,0.51498 +0.13588,0.51415,-0.58233,0.62971,0.41498,-0.48502,0.51498 +0.1902,0.58147,-0.55721,0.5928,0.51498,-0.48502,0.51498 +0.25285,0.65192,-0.5188,0.55303,0.61498,-0.48502,0.51498 +0.32123,0.72618,-0.4653,0.50612,0.71498,-0.48502,0.51498 +0.39502,0.74584,-0.46849,0.47353,0.81498,-0.48502,0.51498 +0.33063,-0.78283,-0.39312,0.48232,-0.78502,-0.38502,0.51498 +0.25543,-0.73695,-0.38495,0.55563,-0.68502,-0.38502,0.51498 +0.1851,-0.65675,-0.45286,0.60299,-0.58502,-0.38502,0.51498 +0.12097,-0.60154,-0.453,0.65799,-0.48502,-0.38502,0.51498 +0.065108,-0.52438,-0.52438,0.67085,-0.38502,-0.38502,0.51498 +0.019346,-0.38883,-0.55501,0.73537,-0.28502,-0.38502,0.51498 +-0.014992,-0.30617,-0.57414,0.75936,-0.18502,-0.38502,0.51498 +-0.035004,-0.13477,-0.59535,0.79208,-0.085017,-0.38502,0.51498 +-0.040521,0.045785,-0.59965,0.79895,0.014983,-0.38502,0.51498 +-0.030908,0.13477,-0.59398,0.79311,0.11498,-0.38502,0.51498 +-0.005705,0.30618,-0.57144,0.76139,0.21498,-0.38502,0.51498 +0.031845,0.46095,-0.54144,0.70311,0.31498,-0.38502,0.51498 +0.080909,0.5257,-0.5257,0.66878,0.41498,-0.38502,0.51498 +0.13913,0.63023,-0.4515,0.63163,0.51498,-0.38502,0.51498 +0.20494,0.68195,-0.45544,0.5723,0.61498,-0.38502,0.51498 +0.27744,0.73538,-0.38883,0.55501,0.71498,-0.38502,0.51498 +0.35397,0.78008,-0.39294,0.48691,0.81498,-0.38502,0.51498 +0.37835,-0.82028,-0.27147,0.50343,-0.88502,-0.28502,0.51498 +0.2969,-0.81063,-0.31199,0.49553,-0.78502,-0.28502,0.51498 +0.21947,-0.76139,-0.30618,0.57144,-0.68502,-0.28502,0.51498 +0.14539,-0.6939,-0.34328,0.63298,-0.58502,-0.28502,0.51498 +0.078707,-0.62397,-0.38095,0.6823,-0.48502,-0.28502,0.51498 +0.019346,-0.55501,-0.38883,0.73538,-0.38502,-0.28502,0.51498 +-0.030677,-0.40318,-0.4085,0.81889,-0.28502,-0.28502,0.51498 +-0.067346,-0.3164,-0.49516,0.80914,-0.18502,-0.28502,0.51498 +-0.089359,-0.1394,-0.51509,0.84572,-0.085017,-0.28502,0.51498 +-0.09537,0.04675,-0.52075,0.85243,0.014983,-0.28502,0.51498 +-0.084835,0.22964,-0.50956,0.82923,0.11498,-0.28502,0.51498 +-0.057842,0.31957,-0.41405,0.85231,0.21498,-0.28502,0.51498 +-0.016536,0.48232,-0.39312,0.78283,0.31498,-0.28502,0.51498 +0.036062,0.55563,-0.38495,0.73695,0.41498,-0.28502,0.51498 +0.097488,0.6531,-0.38127,0.65428,0.51498,-0.28502,0.51498 +0.16649,0.73257,-0.30579,0.60814,0.61498,-0.28502,0.51498 +0.24217,0.76037,-0.30951,0.57099,0.71498,-0.28502,0.51498 +0.32111,0.82039,-0.27108,0.50346,0.81498,-0.28502,0.51498 +0.35609,-0.83858,-0.1835,0.51294,-0.88502,-0.18502,0.51498 +0.27236,-0.83858,-0.1835,0.51294,-0.78502,-0.18502,0.51498 +0.19308,-0.77825,-0.22486,0.58632,-0.68502,-0.18502,0.51498 +0.11727,-0.72076,-0.22161,0.6568,-0.58502,-0.18502,0.51498 +0.047069,-0.65606,-0.22162,0.72143,-0.48502,-0.18502,0.51498 +-0.014992,-0.57414,-0.30617,0.75936,-0.38502,-0.18502,0.51498 +-0.067346,-0.49516,-0.3164,0.80914,-0.28502,-0.18502,0.51498 +-0.106,-0.33203,-0.32754,0.88458,-0.18502,-0.18502,0.51498 +-0.12969,-0.14606,-0.34086,0.9287,-0.085017,-0.18502,0.51498 +-0.13609,0.048971,-0.34556,0.93712,0.014983,-0.18502,0.51498 +-0.12461,0.24073,-0.33854,0.90964,0.11498,-0.18502,0.51498 +-0.095995,0.32764,-0.32764,0.88618,0.21498,-0.18502,0.51498 +-0.052376,0.49895,-0.31618,0.8069,0.31498,-0.18502,0.51498 +0.0022211,0.57365,-0.30938,0.75843,0.41498,-0.18502,0.51498 +0.06681,0.68929,-0.22083,0.69001,0.51498,-0.18502,0.51498 +0.13889,0.75086,-0.22219,0.62196,0.61498,-0.18502,0.51498 +0.21637,0.77876,-0.22231,0.5866,0.71498,-0.18502,0.51498 +0.29733,0.83868,-0.18296,0.51297,0.81498,-0.18502,0.51498 +0.38139,0.86228,-0.18508,0.4714,0.91498,-0.18502,0.51498 +0.34312,-0.84966,-0.092705,0.51912,-0.88502,-0.085017,0.51498 +0.25799,-0.84966,-0.092705,0.51912,-0.78502,-0.085017,0.51498 +0.17706,-0.79645,-0.090914,0.59783,-0.68502,-0.085017,0.51498 +0.10005,-0.73269,-0.13452,0.66714,-0.58502,-0.085017,0.51498 +0.028737,-0.66719,-0.13386,0.73276,-0.48502,-0.085017,0.51498 +-0.035004,-0.59535,-0.13477,0.79208,-0.38502,-0.085017,0.51498 +-0.089359,-0.51509,-0.1394,0.84572,-0.28502,-0.085017,0.51498 +-0.12969,-0.34086,-0.14606,0.9287,-0.18502,-0.085017,0.51498 +-0.15455,-0.14935,-0.15102,0.97718,-0.085017,-0.085017,0.51498 +-0.16125,0.050618,-0.15185,0.98711,0.014983,-0.085017,0.51498 +-0.14918,0.24903,-0.14893,0.95698,0.11498,-0.085017,0.51498 +-0.1194,0.34088,-0.14332,0.92912,0.21498,-0.085017,0.51498 +-0.073847,0.51614,-0.13817,0.84529,0.31498,-0.085017,0.51498 +-0.017147,0.59398,-0.13477,0.79311,0.41498,-0.085017,0.51498 +0.048783,0.7005,-0.134,0.70096,0.51498,-0.085017,0.51498 +0.12202,0.76342,-0.13479,0.63168,0.61498,-0.085017,0.51498 +0.20084,0.7965,-0.090369,0.59785,0.71498,-0.085017,0.51498 +0.28348,0.84972,-0.091951,0.51915,0.81498,-0.085017,0.51498 +0.36868,0.87387,-0.093099,0.47715,0.91498,-0.085017,0.51498 +0.33981,-0.85336,-0.00045949,0.52132,-0.88502,0.014983,0.51498 +0.25457,-0.85247,0.045832,0.52077,-0.78502,0.014983,0.51498 +0.17326,-0.79897,0.045132,0.59967,-0.68502,0.014983,0.51498 +0.095604,-0.73884,0.044858,0.67238,-0.58502,0.014983,0.51498 +0.023715,-0.67237,0.045106,0.73884,-0.48502,0.014983,0.51498 +-0.040521,-0.59965,0.045784,0.79895,-0.38502,0.014983,0.51498 +-0.09537,-0.52075,0.04675,0.85243,-0.28502,0.014983,0.51498 +-0.13609,-0.34555,0.048971,0.93712,-0.18502,0.014983,0.51498 +-0.16125,-0.15185,0.050616,0.98711,-0.085017,0.014983,0.51498 +-0.16807,0.050878,0.05064,0.99742,0.014983,0.014983,0.51498 +-0.15586,0.24966,0.04994,0.96705,0.11498,0.014983,0.51498 +-0.12575,0.34557,0.047929,0.93717,0.21498,0.014983,0.51498 +-0.079782,0.52077,0.045835,0.85247,0.31498,0.014983,0.51498 +-0.022563,0.59967,0.045133,0.79897,0.41498,0.014983,0.51498 +0.043908,0.70648,0.044908,0.70631,0.51498,0.014983,0.51498 +0.11775,0.76996,0.04517,0.63649,0.61498,0.014983,0.51498 +0.1972,0.79895,0.045784,0.59965,0.71498,0.014983,0.51498 +0.28011,0.85243,0.04675,0.52075,0.81498,0.014983,0.51498 +0.36539,0.87772,0.00024134,0.47918,0.91498,0.014983,0.51498 +0.34624,-0.84482,0.13696,0.51723,-0.88502,0.11498,0.51498 +0.26175,-0.84482,0.13696,0.51723,-0.78502,0.11498,0.51498 +0.18109,-0.79208,0.13477,0.59535,-0.68502,0.11498,0.51498 +0.10407,-0.73312,0.13453,0.66666,-0.58502,0.11498,0.51498 +0.032761,-0.66671,0.13385,0.7332,-0.48502,0.11498,0.51498 +-0.030908,-0.59398,0.13477,0.79311,-0.38502,0.11498,0.51498 +-0.084835,-0.50956,0.22964,0.82922,-0.28502,0.11498,0.51498 +-0.12461,-0.33854,0.24073,0.90964,-0.18502,0.11498,0.51498 +-0.14918,-0.14893,0.24902,0.95698,-0.085017,0.11498,0.51498 +-0.15586,0.049939,0.24966,0.96705,0.014983,0.11498,0.51498 +-0.14397,0.24564,0.24234,0.93858,0.11498,0.11498,0.51498 +-0.11451,0.33869,0.23698,0.91056,0.21498,0.11498,0.51498 +-0.069584,0.50985,0.22616,0.83,0.31498,0.11498,0.51498 +-0.01312,0.59388,0.13652,0.79289,0.41498,0.11498,0.51498 +0.052798,0.70096,0.134,0.7005,0.51498,0.11498,0.51498 +0.12605,0.76376,0.1348,0.63127,0.61498,0.11498,0.51498 +0.20487,0.79188,0.13651,0.59523,0.71498,0.11498,0.51498 +0.2871,0.8445,0.13937,0.5171,0.81498,0.11498,0.51498 +0.37159,0.87387,0.093492,0.47709,0.91498,0.11498,0.51498 +0.36213,-0.83,0.22616,0.50985,-0.88502,0.21498,0.51498 +0.27913,-0.83,0.22616,0.50985,-0.78502,0.21498,0.51498 +0.19974,-0.77976,0.22492,0.58428,-0.68502,0.21498,0.51498 +0.12407,-0.71329,0.2628,0.64974,-0.58502,0.21498,0.51498 +0.05549,-0.64198,0.30479,0.70354,-0.48502,0.21498,0.51498 +-0.0057049,-0.57143,0.30618,0.76139,-0.38502,0.21498,0.51498 +-0.057842,-0.41405,0.31957,0.85231,-0.28502,0.21498,0.51498 +-0.095995,-0.32763,0.32764,0.88618,-0.18502,0.21498,0.51498 +-0.1194,-0.14332,0.34088,0.92912,-0.085017,0.21498,0.51498 +-0.12575,0.047929,0.34557,0.93717,0.014983,0.21498,0.51498 +-0.11451,0.23698,0.33869,0.91056,0.11498,0.21498,0.51498 +-0.086231,0.33203,0.32754,0.88458,0.21498,0.21498,0.51498 +-0.043027,0.49516,0.3164,0.80914,0.31498,0.21498,0.51498 +0.011387,0.57414,0.30617,0.75935,0.41498,0.21498,0.51498 +0.074781,0.67416,0.30379,0.67321,0.51498,0.21498,0.51498 +0.14554,0.74298,0.26378,0.61514,0.61498,0.21498,0.51498 +0.22314,0.77825,0.22486,0.58632,0.71498,0.21498,0.51498 +0.30407,0.83187,0.22618,0.5068,0.81498,0.21498,0.51498 +0.38706,0.86228,0.18535,0.4713,0.91498,0.21498,0.51498 +0.38706,-0.8087,0.31416,0.4973,-0.88502,0.31498,0.51498 +0.30623,-0.80826,0.31192,0.49943,-0.78502,0.31498,0.51498 +0.22872,-0.74804,0.34749,0.56541,-0.68502,0.31498,0.51498 +0.15661,-0.68289,0.38255,0.62235,-0.58502,0.31498,0.51498 +0.090152,-0.62275,0.38092,0.68343,-0.48502,0.31498,0.51498 +0.031845,-0.54144,0.46096,0.70311,-0.38502,0.31498,0.51498 +-0.016536,-0.39312,0.48232,0.78283,-0.28502,0.31498,0.51498 +-0.052376,-0.31617,0.49895,0.8069,-0.18502,0.31498,0.51498 +-0.073847,-0.13816,0.51614,0.84529,-0.085017,0.31498,0.51498 +-0.079782,0.045834,0.52077,0.85247,0.014983,0.31498,0.51498 +-0.069584,0.22616,0.50985,0.83,0.11498,0.31498,0.51498 +-0.043027,0.3164,0.49516,0.80914,0.21498,0.31498,0.51498 +-0.0031004,0.47353,0.46849,0.74584,0.31498,0.31498,0.51498 +0.048054,0.54224,0.45722,0.70493,0.41498,0.31498,0.51498 +0.10891,0.65428,0.38128,0.6531,0.51498,0.31498,0.51498 +0.17715,0.71006,0.38408,0.59017,0.61498,0.31498,0.51498 +0.25146,0.76139,0.30618,0.57143,0.71498,0.31498,0.51498 +0.33054,0.81063,0.31199,0.49553,0.81498,0.31498,0.51498 +0.34237,-0.78008,0.39294,0.48691,-0.78502,0.41498,0.51498 +0.26786,-0.70493,0.45722,0.54224,-0.68502,0.41498,0.51498 +0.19865,-0.65799,0.453,0.60154,-0.58502,0.41498,0.51498 +0.13588,-0.58233,0.51415,0.62971,-0.48502,0.41498,0.51498 +0.080909,-0.5257,0.5257,0.66879,-0.38502,0.41498,0.51498 +0.036062,-0.38494,0.55563,0.73695,-0.28502,0.41498,0.51498 +0.0022212,-0.30938,0.57365,0.75843,-0.18502,0.41498,0.51498 +-0.017147,-0.13477,0.59398,0.79311,-0.085017,0.41498,0.51498 +-0.022563,0.045133,0.59967,0.79897,0.014983,0.41498,0.51498 +-0.01312,0.13652,0.59388,0.79289,0.11498,0.41498,0.51498 +0.011387,0.30617,0.57414,0.75935,0.21498,0.41498,0.51498 +0.048054,0.45722,0.54224,0.70493,0.31498,0.41498,0.51498 +0.096535,0.52438,0.52438,0.67085,0.41498,0.41498,0.51498 +0.15339,0.60966,0.51074,0.60618,0.51498,0.41498,0.51498 +0.21859,0.68275,0.45551,0.57129,0.61498,0.41498,0.51498 +0.28925,0.72067,0.42333,0.54902,0.71498,0.41498,0.51498 +0.36587,0.78283,0.39312,0.48232,0.81498,0.41498,0.51498 +0.38671,-0.74585,0.47102,0.47102,-0.78502,0.51498,0.51498 +0.31548,-0.67085,0.52438,0.52438,-0.68502,0.51498,0.51498 +0.24924,-0.63715,0.54499,0.54499,-0.58502,0.51498,0.51498 +0.1902,-0.55722,0.58715,0.58716,-0.48502,0.51498,0.51498 +0.13913,-0.4515,0.63093,0.63093,-0.38502,0.51498,0.51498 +0.097488,-0.38128,0.65369,0.65369,-0.28502,0.51498,0.51498 +0.06681,-0.22083,0.68965,0.68965,-0.18502,0.51498,0.51498 +0.048783,-0.134,0.70073,0.70073,-0.085017,0.51498,0.51498 +0.043908,0.044909,0.70639,0.70639,0.014983,0.51498,0.51498 +0.052798,0.134,0.70073,0.70073,0.11498,0.51498,0.51498 +0.074781,0.30379,0.67369,0.67369,0.21498,0.51498,0.51498 +0.10891,0.38128,0.65369,0.65369,0.31498,0.51498,0.51498 +0.15339,0.51074,0.60792,0.60792,0.41498,0.51498,0.51498 +0.20696,0.58112,0.57546,0.57546,0.51498,0.51498,0.51498 +0.2685,0.67338,0.52276,0.52276,0.61498,0.51498,0.51498 +0.33567,0.70919,0.49853,0.49853,0.71498,0.51498,0.51498 +0.37021,-0.64511,0.59289,0.48198,-0.68502,0.61498,0.51498 +0.30843,-0.58002,0.63491,0.51036,-0.58502,0.61498,0.51498 +0.25285,-0.51882,0.65199,0.55293,-0.48502,0.61498,0.51498 +0.20494,-0.45551,0.68274,0.57129,-0.38502,0.61498,0.51498 +0.16649,-0.3058,0.73323,0.60734,-0.28502,0.61498,0.51498 +0.13889,-0.2222,0.75137,0.62135,-0.18502,0.61498,0.51498 +0.12202,-0.1348,0.76376,0.63127,-0.085017,0.61498,0.51498 +0.11775,0.04517,0.76984,0.63664,0.014983,0.61498,0.51498 +0.12605,0.13479,0.76342,0.63168,0.11498,0.61498,0.51498 +0.14554,0.26367,0.74271,0.61551,0.21498,0.61498,0.51498 +0.17715,0.38404,0.70928,0.59112,0.31498,0.61498,0.51498 +0.21859,0.45544,0.68195,0.5723,0.41498,0.61498,0.51498 +0.2685,0.52438,0.67085,0.52438,0.51498,0.61498,0.51498 +0.32605,0.60966,0.60618,0.51074,0.61498,0.61498,0.51498 +0.38968,0.6687,0.56245,0.4863,0.71498,0.61498,0.51498 +0.37284,-0.53259,0.68873,0.49194,-0.58502,0.71498,0.51498 +0.32123,-0.46535,0.72649,0.50563,-0.48502,0.71498,0.51498 +0.27746,-0.38857,0.73309,0.55821,-0.38502,0.71498,0.51498 +0.24221,-0.30938,0.75843,0.57365,-0.28502,0.71498,0.51498 +0.2164,-0.22486,0.77825,0.58632,-0.18502,0.71498,0.51498 +0.20084,-0.090914,0.79645,0.59783,-0.085017,0.71498,0.51498 +0.1972,0.045133,0.79897,0.59967,0.014983,0.71498,0.51498 +0.20485,0.13652,0.79289,0.59388,0.11498,0.71498,0.51498 +0.22311,0.22492,0.77976,0.58428,0.21498,0.71498,0.51498 +0.25145,0.30951,0.76037,0.57099,0.31498,0.71498,0.51498 +0.28925,0.42333,0.72067,0.54902,0.41498,0.71498,0.51498 +0.33567,0.49869,0.70895,0.49869,0.51498,0.71498,0.51498 +0.38968,0.56278,0.66854,0.48614,0.61498,0.71498,0.51498 +0.39503,-0.4729,0.74346,0.4729,-0.48502,0.81498,0.51498 +0.35398,-0.39765,0.77808,0.48628,-0.38502,0.81498,0.51498 +0.32111,-0.27147,0.82028,0.50343,-0.28502,0.81498,0.51498 +0.29733,-0.18351,0.83858,0.51294,-0.18502,0.81498,0.51498 +0.28348,-0.092705,0.84966,0.51912,-0.085017,0.81498,0.51498 +0.28011,0.045834,0.85247,0.52077,0.014983,0.81498,0.51498 +0.28707,0.13696,0.84482,0.51723,0.11498,0.81498,0.51498 +0.304,0.22616,0.83,0.50986,0.21498,0.81498,0.51498 +0.33045,0.31192,0.80826,0.49943,0.31498,0.81498,0.51498 +0.36575,0.39294,0.78008,0.48691,0.41498,0.81498,0.51498 +0.38139,-0.18535,0.86228,0.4713,-0.18502,0.91498,0.51498 +0.36868,-0.093492,0.87387,0.47709,-0.085017,0.91498,0.51498 +0.36539,-0.00024133,0.87772,0.47918,0.014983,0.91498,0.51498 +0.37159,0.093098,0.87387,0.47715,0.11498,0.91498,0.51498 +0.38706,0.18508,0.86228,0.4714,0.21498,0.91498,0.51498 +0.39631,-0.09116,-0.82415,0.55899,-0.085017,-0.88502,0.61498 +0.39309,0.00019198,-0.82764,0.56126,0.014983,-0.88502,0.61498 +0.39911,0.091478,-0.82419,0.55888,0.11498,-0.88502,0.61498 +0.38463,-0.34749,-0.74804,0.56541,-0.38502,-0.78502,0.61498 +0.35275,-0.26578,-0.77024,0.57973,-0.28502,-0.78502,0.61498 +0.32977,-0.17959,-0.78657,0.5908,-0.18502,-0.78502,0.61498 +0.31641,-0.090368,-0.7965,0.59785,-0.085017,-0.78502,0.61498 +0.31312,0.045784,-0.79895,0.59965,0.014983,-0.78502,0.61498 +0.31985,0.1365,-0.79188,0.59523,0.11498,-0.78502,0.61498 +0.33626,0.2223,-0.78032,0.58453,0.21498,-0.78502,0.61498 +0.36193,0.30618,-0.76139,0.57144,0.31498,-0.78502,0.61498 +0.39622,0.38495,-0.73695,0.55563,0.41498,-0.78502,0.61498 +0.35633,-0.453,-0.65799,0.60154,-0.48502,-0.68502,0.61498 +0.31393,-0.38255,-0.68289,0.62235,-0.38502,-0.68502,0.61498 +0.27987,-0.3035,-0.70386,0.64224,-0.28502,-0.68502,0.61498 +0.25502,-0.2206,-0.72094,0.65695,-0.18502,-0.68502,0.61498 +0.24021,-0.08957,-0.73661,0.67036,-0.085017,-0.68502,0.61498 +0.23673,0.045106,-0.73884,0.67238,0.014983,-0.68502,0.61498 +0.24407,0.13452,-0.73269,0.66714,0.11498,-0.68502,0.61498 +0.26167,0.2216,-0.72076,0.6568,0.21498,-0.68502,0.61498 +0.28901,0.30348,-0.70476,0.64125,0.31498,-0.68502,0.61498 +0.32541,0.41722,-0.67062,0.61335,0.41498,-0.68502,0.61498 +0.37021,0.48296,-0.64466,0.59259,0.51498,-0.68502,0.61498 +0.34621,-0.56272,-0.56272,0.60555,-0.58502,-0.58502,0.61498 +0.29308,-0.51045,-0.5836,0.63155,-0.48502,-0.58502,0.61498 +0.24748,-0.41716,-0.61337,0.67064,-0.38502,-0.58502,0.61498 +0.21133,-0.3035,-0.64224,0.70386,-0.28502,-0.58502,0.61498 +0.18484,-0.2206,-0.65695,0.72094,-0.18502,-0.58502,0.61498 +0.16873,-0.13386,-0.66719,0.73276,-0.085017,-0.58502,0.61498 +0.16484,0.045107,-0.67237,0.73884,0.014983,-0.58502,0.61498 +0.17275,0.13385,-0.66671,0.7332,0.11498,-0.58502,0.61498 +0.19147,0.22059,-0.6562,0.72162,0.21498,-0.58502,0.61498 +0.22082,0.34328,-0.63298,0.6939,0.31498,-0.58502,0.61498 +0.26058,0.45113,-0.60207,0.65878,0.41498,-0.58502,0.61498 +0.30843,0.51036,-0.58002,0.63491,0.51498,-0.58502,0.61498 +0.36335,0.58147,-0.55721,0.5928,0.61498,-0.58502,0.61498 +0.35635,-0.65878,-0.45114,0.60207,-0.68502,-0.48502,0.61498 +0.29308,-0.5836,-0.51045,0.63154,-0.58502,-0.48502,0.61498 +0.23707,-0.52438,-0.52438,0.67085,-0.48502,-0.48502,0.61498 +0.18854,-0.45722,-0.54224,0.70493,-0.38502,-0.48502,0.61498 +0.14903,-0.34749,-0.56541,0.74804,-0.28502,-0.48502,0.61498 +0.12092,-0.22231,-0.5866,0.77876,-0.18502,-0.48502,0.61498 +0.10374,-0.13477,-0.59535,0.79208,-0.085017,-0.48502,0.61498 +0.099339,0.045785,-0.59965,0.79895,0.014983,-0.48502,0.61498 +0.1078,0.13477,-0.59398,0.79311,0.11498,-0.48502,0.61498 +0.1277,0.26611,-0.57968,0.77016,0.21498,-0.48502,0.61498 +0.16021,0.38495,-0.55563,0.73695,0.31498,-0.48502,0.61498 +0.20232,0.45739,-0.53862,0.70758,0.41498,-0.48502,0.61498 +0.25285,0.55293,-0.51882,0.65199,0.51498,-0.48502,0.61498 +0.31081,0.61963,-0.48038,0.62072,0.61498,-0.48502,0.61498 +0.37606,0.68195,-0.45544,0.5723,0.71498,-0.48502,0.61498 +0.38463,-0.74797,-0.34771,0.56537,-0.78502,-0.38502,0.61498 +0.31396,-0.6818,-0.38248,0.62358,-0.68502,-0.38502,0.61498 +0.24748,-0.61337,-0.41716,0.67064,-0.58502,-0.38502,0.61498 +0.18854,-0.54224,-0.45722,0.70493,-0.48502,-0.38502,0.61498 +0.13746,-0.47102,-0.47102,0.74585,-0.38502,-0.38502,0.61498 +0.095384,-0.39294,-0.48691,0.78008,-0.28502,-0.38502,0.61498 +0.064992,-0.22975,-0.50657,0.83102,-0.18502,-0.38502,0.61498 +0.04678,-0.13696,-0.51723,0.84482,-0.085017,-0.38502,0.61498 +0.041948,0.04675,-0.52075,0.85243,0.014983,-0.38502,0.61498 +0.050944,0.13696,-0.51518,0.84607,0.11498,-0.38502,0.61498 +0.072731,0.31618,-0.49895,0.8069,0.21498,-0.38502,0.61498 +0.10731,0.39312,-0.48232,0.78283,0.31498,-0.38502,0.61498 +0.15168,0.46889,-0.46889,0.74853,0.41498,-0.38502,0.61498 +0.20494,0.57129,-0.45551,0.68275,0.51498,-0.38502,0.61498 +0.26635,0.6531,-0.38127,0.65428,0.61498,-0.38502,0.61498 +0.33439,0.68289,-0.38255,0.62235,0.71498,-0.38502,0.61498 +0.35275,-0.77016,-0.26611,0.57968,-0.78502,-0.28502,0.61498 +0.2799,-0.70354,-0.30479,0.64198,-0.68502,-0.28502,0.61498 +0.21133,-0.64224,-0.3035,0.70386,-0.58502,-0.28502,0.61498 +0.14903,-0.56541,-0.34749,0.74804,-0.48502,-0.28502,0.61498 +0.095384,-0.48691,-0.39294,0.78008,-0.38502,-0.28502,0.61498 +0.051212,-0.40584,-0.40584,0.81889,-0.28502,-0.28502,0.61498 +0.018668,-0.2353,-0.42328,0.87491,-0.18502,-0.28502,0.61498 +-0.00057236,-0.13997,-0.4331,0.89041,-0.085017,-0.28502,0.61498 +-0.0057636,0.047861,-0.43589,0.89873,0.014983,-0.28502,0.61498 +0.0037461,0.13997,-0.43063,0.89161,0.11498,-0.28502,0.61498 +0.027234,0.32404,-0.41817,0.84861,0.21498,-0.28502,0.61498 +0.063512,0.40806,-0.40806,0.81668,0.31498,-0.28502,0.61498 +0.10998,0.49143,-0.3552,0.7952,0.41498,-0.28502,0.61498 +0.16649,0.60734,-0.3058,0.73323,0.51498,-0.28502,0.61498 +0.23079,0.67321,-0.30379,0.67416,0.61498,-0.28502,0.61498 +0.30097,0.70442,-0.30483,0.64099,0.71498,-0.28502,0.61498 +0.37571,0.77024,-0.26579,0.57972,0.81498,-0.28502,0.61498 +0.32977,-0.78651,-0.18,0.59077,-0.78502,-0.18502,0.61498 +0.25503,-0.72076,-0.22161,0.6568,-0.68502,-0.18502,0.61498 +0.18484,-0.65695,-0.2206,0.72094,-0.58502,-0.18502,0.61498 +0.12092,-0.5866,-0.22231,0.77876,-0.48502,-0.18502,0.61498 +0.064992,-0.50657,-0.22974,0.83102,-0.38502,-0.18502,0.61498 +0.018668,-0.42328,-0.23531,0.87491,-0.28502,-0.18502,0.61498 +-0.01594,-0.24564,-0.24234,0.93858,-0.18502,-0.18502,0.61498 +-0.036093,-0.14659,-0.24907,0.95733,-0.085017,-0.18502,0.61498 +-0.041629,0.049031,-0.24965,0.96709,0.014983,-0.18502,0.61498 +-0.031678,0.14659,-0.24675,0.95793,0.11498,-0.18502,0.61498 +-0.0066814,0.33501,-0.23701,0.91192,0.21498,-0.18502,0.61498 +0.031403,0.42342,-0.23136,0.87589,0.31498,-0.18502,0.61498 +0.080242,0.54719,-0.22578,0.80598,0.41498,-0.18502,0.61498 +0.13889,0.62135,-0.2222,0.75137,0.51498,-0.18502,0.61498 +0.20474,0.68929,-0.22083,0.69001,0.61498,-0.18502,0.61498 +0.27662,0.72094,-0.2206,0.65695,0.71498,-0.18502,0.61498 +0.35334,0.78657,-0.17959,0.5908,0.81498,-0.18502,0.61498 +0.39631,-0.82419,-0.091478,0.55888,-0.88502,-0.085017,0.61498 +0.31641,-0.79645,-0.090914,0.59783,-0.78502,-0.085017,0.61498 +0.24021,-0.73659,-0.089781,0.67035,-0.68502,-0.085017,0.61498 +0.16873,-0.66719,-0.13386,0.73276,-0.58502,-0.085017,0.61498 +0.10374,-0.59535,-0.13477,0.79208,-0.48502,-0.085017,0.61498 +0.04678,-0.51723,-0.13696,0.84482,-0.38502,-0.085017,0.61498 +-0.00057234,-0.4331,-0.13997,0.89041,-0.28502,-0.085017,0.61498 +-0.036093,-0.24907,-0.14659,0.95733,-0.18502,-0.085017,0.61498 +-0.056835,-0.14935,-0.15102,0.97718,-0.085017,-0.085017,0.61498 +-0.062538,0.050618,-0.15185,0.98711,0.014983,-0.085017,0.61498 +-0.052285,0.14935,-0.14935,0.97744,0.11498,-0.085017,0.61498 +-0.026548,0.34337,-0.14603,0.92778,0.21498,-0.085017,0.61498 +0.012456,0.43063,-0.13996,0.89161,0.31498,-0.085017,0.61498 +0.062283,0.55585,-0.13689,0.81993,0.41498,-0.085017,0.61498 +0.12202,0.63127,-0.1348,0.76376,0.51498,-0.085017,0.61498 +0.18894,0.7042,-0.089378,0.70436,0.61498,-0.085017,0.61498 +0.26227,0.73661,-0.08957,0.67036,0.71498,-0.085017,0.61498 +0.34032,0.7965,-0.090369,0.59785,0.81498,-0.085017,0.61498 +0.39309,-0.82764,-0.00019261,0.56126,-0.88502,0.014983,0.61498 +0.31312,-0.79897,0.045132,0.59967,-0.78502,0.014983,0.61498 +0.23673,-0.73884,0.044858,0.67238,-0.68502,0.014983,0.61498 +0.16484,-0.67237,0.045106,0.73884,-0.58502,0.014983,0.61498 +0.099339,-0.59965,0.045784,0.79895,-0.48502,0.014983,0.61498 +0.041948,-0.52075,0.04675,0.85243,-0.38502,0.014983,0.61498 +-0.0057636,-0.43589,0.047859,0.89873,-0.28502,0.014983,0.61498 +-0.041629,-0.24965,0.049031,0.96709,-0.18502,0.014983,0.61498 +-0.062538,-0.15185,0.050616,0.98711,-0.085017,0.014983,0.61498 +-0.068332,0.050878,0.05064,0.99742,0.014983,0.014983,0.61498 +-0.057999,0.15185,0.049983,0.98714,0.11498,0.014983,0.61498 +-0.032038,0.34557,0.047929,0.93717,0.21498,0.014983,0.61498 +0.0072829,0.43591,0.046814,0.89877,0.31498,0.014983,0.61498 +0.057545,0.56059,0.045862,0.82682,0.41498,0.014983,0.61498 +0.11775,0.63664,0.04517,0.76984,0.51498,0.014983,0.61498 +0.18519,0.70648,0.044908,0.70631,0.61498,0.014983,0.61498 +0.25887,0.73884,0.045107,0.67237,0.71498,0.014983,0.61498 +0.33706,0.79979,0.00032593,0.60028,0.81498,0.014983,0.61498 +0.39911,-0.82415,0.091161,0.55899,-0.88502,0.11498,0.61498 +0.31983,-0.79208,0.13477,0.59535,-0.78502,0.11498,0.61498 +0.24405,-0.73276,0.13386,0.66719,-0.68502,0.11498,0.61498 +0.17275,-0.66671,0.13385,0.7332,-0.58502,0.11498,0.61498 +0.1078,-0.59398,0.13477,0.79311,-0.48502,0.11498,0.61498 +0.050944,-0.51518,0.13696,0.84607,-0.38502,0.11498,0.61498 +0.0037461,-0.43063,0.13996,0.89161,-0.28502,0.11498,0.61498 +-0.031678,-0.24675,0.14659,0.95793,-0.18502,0.11498,0.61498 +-0.052285,-0.14935,0.14935,0.97744,-0.085017,0.11498,0.61498 +-0.057999,0.049984,0.15185,0.98714,0.014983,0.11498,0.61498 +-0.047834,0.14935,0.15102,0.97718,0.11498,0.11498,0.61498 +-0.022231,0.34086,0.14606,0.9287,0.21498,0.11498,0.61498 +0.016607,0.43058,0.14273,0.8912,0.31498,0.11498,0.61498 +0.066388,0.55615,0.13689,0.81973,0.41498,0.11498,0.61498 +0.12605,0.63168,0.1348,0.76342,0.51498,0.11498,0.61498 +0.19294,0.70096,0.134,0.7005,0.61498,0.11498,0.61498 +0.26602,0.73269,0.13452,0.66714,0.71498,0.11498,0.61498 +0.34358,0.79188,0.13651,0.59523,0.81498,0.11498,0.61498 +0.33623,-0.77876,0.22231,0.5866,-0.78502,0.21498,0.61498 +0.26164,-0.72143,0.22162,0.65606,-0.68502,0.21498,0.61498 +0.19147,-0.6562,0.22059,0.72162,-0.58502,0.21498,0.61498 +0.1277,-0.57968,0.26611,0.77016,-0.48502,0.21498,0.61498 +0.072731,-0.49895,0.31618,0.8069,-0.38502,0.21498,0.61498 +0.027234,-0.41817,0.32404,0.8486,-0.28502,0.21498,0.61498 +-0.0066814,-0.23701,0.33501,0.91192,-0.18502,0.21498,0.61498 +-0.026548,-0.14603,0.34337,0.92778,-0.085017,0.21498,0.61498 +-0.032038,0.047929,0.34557,0.93717,0.014983,0.21498,0.61498 +-0.022231,0.14606,0.34086,0.9287,0.11498,0.21498,0.61498 +0.0022268,0.32978,0.32978,0.88458,0.21498,0.21498,0.61498 +0.039702,0.41853,0.31947,0.85016,0.31498,0.21498,0.61498 +0.087669,0.53571,0.31101,0.78504,0.41498,0.21498,0.61498 +0.14554,0.61551,0.26367,0.74271,0.51498,0.21498,0.61498 +0.21136,0.69001,0.22083,0.68929,0.61498,0.21498,0.61498 +0.28327,0.72076,0.22161,0.6568,0.71498,0.21498,0.61498 +0.3596,0.77825,0.22486,0.58632,0.81498,0.21498,0.61498 +0.36188,-0.75936,0.30617,0.57414,-0.78502,0.31498,0.61498 +0.289,-0.70442,0.30483,0.64099,-0.68502,0.31498,0.61498 +0.22082,-0.63298,0.34328,0.6939,-0.58502,0.31498,0.61498 +0.16021,-0.55563,0.38495,0.73695,-0.48502,0.31498,0.61498 +0.10731,-0.48232,0.39312,0.78283,-0.38502,0.31498,0.61498 +0.063512,-0.40806,0.40806,0.81668,-0.28502,0.31498,0.61498 +0.031403,-0.23135,0.42342,0.87589,-0.18502,0.31498,0.61498 +0.012456,-0.13997,0.43063,0.89161,-0.085017,0.31498,0.61498 +0.0072829,0.046816,0.43591,0.89877,0.014983,0.31498,0.61498 +0.016607,0.14273,0.43057,0.8912,0.11498,0.31498,0.61498 +0.039702,0.31947,0.41853,0.85016,0.21498,0.31498,0.61498 +0.075535,0.40584,0.40584,0.81889,0.31498,0.31498,0.61498 +0.12175,0.48691,0.39294,0.78008,0.41498,0.31498,0.61498 +0.17715,0.59112,0.38404,0.70928,0.51498,0.31498,0.61498 +0.24,0.66471,0.34208,0.66418,0.61498,0.31498,0.61498 +0.31011,0.70354,0.30479,0.64198,0.71498,0.31498,0.61498 +0.38469,0.75843,0.30938,0.57365,0.81498,0.31498,0.61498 +0.39616,-0.73449,0.38489,0.5589,-0.78502,0.41498,0.61498 +0.32541,-0.67064,0.41716,0.61337,-0.68502,0.41498,0.61498 +0.26058,-0.60207,0.45114,0.65878,-0.58502,0.41498,0.61498 +0.20232,-0.53862,0.45739,0.70759,-0.48502,0.41498,0.61498 +0.15168,-0.46889,0.46889,0.74853,-0.38502,0.41498,0.61498 +0.10998,-0.3552,0.49142,0.7952,-0.28502,0.41498,0.61498 +0.080242,-0.22578,0.54719,0.80598,-0.18502,0.41498,0.61498 +0.062283,-0.13689,0.55585,0.81993,-0.085017,0.41498,0.61498 +0.057545,0.045862,0.56059,0.82682,0.014983,0.41498,0.61498 +0.066388,0.13689,0.55615,0.81973,0.11498,0.41498,0.61498 +0.087669,0.31101,0.53571,0.78504,0.21498,0.41498,0.61498 +0.12175,0.39294,0.48691,0.78008,0.31498,0.41498,0.61498 +0.16569,0.47102,0.47102,0.74585,0.41498,0.41498,0.61498 +0.21859,0.5723,0.45544,0.68195,0.51498,0.41498,0.61498 +0.27884,0.63163,0.4515,0.63023,0.61498,0.41498,0.61498 +0.34586,0.71006,0.38408,0.59017,0.71498,0.41498,0.61498 +0.37021,-0.64511,0.48199,0.59289,-0.68502,0.51498,0.61498 +0.30843,-0.58002,0.51036,0.63491,-0.58502,0.51498,0.61498 +0.25285,-0.51882,0.55293,0.65199,-0.48502,0.51498,0.61498 +0.20494,-0.45551,0.57129,0.68274,-0.38502,0.51498,0.61498 +0.16649,-0.3058,0.60734,0.73323,-0.28502,0.51498,0.61498 +0.13889,-0.2222,0.62135,0.75137,-0.18502,0.51498,0.61498 +0.12202,-0.1348,0.63127,0.76376,-0.085017,0.51498,0.61498 +0.11775,0.045169,0.63664,0.76984,0.014983,0.51498,0.61498 +0.12605,0.13479,0.63168,0.76342,0.11498,0.51498,0.61498 +0.14554,0.26367,0.61551,0.74271,0.21498,0.51498,0.61498 +0.17715,0.38404,0.59112,0.70928,0.31498,0.51498,0.61498 +0.21859,0.45544,0.5723,0.68195,0.41498,0.51498,0.61498 +0.2685,0.52438,0.52438,0.67085,0.51498,0.51498,0.61498 +0.32605,0.60966,0.51074,0.60618,0.61498,0.51498,0.61498 +0.38968,0.6687,0.4863,0.56245,0.71498,0.51498,0.61498 +0.36335,-0.55722,0.58715,0.58716,-0.58502,0.61498,0.61498 +0.31081,-0.48063,0.62008,0.62008,-0.48502,0.61498,0.61498 +0.26635,-0.38128,0.65369,0.65369,-0.38502,0.61498,0.61498 +0.23079,-0.30379,0.67369,0.67369,-0.28502,0.61498,0.61498 +0.20474,-0.22083,0.68965,0.68965,-0.18502,0.61498,0.61498 +0.18894,-0.089429,0.70427,0.70427,-0.085017,0.61498,0.61498 +0.18519,0.044909,0.70639,0.70639,0.014983,0.61498,0.61498 +0.19294,0.134,0.70073,0.70073,0.11498,0.61498,0.61498 +0.21136,0.22083,0.68965,0.68965,0.21498,0.61498,0.61498 +0.24,0.34206,0.66445,0.66445,0.31498,0.61498,0.61498 +0.27884,0.4515,0.63093,0.63093,0.41498,0.61498,0.61498 +0.32605,0.51074,0.60792,0.60792,0.51498,0.61498,0.61498 +0.38016,0.58112,0.57546,0.57546,0.61498,0.61498,0.61498 +0.37606,-0.45551,0.68274,0.57129,-0.48502,0.71498,0.61498 +0.33439,-0.38247,0.6818,0.62358,-0.38502,0.71498,0.61498 +0.30098,-0.30479,0.70354,0.64198,-0.28502,0.71498,0.61498 +0.27663,-0.22161,0.72076,0.6568,-0.18502,0.71498,0.61498 +0.26227,-0.089782,0.73659,0.67035,-0.085017,0.71498,0.61498 +0.25887,0.044859,0.73884,0.67238,0.014983,0.71498,0.61498 +0.26602,0.13453,0.73312,0.66666,0.11498,0.71498,0.61498 +0.28326,0.22162,0.72143,0.65606,0.21498,0.71498,0.61498 +0.31011,0.30483,0.70442,0.64099,0.31498,0.71498,0.61498 +0.34586,0.38404,0.70928,0.59112,0.41498,0.71498,0.61498 +0.38968,0.48614,0.66854,0.56278,0.51498,0.71498,0.61498 +0.37571,-0.26611,0.77016,0.57968,-0.28502,0.81498,0.61498 +0.35334,-0.18,0.78651,0.59077,-0.18502,0.81498,0.61498 +0.34032,-0.090914,0.79645,0.59783,-0.085017,0.81498,0.61498 +0.33706,-0.00032548,0.79979,0.60028,0.014983,0.81498,0.61498 +0.34357,0.13477,0.79208,0.59535,0.11498,0.81498,0.61498 +0.35957,0.22231,0.77876,0.5866,0.21498,0.81498,0.61498 +0.38464,0.30617,0.75936,0.57414,0.31498,0.81498,0.61498 +0.39358,-0.17774,-0.72773,0.66244,-0.18502,-0.78502,0.71498 +0.38105,-0.08957,-0.73661,0.67036,-0.085017,-0.78502,0.71498 +0.37785,0.00012361,-0.73959,0.67306,0.014983,-0.78502,0.71498 +0.38405,0.13452,-0.73269,0.66714,0.11498,-0.78502,0.71498 +0.39942,0.2216,-0.72076,0.6568,0.21498,-0.78502,0.71498 +0.37806,-0.38095,-0.62397,0.6823,-0.38502,-0.68502,0.71498 +0.34594,-0.2628,-0.64974,0.71329,-0.28502,-0.68502,0.71498 +0.32274,-0.17774,-0.66244,0.72773,-0.18502,-0.68502,0.71498 +0.30925,-0.08957,-0.67036,0.73661,-0.085017,-0.68502,0.71498 +0.30596,0.045107,-0.67237,0.73884,0.014983,-0.68502,0.71498 +0.31274,0.13385,-0.66671,0.7332,0.11498,-0.68502,0.71498 +0.32925,0.22059,-0.6562,0.72162,0.21498,-0.68502,0.71498 +0.35504,0.30348,-0.64125,0.70476,0.31498,-0.68502,0.71498 +0.38948,0.38093,-0.62275,0.68343,0.41498,-0.68502,0.71498 +0.35898,-0.45544,-0.5723,0.68195,-0.48502,-0.58502,0.71498 +0.31647,-0.38404,-0.59112,0.70928,-0.38502,-0.58502,0.71498 +0.28238,-0.30579,-0.60814,0.73257,-0.28502,-0.58502,0.71498 +0.25753,-0.22219,-0.62196,0.75086,-0.18502,-0.58502,0.71498 +0.24275,-0.089822,-0.63479,0.76745,-0.085017,-0.58502,0.71498 +0.23928,0.04517,-0.63649,0.76996,0.014983,-0.58502,0.71498 +0.2466,0.1348,-0.63127,0.76376,0.11498,-0.58502,0.71498 +0.26419,0.2222,-0.62135,0.75137,0.21498,-0.58502,0.71498 +0.29155,0.3058,-0.60734,0.73323,0.31498,-0.58502,0.71498 +0.328,0.4192,-0.58141,0.69731,0.41498,-0.58502,0.71498 +0.37284,0.49194,-0.53259,0.68873,0.51498,-0.58502,0.71498 +0.35898,-0.5723,-0.45544,0.68195,-0.58502,-0.48502,0.71498 +0.30625,-0.47102,-0.47102,0.74585,-0.48502,-0.48502,0.71498 +0.2614,-0.39121,-0.52139,0.75836,-0.38502,-0.48502,0.71498 +0.22542,-0.31101,-0.53571,0.78504,-0.28502,-0.48502,0.71498 +0.19911,-0.22577,-0.54762,0.80569,-0.18502,-0.48502,0.71498 +0.18319,-0.091161,-0.55899,0.82415,-0.085017,-0.48502,0.71498 +0.17945,0.045863,-0.56048,0.8269,0.014983,-0.48502,0.71498 +0.18727,0.13689,-0.55585,0.81993,0.11498,-0.48502,0.71498 +0.20587,0.22578,-0.54719,0.80598,0.21498,-0.48502,0.71498 +0.23475,0.35088,-0.52853,0.77301,0.31498,-0.48502,0.71498 +0.27356,0.42788,-0.51345,0.74384,0.41498,-0.48502,0.71498 +0.32123,0.50563,-0.46535,0.72649,0.51498,-0.48502,0.71498 +0.37606,0.57129,-0.45551,0.68275,0.61498,-0.48502,0.71498 +0.37806,-0.62397,-0.38095,0.6823,-0.68502,-0.38502,0.71498 +0.31647,-0.59112,-0.38404,0.70928,-0.58502,-0.38502,0.71498 +0.2614,-0.52139,-0.39121,0.75836,-0.48502,-0.38502,0.71498 +0.21427,-0.40584,-0.40584,0.81889,-0.38502,-0.38502,0.71498 +0.1764,-0.31947,-0.41853,0.85016,-0.28502,-0.38502,0.71498 +0.14865,-0.23077,-0.46728,0.85346,-0.18502,-0.38502,0.71498 +0.13178,-0.13984,-0.47461,0.86902,-0.085017,-0.38502,0.71498 +0.12769,0.046837,-0.47843,0.87687,0.014983,-0.38502,0.71498 +0.13598,0.13984,-0.47444,0.86911,0.11498,-0.38502,0.71498 +0.15558,0.23077,-0.46705,0.85358,0.21498,-0.38502,0.71498 +0.1862,0.36423,-0.41153,0.83545,0.31498,-0.38502,0.71498 +0.22755,0.48628,-0.39765,0.77808,0.41498,-0.38502,0.71498 +0.27746,0.55821,-0.38857,0.73309,0.51498,-0.38502,0.71498 +0.33439,0.62358,-0.38247,0.6818,0.61498,-0.38502,0.71498 +0.3971,0.66418,-0.34208,0.66471,0.71498,-0.38502,0.71498 +0.34594,-0.64974,-0.2628,0.71329,-0.68502,-0.28502,0.71498 +0.28238,-0.60814,-0.30579,0.73257,-0.58502,-0.28502,0.71498 +0.22542,-0.53571,-0.31101,0.78504,-0.48502,-0.28502,0.71498 +0.1764,-0.41853,-0.31947,0.85016,-0.38502,-0.28502,0.71498 +0.13688,-0.32978,-0.32978,0.88458,-0.28502,-0.28502,0.71498 +0.10792,-0.23698,-0.33869,0.91056,-0.18502,-0.28502,0.71498 +0.090261,-0.14333,-0.34345,0.92817,-0.085017,-0.28502,0.71498 +0.085892,0.048971,-0.34556,0.93712,0.014983,-0.28502,0.71498 +0.094593,0.14332,-0.34088,0.92912,0.11498,-0.28502,0.71498 +0.11507,0.23701,-0.33501,0.91192,0.21498,-0.28502,0.71498 +0.14733,0.37335,-0.32623,0.86844,0.31498,-0.28502,0.71498 +0.19052,0.49895,-0.31618,0.8069,0.41498,-0.28502,0.71498 +0.24221,0.57365,-0.30938,0.75843,0.51498,-0.28502,0.71498 +0.30098,0.64198,-0.30479,0.70353,0.61498,-0.28502,0.71498 +0.36559,0.68219,-0.26201,0.68261,0.71498,-0.28502,0.71498 +0.39358,-0.7277,-0.17791,0.66242,-0.78502,-0.18502,0.71498 +0.32274,-0.66244,-0.17774,0.72773,-0.68502,-0.18502,0.71498 +0.25753,-0.62196,-0.22219,0.75086,-0.58502,-0.18502,0.71498 +0.19911,-0.54762,-0.22577,0.80569,-0.48502,-0.18502,0.71498 +0.14865,-0.46728,-0.23077,0.85346,-0.38502,-0.18502,0.71498 +0.10792,-0.33869,-0.23698,0.91056,-0.28502,-0.18502,0.71498 +0.077919,-0.24399,-0.24399,0.93858,-0.18502,-0.18502,0.71498 +0.05964,-0.14659,-0.24907,0.95733,-0.085017,-0.18502,0.71498 +0.05506,0.049937,-0.25052,0.96682,0.014983,-0.18502,0.71498 +0.064115,0.14659,-0.24675,0.95793,0.11498,-0.18502,0.71498 +0.085298,0.24235,-0.24235,0.93943,0.21498,-0.18502,0.71498 +0.11885,0.4268,-0.23519,0.87323,0.31498,-0.18502,0.71498 +0.16332,0.50956,-0.22965,0.82922,0.41498,-0.18502,0.71498 +0.2164,0.58632,-0.22486,0.77825,0.51498,-0.18502,0.71498 +0.27663,0.6568,-0.22161,0.72076,0.61498,-0.18502,0.71498 +0.34291,0.69576,-0.17724,0.69606,0.71498,-0.18502,0.71498 +0.38105,-0.73659,-0.089781,0.67035,-0.78502,-0.085017,0.71498 +0.30925,-0.67036,-0.08957,0.73661,-0.68502,-0.085017,0.71498 +0.24275,-0.63479,-0.089822,0.76745,-0.58502,-0.085017,0.71498 +0.18319,-0.55899,-0.09116,0.82415,-0.48502,-0.085017,0.71498 +0.13178,-0.47461,-0.13984,0.86902,-0.38502,-0.085017,0.71498 +0.090261,-0.34345,-0.14333,0.92817,-0.28502,-0.085017,0.71498 +0.05964,-0.24907,-0.14659,0.95733,-0.18502,-0.085017,0.71498 +0.040883,-0.15018,-0.15019,0.97718,-0.085017,-0.085017,0.71498 +0.036173,0.050618,-0.15185,0.98711,0.014983,-0.085017,0.71498 +0.045424,0.151,-0.151,0.97693,0.11498,-0.085017,0.71498 +0.067116,0.24675,-0.14659,0.95793,0.21498,-0.085017,0.71498 +0.10146,0.43299,-0.1427,0.89003,0.31498,-0.085017,0.71498 +0.14676,0.5171,-0.13937,0.8445,0.41498,-0.085017,0.71498 +0.20084,0.59783,-0.090914,0.79645,0.51498,-0.085017,0.71498 +0.26227,0.67035,-0.089782,0.73659,0.61498,-0.085017,0.71498 +0.32973,0.7042,-0.089378,0.70436,0.71498,-0.085017,0.71498 +0.37785,-0.73959,-0.00012433,0.67306,-0.78502,0.014983,0.71498 +0.30596,-0.67237,0.045106,0.73884,-0.68502,0.014983,0.71498 +0.23928,-0.63649,0.04517,0.76996,-0.58502,0.014983,0.71498 +0.17945,-0.56048,0.045861,0.8269,-0.48502,0.014983,0.71498 +0.12769,-0.47843,0.046837,0.87687,-0.38502,0.014983,0.71498 +0.085892,-0.34555,0.048971,0.93712,-0.28502,0.014983,0.71498 +0.05506,-0.25052,0.049938,0.96682,-0.18502,0.014983,0.71498 +0.036173,-0.15185,0.050616,0.98711,-0.085017,0.014983,0.71498 +0.03141,0.05076,0.050759,0.99742,0.014983,0.014983,0.71498 +0.040715,0.15185,0.049983,0.98714,0.11498,0.014983,0.71498 +0.062556,0.25053,0.049032,0.96687,0.21498,0.014983,0.71498 +0.097166,0.43498,0.047863,0.89917,0.31498,0.014983,0.71498 +0.14279,0.52077,0.045835,0.85247,0.41498,0.014983,0.71498 +0.1972,0.59967,0.045133,0.79897,0.51498,0.014983,0.71498 +0.25887,0.67238,0.044859,0.73884,0.61498,0.014983,0.71498 +0.32647,0.70648,0.044908,0.70631,0.71498,0.014983,0.71498 +0.38405,-0.73276,0.13386,0.66719,-0.78502,0.11498,0.71498 +0.31274,-0.66671,0.13385,0.7332,-0.68502,0.11498,0.71498 +0.2466,-0.63127,0.1348,0.76376,-0.58502,0.11498,0.71498 +0.18727,-0.55585,0.13689,0.81993,-0.48502,0.11498,0.71498 +0.13598,-0.47444,0.13984,0.86911,-0.38502,0.11498,0.71498 +0.094593,-0.34088,0.14332,0.92912,-0.28502,0.11498,0.71498 +0.064115,-0.24675,0.14659,0.95793,-0.18502,0.11498,0.71498 +0.045424,-0.151,0.151,0.97693,-0.085017,0.11498,0.71498 +0.040715,0.049984,0.15185,0.98714,0.014983,0.11498,0.71498 +0.049884,0.15019,0.15019,0.97718,0.11498,0.11498,0.71498 +0.071496,0.24907,0.14659,0.95733,0.21498,0.11498,0.71498 +0.10573,0.43058,0.14273,0.8912,0.31498,0.11498,0.71498 +0.15091,0.51509,0.13941,0.84573,0.41498,0.11498,0.71498 +0.20485,0.59388,0.13652,0.79289,0.51498,0.11498,0.71498 +0.26602,0.66666,0.13453,0.73313,0.61498,0.11498,0.71498 +0.33309,0.70096,0.134,0.7005,0.71498,0.11498,0.71498 +0.39942,-0.72094,0.2206,0.65695,-0.78502,0.21498,0.71498 +0.32925,-0.6562,0.22059,0.72162,-0.68502,0.21498,0.71498 +0.26419,-0.62135,0.2222,0.75137,-0.58502,0.21498,0.71498 +0.20587,-0.54719,0.22578,0.80598,-0.48502,0.21498,0.71498 +0.15558,-0.46705,0.23078,0.85358,-0.38502,0.21498,0.71498 +0.11507,-0.33501,0.23701,0.91192,-0.28502,0.21498,0.71498 +0.085298,-0.24235,0.24235,0.93943,-0.18502,0.21498,0.71498 +0.067116,-0.14659,0.24675,0.95793,-0.085017,0.21498,0.71498 +0.062556,0.049033,0.25053,0.96687,0.014983,0.21498,0.71498 +0.071496,0.14659,0.24907,0.95733,0.11498,0.21498,0.71498 +0.092541,0.24399,0.24399,0.93858,0.21498,0.21498,0.71498 +0.12589,0.42328,0.23531,0.87491,0.31498,0.21498,0.71498 +0.17016,0.50657,0.22974,0.83102,0.41498,0.21498,0.71498 +0.22311,0.58428,0.22492,0.77976,0.51498,0.21498,0.71498 +0.28326,0.65606,0.22162,0.72143,0.61498,0.21498,0.71498 +0.34929,0.69001,0.22083,0.68929,0.71498,0.21498,0.71498 +0.35504,-0.64125,0.30348,0.70477,-0.68502,0.31498,0.71498 +0.29155,-0.60734,0.3058,0.73323,-0.58502,0.31498,0.71498 +0.23475,-0.52853,0.35088,0.77301,-0.48502,0.31498,0.71498 +0.1862,-0.41153,0.36423,0.83545,-0.38502,0.31498,0.71498 +0.14733,-0.32623,0.37335,0.86844,-0.28502,0.31498,0.71498 +0.11885,-0.23519,0.4268,0.87323,-0.18502,0.31498,0.71498 +0.10146,-0.1427,0.43299,0.89003,-0.085017,0.31498,0.71498 +0.097166,0.047863,0.43498,0.89917,0.014983,0.31498,0.71498 +0.10573,0.14273,0.43057,0.8912,0.11498,0.31498,0.71498 +0.12589,0.23531,0.42328,0.87491,0.21498,0.31498,0.71498 +0.15747,0.36881,0.36881,0.8532,0.31498,0.31498,0.71498 +0.20004,0.49145,0.35497,0.79528,0.41498,0.31498,0.71498 +0.25145,0.57099,0.30951,0.76037,0.51498,0.31498,0.71498 +0.31011,0.64099,0.30483,0.70442,0.61498,0.31498,0.71498 +0.37464,0.67416,0.30379,0.67321,0.71498,0.31498,0.71498 +0.38948,-0.62275,0.38092,0.68343,-0.68502,0.41498,0.71498 +0.328,-0.58141,0.4192,0.69731,-0.58502,0.41498,0.71498 +0.27356,-0.51345,0.42788,0.74384,-0.48502,0.41498,0.71498 +0.22755,-0.39765,0.48628,0.77808,-0.38502,0.41498,0.71498 +0.19052,-0.31617,0.49895,0.8069,-0.28502,0.41498,0.71498 +0.16332,-0.22965,0.50956,0.82923,-0.18502,0.41498,0.71498 +0.14676,-0.13937,0.5171,0.8445,-0.085017,0.41498,0.71498 +0.14279,0.045834,0.52077,0.85247,0.014983,0.41498,0.71498 +0.15091,0.1394,0.51509,0.84573,0.11498,0.41498,0.71498 +0.17016,0.22974,0.50658,0.83102,0.21498,0.41498,0.71498 +0.20004,0.35497,0.49145,0.79528,0.31498,0.41498,0.71498 +0.24027,0.47102,0.47102,0.74585,0.41498,0.41498,0.71498 +0.28925,0.54902,0.42333,0.72067,0.51498,0.41498,0.71498 +0.34586,0.59112,0.38404,0.70928,0.61498,0.41498,0.71498 +0.37284,-0.53258,0.49194,0.68873,-0.58502,0.51498,0.71498 +0.32123,-0.46535,0.50563,0.72649,-0.48502,0.51498,0.71498 +0.27746,-0.38857,0.55821,0.73309,-0.38502,0.51498,0.71498 +0.24221,-0.30938,0.57365,0.75843,-0.28502,0.51498,0.71498 +0.2164,-0.22486,0.58632,0.77825,-0.18502,0.51498,0.71498 +0.20084,-0.090914,0.59783,0.79645,-0.085017,0.51498,0.71498 +0.1972,0.045133,0.59967,0.79897,0.014983,0.51498,0.71498 +0.20485,0.13652,0.59388,0.79289,0.11498,0.51498,0.71498 +0.22311,0.22492,0.58428,0.77976,0.21498,0.51498,0.71498 +0.25145,0.30952,0.57099,0.76037,0.31498,0.51498,0.71498 +0.28925,0.42333,0.54902,0.72067,0.41498,0.51498,0.71498 +0.33567,0.49869,0.49869,0.70895,0.51498,0.51498,0.71498 +0.38968,0.56278,0.48614,0.66854,0.61498,0.51498,0.71498 +0.37606,-0.45551,0.57129,0.68274,-0.48502,0.61498,0.71498 +0.33439,-0.38248,0.62358,0.6818,-0.38502,0.61498,0.71498 +0.30098,-0.30479,0.64198,0.70354,-0.28502,0.61498,0.71498 +0.27663,-0.22161,0.6568,0.72076,-0.18502,0.61498,0.71498 +0.26227,-0.089781,0.67035,0.73659,-0.085017,0.61498,0.71498 +0.25887,0.044859,0.67238,0.73884,0.014983,0.61498,0.71498 +0.26602,0.13453,0.66666,0.73312,0.11498,0.61498,0.71498 +0.28326,0.22162,0.65606,0.72143,0.21498,0.61498,0.71498 +0.31011,0.30483,0.64099,0.70442,0.31498,0.61498,0.71498 +0.34586,0.38404,0.59112,0.70928,0.41498,0.61498,0.71498 +0.38968,0.48614,0.56278,0.66854,0.51498,0.61498,0.71498 +0.3971,-0.34211,0.66444,0.66444,-0.38502,0.71498,0.71498 +0.36559,-0.26204,0.6824,0.6824,-0.28502,0.71498,0.71498 +0.34291,-0.17728,0.69591,0.69591,-0.18502,0.71498,0.71498 +0.32973,-0.089429,0.70427,0.70427,-0.085017,0.71498,0.71498 +0.32647,0.044909,0.70639,0.70639,0.014983,0.71498,0.71498 +0.33309,0.134,0.70073,0.70073,0.11498,0.71498,0.71498 +0.34929,0.22083,0.68965,0.68965,0.21498,0.71498,0.71498 +0.37464,0.30379,0.67369,0.67369,0.31498,0.71498,0.71498 +0.39568,-0.17827,-0.62736,0.75805,-0.18502,-0.68502,0.81498 +0.38317,-0.089822,-0.63479,0.76745,-0.085017,-0.68502,0.81498 +0.37997,0.0001101,-0.63729,0.77062,0.014983,-0.68502,0.81498 +0.38614,0.1348,-0.63127,0.76376,0.11498,-0.68502,0.81498 +0.38995,-0.34749,-0.56541,0.74804,-0.38502,-0.58502,0.81498 +0.35838,-0.26579,-0.57973,0.77024,-0.28502,-0.58502,0.81498 +0.33563,-0.17959,-0.5908,0.78657,-0.18502,-0.58502,0.81498 +0.32238,-0.090369,-0.59785,0.7965,-0.085017,-0.58502,0.81498 +0.31909,0.045785,-0.59965,0.79895,0.014983,-0.58502,0.81498 +0.32574,0.13651,-0.59523,0.79188,0.11498,-0.58502,0.81498 +0.34203,0.22486,-0.58632,0.77825,0.21498,-0.58502,0.81498 +0.3675,0.30938,-0.57365,0.75843,0.31498,-0.58502,0.81498 +0.38083,-0.47102,-0.47102,0.74585,-0.48502,-0.48502,0.81498 +0.33938,-0.39294,-0.48691,0.78008,-0.38502,-0.48502,0.81498 +0.30614,-0.31192,-0.49943,0.80826,-0.28502,-0.48502,0.81498 +0.282,-0.18296,-0.51297,0.83868,-0.18502,-0.48502,0.81498 +0.26791,-0.091953,-0.51915,0.84972,-0.085017,-0.48502,0.81498 +0.26451,0.04675,-0.52075,0.85243,0.014983,-0.48502,0.81498 +0.2716,0.13937,-0.5171,0.8445,0.11498,-0.48502,0.81498 +0.28881,0.22964,-0.50956,0.82923,0.21498,-0.48502,0.81498 +0.31562,0.31618,-0.49895,0.8069,0.31498,-0.48502,0.81498 +0.35133,0.39765,-0.48628,0.77808,0.41498,-0.48502,0.81498 +0.39503,0.4729,-0.4729,0.74346,0.51498,-0.48502,0.81498 +0.38995,-0.56541,-0.34749,0.74804,-0.58502,-0.38502,0.81498 +0.33938,-0.48691,-0.39294,0.78008,-0.48502,-0.38502,0.81498 +0.29616,-0.40584,-0.40584,0.81889,-0.38502,-0.38502,0.81498 +0.26142,-0.31947,-0.41853,0.85016,-0.28502,-0.38502,0.81498 +0.23606,-0.23133,-0.42704,0.87414,-0.18502,-0.38502,0.81498 +0.2211,-0.094016,-0.4345,0.89575,-0.085017,-0.38502,0.81498 +0.21757,0.047861,-0.43589,0.89873,0.014983,-0.38502,0.81498 +0.22506,0.14269,-0.43299,0.89003,0.11498,-0.38502,0.81498 +0.24311,0.23519,-0.4268,0.87323,0.21498,-0.38502,0.81498 +0.27118,0.32404,-0.41817,0.84861,0.31498,-0.38502,0.81498 +0.30846,0.40806,-0.40806,0.81668,0.41498,-0.38502,0.81498 +0.35398,0.48628,-0.39765,0.77808,0.51498,-0.38502,0.81498 +0.35838,-0.57973,-0.26579,0.77024,-0.58502,-0.28502,0.81498 +0.30614,-0.49943,-0.31192,0.80826,-0.48502,-0.28502,0.81498 +0.26142,-0.41853,-0.31947,0.85016,-0.38502,-0.28502,0.81498 +0.22534,-0.32978,-0.32978,0.88458,-0.28502,-0.28502,0.81498 +0.19897,-0.23698,-0.33869,0.91056,-0.18502,-0.28502,0.81498 +0.18325,-0.096259,-0.34442,0.93387,-0.085017,-0.28502,0.81498 +0.1796,0.048971,-0.34556,0.93712,0.014983,-0.28502,0.81498 +0.18743,0.14603,-0.34337,0.92778,0.11498,-0.28502,0.81498 +0.20621,0.24073,-0.33854,0.90964,0.21498,-0.28502,0.81498 +0.23535,0.33181,-0.33181,0.88306,0.31498,-0.28502,0.81498 +0.274,0.41817,-0.32404,0.8486,0.41498,-0.28502,0.81498 +0.32111,0.50343,-0.27147,0.82028,0.51498,-0.28502,0.81498 +0.37571,0.57968,-0.26611,0.77016,0.61498,-0.28502,0.81498 +0.39568,-0.62736,-0.17827,0.75805,-0.68502,-0.18502,0.81498 +0.33563,-0.5908,-0.17959,0.78657,-0.58502,-0.18502,0.81498 +0.282,-0.51297,-0.18296,0.83868,-0.48502,-0.18502,0.81498 +0.23606,-0.42704,-0.23133,0.87414,-0.38502,-0.18502,0.81498 +0.19897,-0.33869,-0.23698,0.91056,-0.28502,-0.18502,0.81498 +0.17178,-0.24399,-0.24399,0.93858,-0.18502,-0.18502,0.81498 +0.15549,-0.098382,-0.24966,0.96332,-0.085017,-0.18502,0.81498 +0.15174,0.049937,-0.25052,0.96682,0.014983,-0.18502,0.81498 +0.15982,0.14894,-0.24902,0.95698,0.11498,-0.18502,0.81498 +0.17916,0.24556,-0.24556,0.93776,0.21498,-0.18502,0.81498 +0.20914,0.33854,-0.24073,0.90964,0.31498,-0.18502,0.81498 +0.24886,0.42922,-0.1878,0.88346,0.41498,-0.18502,0.81498 +0.29733,0.51294,-0.18351,0.83858,0.51498,-0.18502,0.81498 +0.35334,0.59077,-0.18,0.7865,0.61498,-0.18502,0.81498 +0.38317,-0.63479,-0.089822,0.76745,-0.68502,-0.085017,0.81498 +0.32238,-0.59785,-0.090368,0.7965,-0.58502,-0.085017,0.81498 +0.26791,-0.51915,-0.091951,0.84973,-0.48502,-0.085017,0.81498 +0.2211,-0.43451,-0.094016,0.89575,-0.38502,-0.085017,0.81498 +0.18325,-0.34441,-0.096258,0.93387,-0.28502,-0.085017,0.81498 +0.15549,-0.24966,-0.098382,0.96332,-0.18502,-0.085017,0.81498 +0.1388,-0.10092,-0.10092,0.98976,-0.085017,-0.085017,0.81498 +0.13498,0.050694,-0.10137,0.99356,0.014983,-0.085017,0.81498 +0.14323,0.15131,-0.10062,0.98335,0.11498,-0.085017,0.81498 +0.16297,0.24965,-0.099107,0.96325,0.21498,-0.085017,0.81498 +0.19357,0.34441,-0.097095,0.93379,0.31498,-0.085017,0.81498 +0.23412,0.43449,-0.094865,0.89567,0.41498,-0.085017,0.81498 +0.28348,0.51912,-0.092706,0.84966,0.51498,-0.085017,0.81498 +0.34032,0.59783,-0.090914,0.79645,0.61498,-0.085017,0.81498 +0.37997,-0.63729,0.00010992,0.77062,-0.68502,0.014983,0.81498 +0.31909,-0.59965,0.045784,0.79895,-0.58502,0.014983,0.81498 +0.26451,-0.52075,0.04675,0.85243,-0.48502,0.014983,0.81498 +0.21757,-0.43589,0.047859,0.89873,-0.38502,0.014983,0.81498 +0.1796,-0.34555,0.048971,0.93712,-0.28502,0.014983,0.81498 +0.15174,-0.25052,0.049938,0.96682,-0.18502,0.014983,0.81498 +0.13498,-0.10137,0.050693,0.99356,-0.085017,0.014983,0.81498 +0.13115,0.05076,0.050759,0.99742,0.014983,0.014983,0.81498 +0.13943,0.15185,0.049983,0.98714,0.11498,0.014983,0.81498 +0.15924,0.25053,0.049032,0.96687,0.21498,0.014983,0.81498 +0.18995,0.34557,0.047929,0.93717,0.31498,0.014983,0.81498 +0.23063,0.43591,0.046814,0.89877,0.41498,0.014983,0.81498 +0.28011,0.52077,0.045835,0.85247,0.51498,0.014983,0.81498 +0.33706,0.60028,-0.00032542,0.79979,0.61498,0.014983,0.81498 +0.38614,-0.63127,0.1348,0.76376,-0.68502,0.11498,0.81498 +0.32574,-0.59523,0.1365,0.79188,-0.58502,0.11498,0.81498 +0.2716,-0.5171,0.13937,0.8445,-0.48502,0.11498,0.81498 +0.22506,-0.43299,0.1427,0.89003,-0.38502,0.11498,0.81498 +0.18743,-0.34337,0.14603,0.92778,-0.28502,0.11498,0.81498 +0.15982,-0.24902,0.14893,0.95698,-0.18502,0.11498,0.81498 +0.14323,-0.10062,0.15131,0.98335,-0.085017,0.11498,0.81498 +0.13943,0.049984,0.15185,0.98714,0.014983,0.11498,0.81498 +0.1476,0.15019,0.15019,0.97718,0.11498,0.11498,0.81498 +0.16723,0.24907,0.14659,0.95733,0.21498,0.11498,0.81498 +0.19766,0.34345,0.14333,0.92817,0.31498,0.11498,0.81498 +0.23799,0.4331,0.13997,0.89041,0.41498,0.11498,0.81498 +0.28707,0.51723,0.13696,0.84482,0.51498,0.11498,0.81498 +0.34357,0.59535,0.13477,0.79208,0.61498,0.11498,0.81498 +0.34203,-0.58632,0.22486,0.77825,-0.58502,0.21498,0.81498 +0.28881,-0.50956,0.22964,0.82922,-0.48502,0.21498,0.81498 +0.24311,-0.4268,0.23519,0.87323,-0.38502,0.21498,0.81498 +0.20621,-0.33854,0.24073,0.90964,-0.28502,0.21498,0.81498 +0.17916,-0.24556,0.24556,0.93776,-0.18502,0.21498,0.81498 +0.16297,-0.099107,0.24965,0.96325,-0.085017,0.21498,0.81498 +0.15924,0.049033,0.25053,0.96687,0.014983,0.21498,0.81498 +0.16723,0.14659,0.24907,0.95733,0.11498,0.21498,0.81498 +0.1864,0.24399,0.24399,0.93858,0.21498,0.21498,0.81498 +0.21622,0.33869,0.23698,0.91056,0.31498,0.21498,0.81498 +0.25579,0.42704,0.23133,0.87414,0.41498,0.21498,0.81498 +0.304,0.50985,0.22616,0.83,0.51498,0.21498,0.81498 +0.35957,0.5866,0.22231,0.77876,0.61498,0.21498,0.81498 +0.3675,-0.57365,0.30937,0.75843,-0.58502,0.31498,0.81498 +0.31562,-0.49895,0.31618,0.8069,-0.48502,0.31498,0.81498 +0.27118,-0.41817,0.32404,0.8486,-0.38502,0.31498,0.81498 +0.23535,-0.33181,0.33181,0.88306,-0.28502,0.31498,0.81498 +0.20914,-0.24073,0.33854,0.90964,-0.18502,0.31498,0.81498 +0.19357,-0.097097,0.34441,0.93379,-0.085017,0.31498,0.81498 +0.18995,0.047929,0.34557,0.93717,0.014983,0.31498,0.81498 +0.19766,0.14333,0.34345,0.92817,0.11498,0.31498,0.81498 +0.21622,0.23698,0.33869,0.91056,0.21498,0.31498,0.81498 +0.2451,0.32978,0.32978,0.88458,0.31498,0.31498,0.81498 +0.28353,0.41853,0.31947,0.85016,0.41498,0.31498,0.81498 +0.33045,0.49943,0.31192,0.80826,0.51498,0.31498,0.81498 +0.38464,0.57414,0.30617,0.75935,0.61498,0.31498,0.81498 +0.35133,-0.48628,0.39765,0.77808,-0.48502,0.41498,0.81498 +0.30846,-0.40806,0.40806,0.81668,-0.38502,0.41498,0.81498 +0.274,-0.32404,0.41817,0.8486,-0.28502,0.41498,0.81498 +0.24886,-0.1878,0.42922,0.88346,-0.18502,0.41498,0.81498 +0.23412,-0.094864,0.43449,0.89567,-0.085017,0.41498,0.81498 +0.23063,0.046816,0.43591,0.89877,0.014983,0.41498,0.81498 +0.23799,0.13997,0.4331,0.89041,0.11498,0.41498,0.81498 +0.25579,0.23133,0.42704,0.87414,0.21498,0.41498,0.81498 +0.28353,0.31947,0.41853,0.85016,0.31498,0.41498,0.81498 +0.32048,0.40584,0.40584,0.81889,0.41498,0.41498,0.81498 +0.36575,0.48691,0.39294,0.78008,0.51498,0.41498,0.81498 +0.39503,-0.4729,0.4729,0.74346,-0.48502,0.51498,0.81498 +0.35398,-0.39765,0.48628,0.77808,-0.38502,0.51498,0.81498 +0.32111,-0.27147,0.50343,0.82028,-0.28502,0.51498,0.81498 +0.29733,-0.18351,0.51294,0.83858,-0.18502,0.51498,0.81498 +0.28348,-0.092706,0.51912,0.84966,-0.085017,0.51498,0.81498 +0.28011,0.045834,0.52077,0.85247,0.014983,0.51498,0.81498 +0.28707,0.13696,0.51723,0.84482,0.11498,0.51498,0.81498 +0.304,0.22616,0.50985,0.83,0.21498,0.51498,0.81498 +0.33045,0.31192,0.49943,0.80826,0.31498,0.51498,0.81498 +0.36575,0.39294,0.48691,0.78008,0.41498,0.51498,0.81498 +0.37571,-0.26611,0.57968,0.77016,-0.28502,0.61498,0.81498 +0.35334,-0.18,0.59077,0.7865,-0.18502,0.61498,0.81498 +0.34032,-0.090914,0.59783,0.79645,-0.085017,0.61498,0.81498 +0.33706,-0.00032579,0.60028,0.79979,0.014983,0.61498,0.81498 +0.34357,0.13477,0.59535,0.79208,0.11498,0.61498,0.81498 +0.35957,0.22231,0.5866,0.77876,0.21498,0.61498,0.81498 +0.38464,0.30617,0.57414,0.75935,0.31498,0.61498,0.81498 +0.38938,-0.27427,-0.46261,0.84307,-0.28502,-0.48502,0.91498 +0.36724,-0.18508,-0.4714,0.86228,-0.18502,-0.48502,0.91498 +0.35436,-0.093099,-0.47715,0.87387,-0.085017,-0.48502,0.91498 +0.35106,0.00024081,-0.47918,0.87772,0.014983,-0.48502,0.91498 +0.35738,0.13984,-0.47444,0.86911,0.11498,-0.48502,0.91498 +0.37312,0.23077,-0.46705,0.85358,0.21498,-0.48502,0.91498 +0.39786,0.27446,-0.46249,0.84307,0.31498,-0.48502,0.91498 +0.37989,-0.36881,-0.36881,0.8532,-0.38502,-0.38502,0.91498 +0.34787,-0.28117,-0.37762,0.88224,-0.28502,-0.38502,0.91498 +0.32485,-0.1896,-0.38482,0.90331,-0.18502,-0.38502,0.91498 +0.31145,-0.095335,-0.38965,0.91602,-0.085017,-0.38502,0.91498 +0.30806,0.047954,-0.39072,0.91926,0.014983,-0.38502,0.91498 +0.31471,0.14319,-0.38742,0.91072,0.11498,-0.38502,0.91498 +0.33115,0.23639,-0.38138,0.89368,0.21498,-0.38502,0.91498 +0.35691,0.32623,-0.37335,0.86844,0.31498,-0.38502,0.91498 +0.3913,0.41153,-0.36423,0.83545,0.41498,-0.38502,0.91498 +0.38938,-0.46261,-0.27427,0.84307,-0.48502,-0.28502,0.91498 +0.34787,-0.37762,-0.28117,0.88224,-0.38502,-0.28502,0.91498 +0.31484,-0.28778,-0.28778,0.91344,-0.28502,-0.28502,0.91498 +0.29106,-0.19403,-0.29332,0.93612,-0.18502,-0.28502,0.91498 +0.27721,-0.097571,-0.29711,0.94985,-0.085017,-0.28502,0.91498 +0.27374,0.049063,-0.29798,0.95331,0.014983,-0.28502,0.91498 +0.28066,0.1465,-0.29544,0.94406,0.11498,-0.28502,0.91498 +0.29768,0.24185,-0.29081,0.92571,0.21498,-0.28502,0.91498 +0.3243,0.33382,-0.28476,0.8986,0.31498,-0.28502,0.91498 +0.35977,0.42129,-0.27802,0.86326,0.41498,-0.28502,0.91498 +0.36724,-0.4714,-0.18508,0.86228,-0.48502,-0.18502,0.91498 +0.32485,-0.38482,-0.1896,0.90331,-0.38502,-0.18502,0.91498 +0.29106,-0.29332,-0.19403,0.93612,-0.28502,-0.18502,0.91498 +0.26668,-0.19782,-0.19782,0.96007,-0.18502,-0.18502,0.91498 +0.25248,-0.099522,-0.20046,0.97463,-0.085017,-0.18502,0.91498 +0.24894,0.050023,-0.20113,0.97829,0.014983,-0.18502,0.91498 +0.25606,0.14933,-0.19944,0.96846,0.11498,-0.18502,0.91498 +0.27353,0.24647,-0.19632,0.94906,0.21498,-0.18502,0.91498 +0.30081,0.34013,-0.19227,0.92051,0.31498,-0.18502,0.91498 +0.33709,0.42922,-0.1878,0.88346,0.41498,-0.18502,0.91498 +0.38139,0.4713,-0.18535,0.86228,0.51498,-0.18502,0.91498 +0.35436,-0.47715,-0.093098,0.87387,-0.48502,-0.085017,0.91498 +0.31145,-0.38965,-0.095335,0.91602,-0.38502,-0.085017,0.91498 +0.27721,-0.29711,-0.097571,0.94985,-0.28502,-0.085017,0.91498 +0.25248,-0.20046,-0.099522,0.97463,-0.18502,-0.085017,0.91498 +0.23806,-0.10092,-0.10092,0.98976,-0.085017,-0.085017,0.91498 +0.23448,0.050694,-0.10137,0.99356,0.014983,-0.085017,0.91498 +0.24171,0.15131,-0.10062,0.98335,0.11498,-0.085017,0.91498 +0.25945,0.24965,-0.099107,0.96325,0.21498,-0.085017,0.91498 +0.28712,0.34441,-0.097095,0.93379,0.31498,-0.085017,0.91498 +0.32388,0.43449,-0.094865,0.89567,0.41498,-0.085017,0.91498 +0.36868,0.47709,-0.093492,0.87387,0.51498,-0.085017,0.91498 +0.35106,-0.47918,0.00024088,0.87772,-0.48502,0.014983,0.91498 +0.30806,-0.39072,0.047952,0.91926,-0.38502,0.014983,0.91498 +0.27374,-0.29798,0.049063,0.95331,-0.28502,0.014983,0.91498 +0.24894,-0.20113,0.050024,0.97829,-0.18502,0.014983,0.91498 +0.23448,-0.10137,0.050693,0.99356,-0.085017,0.014983,0.91498 +0.23089,0.05076,0.050759,0.99742,0.014983,0.014983,0.91498 +0.23814,0.15185,0.049983,0.98714,0.11498,0.014983,0.91498 +0.25593,0.25053,0.049032,0.96687,0.21498,0.014983,0.91498 +0.28367,0.34557,0.047929,0.93717,0.31498,0.014983,0.91498 +0.32051,0.43639,-0.00052325,0.89976,0.41498,0.014983,0.91498 +0.36539,0.47918,-0.00024116,0.87772,0.51498,0.014983,0.91498 +0.35738,-0.47444,0.13984,0.86911,-0.48502,0.11498,0.91498 +0.31471,-0.38742,0.14319,0.91072,-0.38502,0.11498,0.91498 +0.28066,-0.29544,0.14649,0.94406,-0.28502,0.11498,0.91498 +0.25606,-0.19944,0.14933,0.96846,-0.18502,0.11498,0.91498 +0.24171,-0.10062,0.15131,0.98335,-0.085017,0.11498,0.91498 +0.23814,0.049984,0.15185,0.98714,0.014983,0.11498,0.91498 +0.24532,0.15019,0.15019,0.97718,0.11498,0.11498,0.91498 +0.26296,0.24907,0.14659,0.95733,0.21498,0.11498,0.91498 +0.29048,0.34345,0.14333,0.92817,0.31498,0.11498,0.91498 +0.32703,0.4331,0.13997,0.89041,0.41498,0.11498,0.91498 +0.37159,0.47715,0.093098,0.87387,0.51498,0.11498,0.91498 +0.37312,-0.46705,0.23078,0.85358,-0.48502,0.21498,0.91498 +0.33115,-0.38138,0.23639,0.89368,-0.38502,0.21498,0.91498 +0.29768,-0.29081,0.24185,0.92571,-0.28502,0.21498,0.91498 +0.27353,-0.19632,0.24647,0.94906,-0.18502,0.21498,0.91498 +0.25945,-0.099107,0.24965,0.96325,-0.085017,0.21498,0.91498 +0.25593,0.049033,0.25053,0.96687,0.014983,0.21498,0.91498 +0.26296,0.14659,0.24907,0.95733,0.11498,0.21498,0.91498 +0.28026,0.24399,0.24399,0.93858,0.21498,0.21498,0.91498 +0.30728,0.33869,0.23698,0.91056,0.31498,0.21498,0.91498 +0.34321,0.42516,0.23332,0.87453,0.41498,0.21498,0.91498 +0.38706,0.4714,0.18508,0.86228,0.51498,0.21498,0.91498 +0.39786,-0.46249,0.27446,0.84307,-0.48502,0.31498,0.91498 +0.35691,-0.37335,0.32623,0.86844,-0.38502,0.31498,0.91498 +0.3243,-0.28476,0.33382,0.8986,-0.28502,0.31498,0.91498 +0.30081,-0.19226,0.34013,0.92051,-0.18502,0.31498,0.91498 +0.28712,-0.097097,0.34441,0.93379,-0.085017,0.31498,0.91498 +0.28367,0.047929,0.34557,0.93717,0.014983,0.31498,0.91498 +0.29048,0.14333,0.34345,0.92817,0.11498,0.31498,0.91498 +0.30728,0.23698,0.33869,0.91056,0.21498,0.31498,0.91498 +0.33356,0.32978,0.32978,0.88458,0.31498,0.31498,0.91498 +0.36855,0.41618,0.32188,0.8504,0.41498,0.31498,0.91498 +0.3913,-0.36423,0.41153,0.83545,-0.38502,0.41498,0.91498 +0.35977,-0.27802,0.42129,0.86326,-0.28502,0.41498,0.91498 +0.33709,-0.1878,0.42922,0.88346,-0.18502,0.41498,0.91498 +0.32388,-0.094864,0.43449,0.89567,-0.085017,0.41498,0.91498 +0.32051,-0.00052314,0.43639,0.89976,0.014983,0.41498,0.91498 +0.32703,0.13997,0.4331,0.89041,0.11498,0.41498,0.91498 +0.34321,0.23332,0.42516,0.87453,0.21498,0.41498,0.91498 +0.36855,0.32188,0.41618,0.8504,0.31498,0.41498,0.91498 +0.38139,-0.18535,0.4713,0.86228,-0.18502,0.51498,0.91498 +0.36868,-0.093492,0.47709,0.87387,-0.085017,0.51498,0.91498 +0.36539,-0.00024029,0.47918,0.87772,0.014983,0.51498,0.91498 +0.37159,0.093098,0.47715,0.87387,0.11498,0.51498,0.91498 +0.38706,0.18508,0.4714,0.86228,0.21498,0.51498,0.91498 +0.38642,-0.14896,-0.24675,0.95756,-0.18502,-0.28502,1.015 +0.37361,-0.049939,-0.24966,0.96705,-0.085017,-0.28502,1.015 +0.37018,0.00045243,-0.25083,0.96803,0.014983,-0.28502,1.015 +0.37621,0.099108,-0.24965,0.96325,0.11498,-0.28502,1.015 +0.39157,0.19632,-0.24647,0.94906,0.21498,-0.28502,1.015 +0.38642,-0.24675,-0.14896,0.95756,-0.28502,-0.18502,1.015 +0.36408,-0.15018,-0.15019,0.97718,-0.18502,-0.18502,1.015 +0.35099,-0.050617,-0.15122,0.9872,-0.085017,-0.18502,1.015 +0.3475,0.00031734,-0.15204,0.98837,0.014983,-0.18502,1.015 +0.35367,0.10062,-0.15131,0.98335,0.11498,-0.18502,1.015 +0.36935,0.19944,-0.14933,0.96846,0.21498,-0.18502,1.015 +0.39418,0.29544,-0.14649,0.94406,0.31498,-0.18502,1.015 +0.37361,-0.24966,-0.04994,0.96705,-0.28502,-0.085017,1.015 +0.35099,-0.15122,-0.050618,0.9872,-0.18502,-0.085017,1.015 +0.33775,-0.05076,-0.050759,0.99742,-0.085017,-0.085017,1.015 +0.3342,0.00011815,-0.050943,0.9987,0.014983,-0.085017,1.015 +0.34046,0.10137,-0.050693,0.99356,0.11498,-0.085017,1.015 +0.35632,0.20113,-0.050023,0.97829,0.21498,-0.085017,1.015 +0.38144,0.29798,-0.049063,0.95331,0.31498,-0.085017,1.015 +0.37018,-0.25083,0.00045319,0.96803,-0.28502,0.014983,1.015 +0.3475,-0.15204,0.00031761,0.98837,-0.18502,0.014983,1.015 +0.3342,-0.050943,0.00011897,0.9987,-0.085017,0.014983,1.015 +0.33065,1.2663e-07,-1.1885e-09,1,0.014983,0.014983,1.015 +0.33691,0.10151,-0.00010855,0.99483,0.11498,0.014983,1.015 +0.35283,0.20149,-0.00019099,0.97949,0.21498,0.014983,1.015 +0.37802,0.29852,-0.00024113,0.9544,0.31498,0.014983,1.015 +0.37621,-0.24965,0.099107,0.96325,-0.28502,0.11498,1.015 +0.35367,-0.15131,0.10062,0.98335,-0.18502,0.11498,1.015 +0.34046,-0.050695,0.10137,0.99356,-0.085017,0.11498,1.015 +0.33691,-0.0001083,0.10151,0.99483,0.014983,0.11498,1.015 +0.34315,0.10092,0.10092,0.98976,0.11498,0.11498,1.015 +0.35897,0.20046,0.099522,0.97463,0.21498,0.11498,1.015 +0.38402,0.29711,0.097571,0.94985,0.31498,0.11498,1.015 +0.39157,-0.24647,0.19632,0.94906,-0.28502,0.21498,1.015 +0.36935,-0.14933,0.19944,0.96846,-0.18502,0.21498,1.015 +0.35632,-0.050025,0.20113,0.97829,-0.085017,0.21498,1.015 +0.35283,-0.00019178,0.20149,0.97949,0.014983,0.21498,1.015 +0.35897,0.099522,0.20046,0.97463,0.11498,0.21498,1.015 +0.37457,0.19782,0.19782,0.96007,0.21498,0.21498,1.015 +0.39927,0.29332,0.19403,0.93612,0.31498,0.21498,1.015 +0.39418,-0.14649,0.29544,0.94406,-0.18502,0.31498,1.015 +0.38144,-0.049061,0.29798,0.95331,-0.085017,0.31498,1.015 +0.37802,-0.00024043,0.29852,0.9544,0.014983,0.31498,1.015 +0.38402,0.097571,0.29711,0.94985,0.11498,0.31498,1.015 +0.39927,0.19403,0.29332,0.93612,0.21498,0.31498,1.015 diff --git a/test/preprocessing/packing/nhs_faces.jl b/test/preprocessing/packing/nhs_faces.jl new file mode 100644 index 000000000..d3896745e --- /dev/null +++ b/test/preprocessing/packing/nhs_faces.jl @@ -0,0 +1,104 @@ +@testset verbose=true "FaceNeighborhoodSearch" begin + @testset verbose=true "2D Cell Bounding Box" begin + triangle = [0.0 1.0 0.5 0.0; + 0.0 0.0 0.7 0.0] + + # Only use the third edge of the triangle, i.e. the edge from [0.1, 0.0] to [0.0, 0.0] + edge_aligned = deleteat!(TrixiParticles.Polygon(triangle), [1, 2]) + edge_id = 1 # Only one edge in `Polygon` + + cell_sizes = [1.0 + sqrt(eps()), 0.1] + + expected_ncells_bbox = [(1, 1), (11, 1)] + # One padding layer in each direction around the bounding box + expected_ncells_filled = map(x -> prod(x .+ 2), expected_ncells_bbox) + + @testset verbose=true "Axis Aligned Edge: cell size $(cell_size)" for (i, cell_size) in enumerate(cell_sizes) + nhs = TrixiParticles.FaceNeighborhoodSearch{2}(; search_radius=cell_size) + + TrixiParticles.initialize!(nhs, edge_aligned) + + @test expected_ncells_bbox[i] == + size(collect(TrixiParticles.bounding_box(edge_id, edge_aligned, nhs))) + + @test expected_ncells_filled[i] == length(nhs.neighbors.hashtable) + end + + # Only use the first edge of the triangle, i.e. the edge from [0.0, 0.0] to [0.5, 0.7] + edge_arbitrary = deleteat!(TrixiParticles.Polygon(triangle), [2, 3]) + edge_id = 1 # Only one edge in `Polygon` + + expected_ncells_bbox = [(1, 1), (6, 7)] + # One padding layer in each direction around the bounding box + expected_ncells_filled = map(x -> prod(x .+ 2), expected_ncells_bbox) + + @testset verbose=true "Arbitrary Edge: cell size $(cell_size)" for (i, cell_size) in enumerate(cell_sizes) + nhs = TrixiParticles.FaceNeighborhoodSearch{2}(; search_radius=cell_size) + + TrixiParticles.initialize!(nhs, edge_arbitrary) + + @test expected_ncells_bbox[i] == + size(collect(TrixiParticles.bounding_box(edge_id, edge_arbitrary, nhs))) + + @test expected_ncells_filled[i] == length(nhs.neighbors.hashtable) + end + end + + # Tested with Paraview and `save("triangle.stl", triangle)`, `trixi2vtk(stack([min_corner, max_corner]))` + @testset verbose=true "3D Cell Bounding Box" begin + # Axis aligned triangle + A = SVector(0.0, 1.0, 0.0) + B = zero(A) + C = SVector(1.0, 1.0, 0.0) + + triangle_aligned = TrixiParticles.TriangleMesh([(A, B, C)], + [TrixiParticles.cross(B - A, C - A)], + [A, B, C]) + face_id = 1 # Only one face in `TriangleMesh` + + cell_sizes = [1.0 + sqrt(eps()), 0.1] + + expected_ncells_bbox = [(1, 1, 1), (11, 11, 1)] + # One padding layer in each direction around the bounding box + expected_ncells_filled = map(x -> prod(x .+ 2), expected_ncells_bbox) + + @testset verbose=true "Axis Aligned Triangle: cell size $(cell_size)" for (i, cell_size) in enumerate(cell_sizes) + nhs = TrixiParticles.FaceNeighborhoodSearch{3}(; search_radius=cell_size) + + TrixiParticles.initialize!(nhs, triangle_aligned) + + @test expected_ncells_bbox[i] == + size(collect(TrixiParticles.bounding_box(face_id, triangle_aligned, nhs))) + + @test expected_ncells_filled[i] == length(nhs.neighbors.hashtable) + end + + # Arbitrary triangle + A = SVector(0.42, -0.16, 0.81) + B = SVector(-0.58, 0.74, -0.02) + C = SVector(0.87, 1.02, 0.37) + + triangle_arbitrary = TrixiParticles.TriangleMesh([(A, B, C)], + [TrixiParticles.cross(B - A, + C - A)], + [A, B, C]) + face_id = 1 # Only one face in `TriangleMesh` + cell_sizes = [1.0 + sqrt(eps()), 0.1] + + expected_ncells_bbox = [(2, 3, 2), (15, 13, 10)] + # One padding layer in each direction around the bounding box + expected_ncells_filled = map(x -> prod(x .+ 2), expected_ncells_bbox) + + @testset verbose=true "Arbitrary Triangle: cell size $(cell_size)" for (i, cell_size) in enumerate(cell_sizes) + nhs = TrixiParticles.FaceNeighborhoodSearch{3}(; search_radius=cell_size) + + TrixiParticles.initialize!(nhs, triangle_arbitrary) + + @test expected_ncells_bbox[i] == + size(collect(TrixiParticles.bounding_box(face_id, triangle_arbitrary, + nhs))) + + @test expected_ncells_filled[i] == length(nhs.neighbors.hashtable) + end + end +end diff --git a/test/preprocessing/packing/packing.jl b/test/preprocessing/packing/packing.jl new file mode 100644 index 000000000..d8412cd52 --- /dev/null +++ b/test/preprocessing/packing/packing.jl @@ -0,0 +1,2 @@ +include("signed_distance.jl") +include("nhs_faces.jl") diff --git a/test/preprocessing/packing/signed_distance.jl b/test/preprocessing/packing/signed_distance.jl new file mode 100644 index 000000000..c6efcc08c --- /dev/null +++ b/test/preprocessing/packing/signed_distance.jl @@ -0,0 +1,138 @@ + +@testset verbose=true "Signed Distance Field" begin + @testset verbose=true "`show`" begin + data_dir = pkgdir(TrixiParticles, "examples", "preprocessing", "data") + + geometry = load_geometry(joinpath(data_dir, "hexagon.asc")) + + signed_distance_field = SignedDistanceField(geometry, 0.1) + + show_compact = "SignedDistanceField{2}()" + @test repr(signed_distance_field) == show_compact + + show_box = """ + ┌──────────────────────────────────────────────────────────────────────────────────────────────────┐ + │ SignedDistanceField{2} │ + │ ══════════════════════ │ + │ #particles: ………………………………………………… 474 │ + │ max signed distance: ………………………… 0.4 │ + └──────────────────────────────────────────────────────────────────────────────────────────────────┘""" + + @test repr("text/plain", signed_distance_field) == show_box + + signed_distance_field = SignedDistanceField(geometry, 0.1; max_signed_distance=0.89) + show_box = """ + ┌──────────────────────────────────────────────────────────────────────────────────────────────────┐ + │ SignedDistanceField{2} │ + │ ══════════════════════ │ + │ #particles: ………………………………………………… 1037 │ + │ max signed distance: ………………………… 0.89 │ + └──────────────────────────────────────────────────────────────────────────────────────────────────┘""" + + @test repr("text/plain", signed_distance_field) == show_box + + signed_distance_field = SignedDistanceField(geometry, 0.1; max_signed_distance=0.45, + use_for_boundary_packing=true) + show_box = """ + ┌──────────────────────────────────────────────────────────────────────────────────────────────────┐ + │ SignedDistanceField{2} │ + │ ══════════════════════ │ + │ #particles: ………………………………………………… 998 │ + │ max signed distance: ………………………… 0.45 │ + └──────────────────────────────────────────────────────────────────────────────────────────────────┘""" + + @test repr("text/plain", signed_distance_field) == show_box + end + + @testset verbose=true "Real World Data" begin + data_dir = pkgdir(TrixiParticles, "examples", "preprocessing", "data") + validation_dir = pkgdir(TrixiParticles, "test", "preprocessing", "data") + + files = ["hexagon.asc", "circle.asc", "sphere.stl"] + + @testset verbose=true "$(files[i])" for i in eachindex(files) + geometry = load_geometry(joinpath(data_dir, files[i])) + + signed_distance_field = SignedDistanceField(geometry, 0.1) + + nhs = TrixiParticles.FaceNeighborhoodSearch{ndims(geometry)}(search_radius=0.1) + + TrixiParticles.initialize!(nhs, geometry) + + positions_test = [ + [SVector(ntuple(dim -> 0.0, ndims(geometry)))], + [SVector(ntuple(dim -> 5.0, ndims(geometry)))], + [first(geometry.vertices)] + ] + + positions_expected = [ + empty(first(positions_test)), + empty(first(positions_test)), + [first(geometry.vertices)] + ] + + normals_expected = [ + empty(first(positions_test)), + empty(first(positions_test)), + [first(geometry.vertex_normals) isa Tuple ? + first(geometry.vertex_normals[1]) : + first(geometry.vertex_normals)] + ] + + distances_expected = [ + empty(first(positions_test)), + empty(first(positions_test)), + [zero(eltype(geometry))] + ] + + @testset verbose=true "Positions $j" for j in eachindex(positions_test) + positions = positions_test[j] + normals = fill(SVector(ntuple(dim -> Inf, ndims(geometry))), + length(positions)) + distances = fill(Inf, length(positions)) + + TrixiParticles.calculate_signed_distances!(positions, distances, normals, + geometry, 1, 0.4, nhs) + + @test positions_expected[j] == positions + @test normals_expected[j] == normals + @test distances_expected[j] == distances + end + + @testset verbose=true "Pointcloud" begin + # Checked in ParaView with `trixi2vtk(signed_distance_field)` + data = TrixiParticles.CSV.read(joinpath(validation_dir, + "signed_distances_" * + files[i][1:(end - 4)] * + ".csv"), + TrixiParticles.DataFrame) + + if ndims(geometry) == 3 + vertex_normals = reinterpret(reshape, SVector{3, Float64}, + vcat((data.var"normals:0")', + (data.var"normals:1")', + (data.var"normals:2")')) + + points = reinterpret(reshape, SVector{3, Float64}, + vcat((data.var"Points:0")', + (data.var"Points:1")', + (data.var"Points:2")')) + else + vertex_normals = reinterpret(reshape, SVector{2, Float64}, + vcat((data.var"normals:0")', + (data.var"normals:1")')) + + points = reinterpret(reshape, SVector{2, Float64}, + vcat((data.var"Points:0")', + (data.var"Points:1")')) + end + + distances = data.signed_distances + + @test isapprox(signed_distance_field.positions, points; rtol=1e-4) + @test isapprox(signed_distance_field.normals, vertex_normals; rtol=1e-4) + @test isapprox(signed_distance_field.distances, distances; rtol=1e-4) + end + end + end +end diff --git a/test/preprocessing/preprocessing.jl b/test/preprocessing/preprocessing.jl index 50b96d883..a5f090f28 100644 --- a/test/preprocessing/preprocessing.jl +++ b/test/preprocessing/preprocessing.jl @@ -1,2 +1,3 @@ include("geometries/geometries.jl") +include("packing/packing.jl") include("point_in_poly/winding_number_jacobson.jl")